diff --git a/Intern/rayx-core/src/Beamline/Objects/CircleSource.cpp b/Intern/rayx-core/src/Beamline/Objects/CircleSource.cpp index 8f6c53bc..9431ab8b 100644 --- a/Intern/rayx-core/src/Beamline/Objects/CircleSource.cpp +++ b/Intern/rayx-core/src/Beamline/Objects/CircleSource.cpp @@ -57,8 +57,7 @@ std::vector CircleSource::getRays([[maybe_unused]] int thread_count) const // main ray (main ray: xDir=0,yDir=0,zDir=1 for phi=psi=0) glm::dvec3 direction = getDirection(); - const auto rotation = glm::dmat3(m_orientation); - const auto field = rotation * stokesToElectricField(m_stokes); + const auto field = stokesToElectricField(m_stokes, direction); Ray r = {position, ETYPE_UNINIT, direction, en, field, 0.0, 0.0, -1.0, -1.0}; diff --git a/Intern/rayx-core/src/Beamline/Objects/DipoleSource.cpp b/Intern/rayx-core/src/Beamline/Objects/DipoleSource.cpp index c51caec2..3265c8a7 100644 --- a/Intern/rayx-core/src/Beamline/Objects/DipoleSource.cpp +++ b/Intern/rayx-core/src/Beamline/Objects/DipoleSource.cpp @@ -131,8 +131,7 @@ std::vector DipoleSource::getRays(int thread_count) const { glm::dvec4 tempDir = m_orientation * glm::dvec4(direction, 0.0); direction = glm::dvec3(tempDir.x, tempDir.y, tempDir.z); - const auto rotation = glm::dmat3(m_orientation); - const auto field = rotation * stokesToElectricField(psiandstokes.stokes); + const auto field = stokesToElectricField(psiandstokes.stokes, direction); Ray r = {position, ETYPE_UNINIT, direction, en, field, 0.0, 0.0, -1.0, -1.0}; #if defined(DIPOLE_OMP) diff --git a/Intern/rayx-core/src/Beamline/Objects/MatrixSource.cpp b/Intern/rayx-core/src/Beamline/Objects/MatrixSource.cpp index 968a476e..226575b2 100644 --- a/Intern/rayx-core/src/Beamline/Objects/MatrixSource.cpp +++ b/Intern/rayx-core/src/Beamline/Objects/MatrixSource.cpp @@ -59,8 +59,7 @@ std::vector MatrixSource::getRays([[maybe_unused]] int thread_count) const glm::dvec4 tempDir = m_orientation * glm::dvec4(direction, 0.0); direction = glm::dvec3(tempDir.x, tempDir.y, tempDir.z); - const auto rotation = glm::dmat3(m_orientation); - const auto field = rotation * stokesToElectricField(m_pol); + const auto field = stokesToElectricField(m_pol, direction); Ray r = {position, ETYPE_UNINIT, direction, en, field, 0.0, 0.0, -1.0, -1.0}; diff --git a/Intern/rayx-core/src/Beamline/Objects/PixelSource.cpp b/Intern/rayx-core/src/Beamline/Objects/PixelSource.cpp index 8ab3063c..cbf394bd 100644 --- a/Intern/rayx-core/src/Beamline/Objects/PixelSource.cpp +++ b/Intern/rayx-core/src/Beamline/Objects/PixelSource.cpp @@ -74,7 +74,7 @@ std::vector PixelSource::getRays([[maybe_unused]] int thread_count) const { direction = glm::dvec3(tempDir.x, tempDir.y, tempDir.z); const auto rotation = glm::dmat3(m_orientation); - const auto field = rotation * stokesToElectricField(m_pol); + const auto field = stokesToElectricField(m_pol, rotation); Ray r = {position, ETYPE_UNINIT, direction, en, field, 0.0, 0.0, -1.0, -1.0}; diff --git a/Intern/rayx-core/src/Beamline/Objects/PointSource.cpp b/Intern/rayx-core/src/Beamline/Objects/PointSource.cpp index 2efe2af8..1a1569a8 100644 --- a/Intern/rayx-core/src/Beamline/Objects/PointSource.cpp +++ b/Intern/rayx-core/src/Beamline/Objects/PointSource.cpp @@ -92,8 +92,7 @@ std::vector PointSource::getRays(int thread_count) const { glm::dvec4 tempDir = m_orientation * glm::dvec4(direction, 0.0); direction = glm::dvec3(tempDir.x, tempDir.y, tempDir.z); - // const auto rotation = rotationMatrix(direction); - const auto field = /* rotation * */ stokesToElectricField(m_pol); + const auto field = stokesToElectricField(m_pol, direction); Ray r = {position, ETYPE_UNINIT, direction, en, field, 0.0, 0.0, -1.0, -1.0}; #if defined(DIPOLE_OMP) diff --git a/Intern/rayx-core/src/Beamline/Objects/SimpleUndulatorSource.cpp b/Intern/rayx-core/src/Beamline/Objects/SimpleUndulatorSource.cpp index 3a0d61d1..34a6db23 100644 --- a/Intern/rayx-core/src/Beamline/Objects/SimpleUndulatorSource.cpp +++ b/Intern/rayx-core/src/Beamline/Objects/SimpleUndulatorSource.cpp @@ -72,8 +72,7 @@ std::vector SimpleUndulatorSource::getRays([[maybe_unused]] int thread_coun glm::dvec4 tempDir = m_orientation * glm::dvec4(direction, 0.0); direction = glm::dvec3(tempDir.x, tempDir.y, tempDir.z); - const auto rotation = glm::dmat3(m_orientation); - const auto field = rotation * stokesToElectricField(m_pol); + const auto field = stokesToElectricField(m_pol, direction); Ray r = {position, ETYPE_UNINIT, direction, en, field, 0.0, 0.0, -1.0, -1.0}; diff --git a/Intern/rayx-core/src/Shader/Efficiency.h b/Intern/rayx-core/src/Shader/Efficiency.h index a78b823f..bd52f247 100644 --- a/Intern/rayx-core/src/Shader/Efficiency.h +++ b/Intern/rayx-core/src/Shader/Efficiency.h @@ -1,3 +1,9 @@ +/* + * This code implements several formulas from the following book: + * Russel A. Chipman, Wai-Sze Tiffany Lam, Garam Young "Polarized Light and Optical Systems" (2019). + * For specific references, see the inline comments in the respective functions. + */ + #pragma once #include @@ -8,34 +14,43 @@ namespace RAYX { -using Stokes = glm::dvec4; -using ElectricField = cvec3; -using LocalElectricField = cvec2; +using Stokes = glm::dvec4; // Stokes vector represents the polarization state of light in the ray local plane +using LocalElectricField = cvec2; // Electric field in the ray local plane, as a complex 2D vector +using ElectricField = cvec3; // Electric field as a complex 3D vector struct FresnelCoeffs { - double s; - double p; + double s; // Real component of Fresnel reflection/refraction coefficient for s-polarized light + double p; // Real component of Fresnel reflection/refraction coefficient for p-polarized light }; struct ComplexFresnelCoeffs { - complex::Complex s; - complex::Complex p; + complex::Complex s; // Complex Fresnel coefficient for s-polarized light + complex::Complex p; // Complex Fresnel coefficient for p-polarized light }; +// Computes the angle between two unit vectors in 3D space RAYX_FN_ACC inline double angleBetweenUnitVectors(glm::dvec3 a, glm::dvec3 b) { return glm::acos(glm::dot(a, b)); } +// Calculates the refracted angle using Snell's Law, based on complex index of refraction +// Source: "Polarized Light and Optical Systems", p. 297, Formula 8.3 RAYX_FN_ACC inline complex::Complex calcRefractAngle(const complex::Complex incidentAngle, const complex::Complex iorI, const complex::Complex iorT) { return complex::asin((iorI / iorT) * complex::sin(incidentAngle)); } +// Calculates Brewster's angle, the angle at which no reflection occurs for p-polarized light +// Source: "Polarized Light and Optical Systems", p. 305, Formula 8.26 RAYX_FN_ACC inline complex::Complex calcBrewstersAngle(const complex::Complex iorI, const complex::Complex iorT) { return complex::atan(iorT / iorI); } +// Calculates the critical angle for total internal reflection +// Source: "Polarized Light and Optical Systems", p. 306, Formula 8.27 RAYX_FN_ACC inline complex::Complex calcCriticalAngle(const complex::Complex iorI, const complex::Complex iorT) { return complex::asin(iorT / iorI); } +// Computes the Fresnel reflection amplitude for s and p polarization states +// Source: "Polarized Light and Optical Systems", p. 300, Formula 8.8 and 8.10 RAYX_FN_ACC inline ComplexFresnelCoeffs calcReflectAmplitude(const complex::Complex incidentAngle, const complex::Complex refractAngle, const complex::Complex iorI, const complex::Complex iorT) { @@ -45,12 +60,11 @@ inline ComplexFresnelCoeffs calcReflectAmplitude(const complex::Complex incident const auto s = (iorI * cos_i - iorT * cos_t) / (iorI * cos_i + iorT * cos_t); const auto p = (iorT * cos_i - iorI * cos_t) / (iorT * cos_i + iorI * cos_t); - return { - .s = s, - .p = p, - }; + return {.s = s, .p = p}; } +// Computes the Fresnel transmission (refracted) amplitude for s and p polarization states +// Source: "Polarized Light and Optical Systems", p. 300, Formula 8.9 and 8.11 RAYX_FN_ACC inline ComplexFresnelCoeffs calcRefractAmplitude(const complex::Complex incidentAngle, const complex::Complex refractAngle, const complex::Complex iorI, const complex::Complex iorT) { @@ -60,44 +74,39 @@ inline ComplexFresnelCoeffs calcRefractAmplitude(const complex::Complex incident const auto s = (2.0 * iorI * cos_i) / (iorI * cos_i + iorT * cos_t); const auto p = (2.0 * iorI * cos_i) / (iorT * cos_i + iorI * cos_t); - return { - .s = s, - .p = p, - }; + return {.s = s, .p = p}; } +// Computes the reflectance (intensity) based on the Fresnel reflection amplitudes +// Source: "Polarized Light and Optical Systems", p. 301, Formula 8.16 and 8.17 RAYX_FN_ACC inline FresnelCoeffs calcReflectIntensity(const ComplexFresnelCoeffs reflectAmplitude) { - const auto s = (reflectAmplitude.s * complex::conj(reflectAmplitude.s)).real(); - const auto p = (reflectAmplitude.p * complex::conj(reflectAmplitude.p)).real(); + const auto s = (reflectAmplitude.s * complex::conj(reflectAmplitude.s)).real(); // s-polarized intensity + const auto p = (reflectAmplitude.p * complex::conj(reflectAmplitude.p)).real(); // p-polarized intensity - return { - .s = s, - .p = p, - }; + return {.s = s, .p = p}; } +// Computes the transmittance (intensity) based on the Fresnel transmission amplitudes +// Source: "Polarized Light and Optical Systems", p. 302, Formula 8.19 and 8.20 RAYX_FN_ACC inline FresnelCoeffs calcRefractIntensity(const ComplexFresnelCoeffs refract_amplitude, const complex::Complex incidentAngle, const complex::Complex refractAngle, const complex::Complex iorI, const complex::Complex iorT) { const auto r = ((iorT * complex::cos(refractAngle)) / (iorI * complex::cos(incidentAngle))).real(); - const auto s = r * (refract_amplitude.s * complex::conj(refract_amplitude.s)).real(); - const auto p = r * (refract_amplitude.p * complex::conj(refract_amplitude.p)).real(); + const auto s = r * (refract_amplitude.s * complex::conj(refract_amplitude.s)).real(); // s-polarized intensity + const auto p = r * (refract_amplitude.p * complex::conj(refract_amplitude.p)).real(); // p-polarized intensity - return { - .s = s, - .p = p, - }; + return {.s = s, .p = p}; } +// Computes the Jones matrix, representing the effect on the polarization state, based on Fresnel coefficients +// Source: "Polarized Light and Optical Systems", p. 385, Formula 10.26 RAYX_FN_ACC -inline cmat3 calcJonesMatrix(const ComplexFresnelCoeffs amplitude) { - return { - amplitude.s, 0, 0, 0, amplitude.p, 0, 0, 0, 1, - }; -} +inline cmat3 calcJonesMatrix(const ComplexFresnelCoeffs amplitude) { return {amplitude.s, 0, 0, 0, amplitude.p, 0, 0, 0, 1}; } +// Computes the polarization transformation matrix for reflection/refraction +// Source: "Polarized Light and Optical Systems", p. 386, Formula 10.22 and 10.31 RAYX_FN_ACC inline cmat3 calcPolaririzationMatrix(const glm::dvec3 incidentVec, const glm::dvec3 reflectOrRefractVec, const glm::dvec3 normalVec, const ComplexFresnelCoeffs amplitude) { @@ -107,24 +116,22 @@ inline cmat3 calcPolaririzationMatrix(const glm::dvec3 incidentVec, const glm::d const auto p1 = glm::cross(reflectOrRefractVec, s0); const auto out = glm::dmat3(s1, p1, reflectOrRefractVec); - const auto in = glm::dmat3(s0.x, p0.x, incidentVec.x, s0.y, p0.y, incidentVec.y, s0.z, p0.z, incidentVec.z); const auto jonesMatrix = calcJonesMatrix(amplitude); - return out * jonesMatrix * in; } +// Computes the polarization matrix for reflection at normal incidence (simplified case) +// Source: "Polarized Light and Optical Systems", p. 387, Formula 10.35 RAYX_FN_ACC inline cmat3 calcReflectPolarizationMatrixAtNormalIncidence(const ComplexFresnelCoeffs amplitude) { - // since no plane of incidence is defined at normal incidence, - // s and p components are equal and only contain the base reflectivity and a phase shift of 180 degrees - // here we apply the base reflectivity and phase shift independent of the ray direction to all components return { - amplitude.s, 0, 0, 0, amplitude.s, 0, 0, 0, amplitude.s, + amplitude.s, 0, 0, 0, amplitude.s, 0, 0, 0, amplitude.s, // All components equal since it's normal incidence }; } +// Calculates the reflected electric field after intercepting a surface RAYX_FN_ACC inline ElectricField interceptReflect(const ElectricField incidentElectricField, const glm::dvec3 incidentVec, const glm::dvec3 reflectVec, const glm::dvec3 normalVec, const complex::Complex iorI, const complex::Complex iorT) { @@ -133,35 +140,46 @@ inline ElectricField interceptReflect(const ElectricField incidentElectricField, const auto reflectAmplitude = calcReflectAmplitude(incidentAngle, refractAngle, iorI, iorT); - // TODO: make this more robust - const auto isNormalIncidence = incidentVec == -normalVec; + const auto isNormalIncidence = incidentVec == -normalVec; // Check for normal incidence const auto reflectPolarizationMatrix = isNormalIncidence ? calcReflectPolarizationMatrixAtNormalIncidence(reflectAmplitude) : calcPolaririzationMatrix(incidentVec, reflectVec, normalVec, reflectAmplitude); - const auto reflectElectricField = reflectPolarizationMatrix * incidentElectricField; + const auto reflectElectricField = reflectPolarizationMatrix * incidentElectricField; // Reflect electric field return reflectElectricField; } +// Computes the intensity from a 2D electric field (local) +// Source: "Polarized Light and Optical Systems", p. 76, Formula 3.25 RAYX_FN_ACC inline double intensity(const LocalElectricField field) { const auto mag = complex::abs(field); return glm::dot(mag, mag); } +// Computes the intensity from a 3D electric field (global) +// Source: "Polarized Light and Optical Systems", p. 76, Formula 3.25 RAYX_FN_ACC inline double intensity(const ElectricField field) { const auto mag = complex::abs(field); return glm::dot(mag, mag); } +// Returns the intensity from a Stokes vector +// Source: https://en.wikipedia.org/wiki/Stokes_parameters RAYX_FN_ACC inline double intensity(const Stokes stokes) { return stokes.x; } +// Computes the degree of polarization from a Stokes vector +// Source: https://en.wikipedia.org/wiki/Stokes_parameters RAYX_FN_ACC inline double degreeOfPolarization(const Stokes stokes) { return glm::length(glm::vec3(stokes.y, stokes.z, stokes.w)) / stokes.x; } +// Converts a local electric field to a Stokes vector +// Source: "Polarized Light and Optical Systems", p. 76, Formula 3.25 RAYX_FN_ACC -inline Stokes fieldToStokes(const LocalElectricField field) { +inline Stokes localElectricFieldToStokes(const LocalElectricField field) { + // note that we omit the magnitude scale with the impedance of free space (https://en.wikipedia.org/wiki/Impedance_of_free_space) + const auto mag = complex::abs(field); const auto theta = complex::arg(field); @@ -169,9 +187,8 @@ inline Stokes fieldToStokes(const LocalElectricField field) { 2.0 * mag.x * mag.y * glm::sin(theta.x - theta.y)); } -RAYX_FN_ACC -inline Stokes fieldToStokes(const ElectricField field) { return fieldToStokes(LocalElectricField(field)); } - +// Converts a Stokes vector into a local electric field +// Source: "Polarized Light and Optical Systems", p. 77, Formula 3.28 RAYX_FN_ACC inline LocalElectricField stokesToLocalElectricField(const Stokes stokes) { const auto x_real = glm::sqrt((stokes.x + stokes.y) / 2.0); @@ -183,30 +200,94 @@ inline LocalElectricField stokesToLocalElectricField(const Stokes stokes) { return LocalElectricField({x_real, 0}, y); } -RAYX_FN_ACC -inline ElectricField stokesToElectricField(const Stokes stokes) { return ElectricField(stokesToLocalElectricField(stokes), complex::Complex(0, 0)); } +struct RotationBase { + glm::dvec3 right; + glm::dvec3 up; + glm::dvec3 forward; +}; +// Computes a base given a forward vector +// A convention for the up and right vectors is implemented, making this function well defined and for all forward directions +// TODO(Sven): this convention should be exchanged with one that does not branch RAYX_FN_ACC -inline glm::dmat3 rotationMatrix(const glm::dvec3 forward) { +inline RotationBase forwardVectorToBaseConvention(glm::dvec3 forward) { auto up = glm::dvec3(0, 1, 0); glm::dvec3 right; + // If the forward vector is not nearly vertical, we use the up vector (0, 1, 0), othwewise use the right vector (1, 0, 0) if (glm::abs(glm::dot(forward, up)) < .5) { - right = glm::normalize(glm::cross(forward, up)); - up = glm::normalize(glm::cross(right, forward)); + right = glm::normalize(glm::cross(up, forward)); + up = glm::cross(forward, right); } else { right = glm::dvec3(1, 0, 0); up = glm::normalize(glm::cross(forward, right)); - right = glm::normalize(glm::cross(forward, up)); + right = glm::cross(up, forward); } - return glm::dmat3(right, up, forward); + return RotationBase{ + .right = right, + .up = up, + .forward = forward, + }; +} + +// Computes a rotation matrix given a forward vector. This matrix can be used to align an object with a direction +RAYX_FN_ACC +inline glm::dmat3 rotationMatrix(const glm::dvec3 forward) { + const auto base = forwardVectorToBaseConvention(forward); + return glm::dmat3(base.right, base.up, base.forward); } +// Computes a rotation matrix given both forward and up vectors, used to align objects in space RAYX_FN_ACC inline glm::dmat3 rotationMatrix(const glm::dvec3 forward, const glm::dvec3 up) { const auto right = glm::cross(forward, up); return glm::dmat3(right, up, forward); } +RAYX_FN_ACC +inline ElectricField localToGlobalElectricField(LocalElectricField localField, glm::dvec3 forward) { + return rotationMatrix(forward) * ElectricField(localField, complex::Complex{0, 0}); +} + +RAYX_FN_ACC +inline ElectricField localToGlobalElectricField(LocalElectricField localField, glm::dvec3 forward, glm::dvec3 up) { + return rotationMatrix(forward, up) * ElectricField(localField, complex::Complex{0, 0}); +} + +RAYX_FN_ACC +inline LocalElectricField globalToLocalElectricField(ElectricField field, glm::dvec3 forward) { + return glm::transpose(rotationMatrix(forward)) * field; +} + +RAYX_FN_ACC +inline LocalElectricField globalToLocalElectricField(ElectricField field, glm::dvec3 forward, glm::vec3 up) { + return glm::transpose(rotationMatrix(forward, up)) * field; +} + +RAYX_FN_ACC +inline ElectricField stokesToElectricField(const Stokes stokes, const glm::dvec3 forward) { + return localToGlobalElectricField(stokesToLocalElectricField(stokes), forward); +} + +RAYX_FN_ACC +inline ElectricField stokesToElectricField(const Stokes stokes, const glm::dvec3 forward, const glm::dvec3 up) { + return localToGlobalElectricField(stokesToLocalElectricField(stokes), forward, up); +} + +RAYX_FN_ACC +inline ElectricField stokesToElectricField(const Stokes stokes, const glm::dmat3 rotation) { + return rotation * ElectricField(stokesToLocalElectricField(stokes), complex::Complex{0, 0}); +} + +RAYX_FN_ACC +inline ElectricField electricFieldToStokes(const ElectricField field, const glm::dvec3 forward) { + return localElectricFieldToStokes(globalToLocalElectricField(field, forward)); +} + +RAYX_FN_ACC +inline ElectricField electricFieldToStokes(const ElectricField field, const glm::dvec3 forward, const glm::dvec3 up) { + return localElectricFieldToStokes(globalToLocalElectricField(field, forward, up)); +} + } // namespace RAYX diff --git a/Intern/rayx-core/src/Shader/Utils.h b/Intern/rayx-core/src/Shader/Utils.h index 079442fd..4d930caa 100644 --- a/Intern/rayx-core/src/Shader/Utils.h +++ b/Intern/rayx-core/src/Shader/Utils.h @@ -16,6 +16,7 @@ RAYX_FN_ACC inline Ray RAYX_API rayMatrixMult(Ray r, const glm::dmat4 m) { r.m_position = glm::dvec3(m * glm::dvec4(r.m_position, 1)); r.m_direction = glm::dvec3(m * glm::dvec4(r.m_direction, 0)); + r.m_field = glm::dmat3(m) * r.m_field; return r; } diff --git a/Intern/rayx-core/src/Writer/CSVWriter.cpp b/Intern/rayx-core/src/Writer/CSVWriter.cpp index b4e2f0c6..7dd0874c 100644 --- a/Intern/rayx-core/src/Writer/CSVWriter.cpp +++ b/Intern/rayx-core/src/Writer/CSVWriter.cpp @@ -114,15 +114,12 @@ RAYX::BundleHistory loadCSV(const std::string& filename) { d.push_back(std::stod(num)); } - if (d.size() != 16) { + if (d.size() != 18) { RAYX_EXIT << "CSV line has incorrect length: " << d.size(); } const auto direction = glm::dvec3(d[4], d[5], d[6]); - - const auto stokes = glm::dvec4(d[8], d[9], d[10], d[11]); - // const auto rotation = glm::transpose(RAYX::rotationMatrix(direction)); - const auto field = /* rotation * */ RAYX::stokesToElectricField(stokes); + const auto field = RAYX::ElectricField({d[8], d[9]}, {d[10], d[11]}, {d[12], d[13]}); // create the Ray from the loaded doubles from this line. RAYX::Ray ray = {.m_position = {d[0], d[1], d[2]}, @@ -130,10 +127,10 @@ RAYX::BundleHistory loadCSV(const std::string& filename) { .m_direction = direction, .m_energy = d[7], .m_field = field, - .m_pathLength = d[12], - .m_order = d[13], - .m_lastElement = d[14], - .m_sourceID = d[15]}; + .m_pathLength = d[14], + .m_order = d[15], + .m_lastElement = d[16], + .m_sourceID = d[17]}; // This checks whether `ray_id` is from a "new ray" that didn't yet come up in the BundleHistory. // If so, we need to make place for it. if (out.size() <= ray_id) { diff --git a/Intern/rayx-core/tests/input/MatrixSource_distr_seeded.correct.csv b/Intern/rayx-core/tests/input/MatrixSource_distr_seeded.correct.csv index 3cbe1618..c807e1eb 100644 --- a/Intern/rayx-core/tests/input/MatrixSource_distr_seeded.correct.csv +++ b/Intern/rayx-core/tests/input/MatrixSource_distr_seeded.correct.csv @@ -1,201 +1,201 @@ -Ray-ID ,Event-ID ,X-position ,Y-position ,Z-position ,Event-type ,X-direction ,Y-direction ,Z-direction ,Energy ,Stokes0 ,Stokes1 ,Stokes2 ,Stokes3 ,pathLength ,order ,lastElement ,lightSourceIndex -0.00000000000000000000,0.00000000000000000000,-0.5325000416666707536,0.00000000000000000000,0.48000010416668242863,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,159.308596877220224996,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00025000004166031,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -1.00000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,0.48000008641519859020,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,36.6869575429444623182,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00021449707230658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -2.00000000000000000000,0.00000000000000000000,-0.3686538599795182724,0.00000000000000000000,0.48000007162229613166,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,155.938199524753315472,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00018491126604658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -3.00000000000000000000,0.00000000000000000000,-0.2867307757358520392,0.00000000000000000000,0.48000005978797460892,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,119.370032315927105059,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00016124262219818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -4.00000000000000000000,0.00000000000000000000,-0.2048076946783492502,0.00000000000000000000,0.48000005091223379993,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,0.00049999997916666690,89.1665515231822070063,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014349113985190,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -5.00000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,0.48000004499507348265,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,0.00049999997916666690,19.9949841061595314783,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00013165681866667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -6.00000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,0.48000004203649332401,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,0.00049999997916666690,91.8497775895171173488,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965807405,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -7.00000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,0.48000004203649332401,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,0.00049999997916666690,66.7417222789352990730,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965807405,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -8.00000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,0.48000004499507348265,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,0.00049999997916666690,28.5733628618934574205,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00013165681866667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -9.00000000000000000000,0.00000000000000000000,0.20480769467834930575,0.00000000000000000000,0.48000005091223379993,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,0.00049999997916666690,130.177694682538913184,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014349113985190,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -10.0000000000000000000,0.00000000000000000000,0.28673077573585203925,0.00000000000000000000,0.48000005978797460892,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,0.00049999997916666690,11.2823152940911963781,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00016124262219818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -11.0000000000000000000,0.00000000000000000000,0.36865385997951827246,0.00000000000000000000,0.48000007162229613166,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,0.00049999997916666690,144.399754317570426564,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00018491126604658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -12.0000000000000000000,0.00000000000000000000,0.45057694831968025939,0.00000000000000000000,0.48000008641519859020,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,0.00049999997916666690,187.710542880862618630,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00021449707230658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -13.0000000000000000000,0.00000000000000000000,0.53250004166667075367,0.00000000000000000000,0.48000010416668242863,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,0.00049999997916666690,0.15575294386496604803,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00025000004166031,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -14.0000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,0.40615392428122731871,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,0.00042307691045554557,198.442312888438408435,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00021449707230658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -15.0000000000000000000,0.00000000000000000000,-0.4505769483196802593,0.00000000000000000000,0.40615390926074129707,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,0.00042307691045554557,123.496301500940774076,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00017899410420341,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -16.0000000000000000000,0.00000000000000000000,-0.3686538599795181614,0.00000000000000000000,0.40615389674367019523,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,0.00042307691045554557,122.330632508343711606,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014940829908027,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -17.0000000000000000000,0.00000000000000000000,-0.2867307757358520947,0.00000000000000000000,0.40615388673001384667,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,0.00042307691045554557,1.41326170447591259460,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965602769,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -18.0000000000000000000,0.00000000000000000000,-0.2048076946783493057,0.00000000000000000000,0.40615387921977175178,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,0.00042307691045554557,4.61248569297894928098,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00010798817424984,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -19.0000000000000000000,0.00000000000000000000,-0.1228846158966773183,0.00000000000000000000,0.40615387421294396608,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,0.00042307691045554557,104.954932375102046648,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385351935,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -20.0000000000000000000,0.00000000000000000000,-0.0409615384805036841,0.00000000000000000000,0.40615387170952998996,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,0.00042307691045554557,79.9721955507928896622,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009023669315411,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -21.0000000000000000000,0.00000000000000000000,0.04096153848050368417,0.00000000000000000000,0.40615387170952998996,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,0.00042307691045554557,9.33313365311667553214,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009023669315411,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -22.0000000000000000000,0.00000000000000000000,0.12288461589667731832,0.00000000000000000000,0.40615387421294396608,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,0.00042307691045554557,194.751104524999647082,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385351935,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -23.0000000000000000000,0.00000000000000000000,0.20480769467834936126,0.00000000000000000000,0.40615387921977175178,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,0.00042307691045554557,46.5542680692286907628,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00010798817424984,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -24.0000000000000000000,0.00000000000000000000,0.28673077573585209476,0.00000000000000000000,0.40615388673001384667,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,0.00042307691045554557,18.1212870911977468324,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965602769,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -25.0000000000000000000,0.00000000000000000000,0.36865385997951816143,0.00000000000000000000,0.40615389674367019523,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,0.00042307691045554557,123.677202948293924578,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014940829908027,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -26.0000000000000000000,0.00000000000000000000,0.45057694831968031490,0.00000000000000000000,0.40615390926074129707,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,0.00042307691045554557,76.4923980172007418332,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00017899410420341,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -27.0000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,0.40615392428122731871,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,0.00042307691045554557,196.646177209132872576,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00021449707230658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -28.0000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,0.33230774940260138228,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,0.00034615383924101053,93.3525797197019073792,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00018491126604658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -29.0000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,0.33230773711311301088,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,0.00034615383924101053,171.988080668260380434,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014940829908027,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -30.0000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,0.33230772687187326575,1.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,0.00034615383924101053,136.061507774531264658,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00011982249475295,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -31.0000000000000000000,0.00000000000000000000,-0.2867307757358520392,0.00000000000000000000,0.33230771867888186932,1.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,0.00034615383924101053,90.0998506904812188622,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385238248,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -32.0000000000000000000,0.00000000000000000000,-0.2048076946783493057,0.00000000000000000000,0.33230771253413848853,1.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,0.00034615383924101053,2.65299161026556795661,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007840237128675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -33.0000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,0.33230770843764301236,1.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,0.00034615383924101053,188.440350859528479077,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006656805078364,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -34.0000000000000000000,0.00000000000000000000,-0.0409615384805036841,0.00000000000000000000,0.33230770638939538530,1.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,0.00034615383924101053,112.657642996091780673,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006065089064577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -35.0000000000000000000,0.00000000000000000000,0.04096153848050368417,0.00000000000000000000,0.33230770638939538530,1.00000000000000000000,0.00003846153614777726,0.99999993934911302062,0.00034615383924101053,77.0833012361739093876,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006065089064577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -36.0000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,0.33230770843764301236,1.00000000000000000000,0.00011538460821574884,0.99999993343195370254,0.00034615383924101053,3.19325146339676591011,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006656805078364,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -37.0000000000000000000,0.00000000000000000000,0.20480769467834933350,0.00000000000000000000,0.33230771253413848853,1.00000000000000000000,0.00019230767960097126,0.99999992159763495536,0.00034615383924101053,46.1787641621611015807,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007840237128675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -38.0000000000000000000,0.00000000000000000000,0.28673077573585203925,0.00000000000000000000,0.33230771867888186932,1.00000000000000000000,0.00026923074984827827,0.99999990384615689009,0.00034615383924101053,48.2050938178331307426,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385238248,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -39.0000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,0.33230772687187326575,1.00000000000000000000,0.00034615381850250414,0.99999988017751961777,0.00034615383924101053,136.652704872342923181,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00011982249475295,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -40.0000000000000000000,0.00000000000000000000,0.45057694831968025939,0.00000000000000000000,0.33230773711311301088,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,0.00034615383924101053,121.999331359285719145,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014940829908027,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -41.0000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,0.33230774940260138228,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,0.00034615383924101053,166.638982660751537423,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00018491126604658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -42.0000000000000000000,0.00000000000000000000,-0.5325000416666707536,0.00000000000000000000,0.25846157862047175468,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,0.00026923076597822786,34.6729294477666059037,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00016124262219818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -43.0000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,0.25846156906198097802,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,0.00026923076597822786,78.2121218923041823245,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965591400,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -44.0000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,0.25846156109657242305,1.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,0.00026923076597822786,36.4472173704875643807,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385249617,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -45.0000000000000000000,0.00000000000000000000,-0.2867307757358520947,0.00000000000000000000,0.25846155472424586774,1.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,0.00026923076597822786,151.072281773917438840,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007248521058045,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -46.0000000000000000000,0.00000000000000000000,-0.2048076946783492779,0.00000000000000000000,0.25846154994500109003,1.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,0.00026923076597822786,85.0311754935028005775,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00005473372982578,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -47.0000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,0.25846154675883803442,1.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,0.00026923076597822786,41.5883327465477208306,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00004289940966373,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -48.0000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,0.25846154516575653437,1.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,0.00026923076597822786,113.540065454677701950,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224963954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -49.0000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,0.25846154516575653437,1.00000000000000000000,0.00003846153705810951,0.99999996301775162521,0.00026923076597822786,6.26265835162779804790,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224963954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -50.0000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,0.25846154675883803442,1.00000000000000000000,0.00011538461094674560,0.99999995710059208509,0.00026923076597822786,168.456954594807911007,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00004289940966373,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -51.0000000000000000000,0.00000000000000000000,0.20480769467834933350,0.00000000000000000000,0.25846154994500109003,1.00000000000000000000,0.00019230768415263250,0.99999994526627311586,0.00026923076597822786,89.9508258071613653328,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00005473372982578,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -52.0000000000000000000,0.00000000000000000000,0.28673077573585209476,0.00000000000000000000,0.25846155472424586774,1.00000000000000000000,0.00026923075622060400,0.99999992751479460650,0.00026923076597822786,79.0300463044620187247,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007248521058045,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -53.0000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,0.25846156109657242305,1.00000000000000000000,0.00034615382669549426,0.99999990384615689009,0.00026923076597822786,185.331772450667756402,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385249617,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -54.0000000000000000000,0.00000000000000000000,0.45057694831968025939,0.00000000000000000000,0.25846156906198097802,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,0.00026923076597822786,145.454399228434624546,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965591400,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -55.0000000000000000000,0.00000000000000000000,0.53250004166667075367,0.00000000000000000000,0.25846157862047175468,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,0.00026923076597822786,65.3081542964345231894,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00016124262219818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -56.0000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,0.18461541102450593210,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,0.00019230769112236383,114.088795220965707244,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014349113985190,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -57.0000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,0.18461540419701261139,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,0.00019230769112236383,104.166853219309558653,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00010798817424984,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -58.0000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,0.18461539850743513557,1.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,0.00019230769112236383,192.234405780265660723,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007840237128675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -59.0000000000000000000,0.00000000000000000000,-0.2867307757358520947,0.00000000000000000000,0.18461539395577336586,1.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,0.00019230769112236383,168.906770127105232859,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00005473372982578,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -60.0000000000000000000,0.00000000000000000000,-0.2048076946783493057,0.00000000000000000000,0.18461539054202713572,1.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,0.00019230769112236383,149.464022216727954628,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224941217,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -61.0000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,0.18461538826619638964,1.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,0.00019230769112236383,107.938425919958007170,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00002514792947749,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -62.0000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,0.18461538712828104435,1.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,0.00019230769112236383,117.350233699509459484,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001923076956700,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -63.0000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,0.18461538712828104435,1.00000000000000000000,0.00003846153774085871,0.99999998076923080070,0.00019230769112236383,193.051062196737859721,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001923076956700,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -64.0000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,0.18461538826619638964,1.00000000000000000000,0.00011538461299499319,0.99999997485207114955,0.00019230769112236383,121.406850014209481969,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00002514792947749,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -65.0000000000000000000,0.00000000000000000000,0.20480769467834936126,0.00000000000000000000,0.18461539054202713572,1.00000000000000000000,0.00019230768756637849,0.99999996301775195828,0.00019230769112236383,55.1998367661609847800,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224941217,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -66.0000000000000000000,0.00000000000000000000,0.28673077573585209476,0.00000000000000000000,0.18461539395577336586,1.00000000000000000000,0.00026923076099984833,0.99999994526627311586,0.00019230769112236383,59.2547012630977434355,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00005473372982578,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -67.0000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,0.18461539850743513557,1.00000000000000000000,0.00034615383284023691,0.99999992159763495536,0.00019230769112236383,33.0533882680007735643,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007840237128675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -68.0000000000000000000,0.00000000000000000000,0.45057694831968020388,0.00000000000000000000,0.18461540419701261139,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,0.00019230769112236383,3.12728099597787467800,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00010798817424984,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -69.0000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,0.18461541102450593210,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,0.00019230769112236383,84.6802953827847488810,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014349113985190,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -70.0000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,0.11076924570437117478,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,0.00011538461512858444,78.9763033573926236385,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00013165681866667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -71.0000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,0.11076924160787522677,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,0.00011538461512858444,58.6976352750085439424,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385340566,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -72.0000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,0.11076923819412874683,1.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,0.00011538461512858444,2.81596472552417909085,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006656805078364,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -73.0000000000000000000,0.00000000000000000000,-0.2867307757358520392,0.00000000000000000000,0.11076923546313169333,1.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,0.00011538461512858444,39.7684806119111584621,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00004289940966373,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -74.0000000000000000000,0.00000000000000000000,-0.2048076946783493057,0.00000000000000000000,0.11076923341488398300,1.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,0.00011538461512858444,142.268389822512006048,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00002514792947749,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -75.0000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,0.11076923204938554645,1.00000000000000000000,-0.0001153846143604915,0.99999998668639045185,0.00011538461512858444,158.035107086886426941,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001331360965650,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -76.0000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,0.11076923136663634206,1.00000000000000000000,-0.0000384615381960248,0.99999999260355021402,0.00011538461512858444,121.191996084803705002,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000739644974601,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -77.0000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,0.11076923136663634206,1.00000000000000000000,0.00003846153819602484,0.99999999260355021402,0.00011538461512858444,185.260175630743674446,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000739644974601,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -78.0000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,0.11076923204938554645,1.00000000000000000000,0.00011538461436049158,0.99999998668639045185,0.00011538461512858444,130.215406122201898142,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001331360965650,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -79.0000000000000000000,0.00000000000000000000,0.20480769467834936126,0.00000000000000000000,0.11076923341488398300,1.00000000000000000000,0.00019230768984220914,0.99999997485207114955,0.00011538461512858444,182.991935122523443624,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00002514792947749,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -80.0000000000000000000,0.00000000000000000000,0.28673077573585203925,0.00000000000000000000,0.11076923546313169333,1.00000000000000000000,0.00026923076418601120,0.99999995710059208509,0.00011538461512858444,170.007715041285308643,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00004289940966373,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -81.0000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,0.11076923819412874683,1.00000000000000000000,0.00034615383693673202,0.99999993343195370254,0.00011538461512858444,89.8901348677208034132,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006656805078364,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -82.0000000000000000000,0.00000000000000000000,0.45057694831968020388,0.00000000000000000000,0.11076924160787522677,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,0.00011538461512858444,19.0820232078158333877,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385340566,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -83.0000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,0.11076924570437117478,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,0.00011538461512858444,74.1636510179759085303,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00013165681866667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -84.0000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,0.03692308174973495116,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,0.00003846153845205580,133.768251429723648016,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965807405,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -85.0000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,0.03692308038423629951,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,0.00003846153845205580,133.184470453575357851,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009023669315411,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -86.0000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,0.03692307924632082238,1.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,0.00003846153845205580,118.259557131272629248,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006065089064577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -87.0000000000000000000,0.00000000000000000000,-0.2867307757358520947,0.00000000000000000000,0.03692307833598847816,1.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,0.00003846153845205580,54.9443582666442651429,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224963954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -88.0000000000000000000,0.00000000000000000000,-0.2048076946783492779,0.00000000000000000000,0.03692307765323923907,1.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,0.00003846153845205580,112.248684585152361137,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001923076956700,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -89.0000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,0.03692307719807309818,1.00000000000000000000,-0.0001153846150432407,0.99999999260355021402,0.00003846153845205580,76.5853748835123582239,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000739644974601,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -90.0000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,0.03692307697049002773,1.00000000000000000000,-0.0000384615384236079,0.99999999852070997619,0.00003846153845205580,194.342418712177874340,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000147928994920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -91.0000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,0.03692307697049002773,1.00000000000000000000,0.00003846153842360791,0.99999999852070997619,0.00003846153845205580,169.782763852221592060,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000147928994920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -92.0000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,0.03692307719807309818,1.00000000000000000000,0.00011538461504324078,0.99999999260355021402,0.00003846153845205580,144.345903616479120046,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000739644974601,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -93.0000000000000000000,0.00000000000000000000,0.20480769467834933350,0.00000000000000000000,0.03692307765323923907,1.00000000000000000000,0.00019230769098012445,0.99999998076923080070,0.00003846153845205580,47.1969838364042786338,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001923076956700,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -94.0000000000000000000,0.00000000000000000000,0.28673077573585209476,0.00000000000000000000,0.03692307833598847816,1.00000000000000000000,0.00026923076577909266,0.99999996301775162521,0.00003846153845205580,51.2136644337358077905,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224963954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -95.0000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,0.03692307924632082238,1.00000000000000000000,0.00034615383898497955,0.99999993934911302062,0.00003846153845205580,8.08671834135584433056,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006065089064577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -96.0000000000000000000,0.00000000000000000000,0.45057694831968025939,0.00000000000000000000,0.03692308038423629951,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,0.00003846153845205580,142.132577985090335914,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009023669315411,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -97.0000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,0.03692308174973495116,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,0.00003846153845205580,22.1781652938058044810,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965807405,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -98.0000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,-0.0369230817497349581,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,-0.0000384615384520558,87.8673014901269482379,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965807405,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -99.0000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,-0.0369230803842363064,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,-0.0000384615384520558,40.3438412678297240177,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009023669315411,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -100.000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,-0.0369230792463208293,1.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,-0.0000384615384520558,179.152719671640710430,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006065089064577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -101.000000000000000000,0.00000000000000000000,-0.2867307757358520947,0.00000000000000000000,-0.0369230783359884850,1.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,-0.0000384615384520558,95.0740449351896614871,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224963954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -102.000000000000000000,0.00000000000000000000,-0.2048076946783492779,0.00000000000000000000,-0.0369230776532392460,1.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,-0.0000384615384520558,112.655114967528518832,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001923076956700,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -103.000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,-0.0369230771980731051,1.00000000000000000000,-0.0001153846150432407,0.99999999260355021402,-0.0000384615384520558,139.103216104931959762,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000739644974601,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -104.000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,-0.0369230769704900346,1.00000000000000000000,-0.0000384615384236079,0.99999999852070997619,-0.0000384615384520558,27.8662907024534156619,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000147928994920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -105.000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,-0.0369230769704900346,1.00000000000000000000,0.00003846153842360791,0.99999999852070997619,-0.0000384615384520558,120.883475551587409313,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000147928994920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -106.000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,-0.0369230771980731051,1.00000000000000000000,0.00011538461504324078,0.99999999260355021402,-0.0000384615384520558,107.968217811539830108,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000739644974601,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -107.000000000000000000,0.00000000000000000000,0.20480769467834933350,0.00000000000000000000,-0.0369230776532392460,1.00000000000000000000,0.00019230769098012445,0.99999998076923080070,-0.0000384615384520558,40.6122459193254456977,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001923076956700,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -108.000000000000000000,0.00000000000000000000,0.28673077573585209476,0.00000000000000000000,-0.0369230783359884850,1.00000000000000000000,0.00026923076577909266,0.99999996301775162521,-0.0000384615384520558,188.570714599585784299,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224963954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -109.000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,-0.0369230792463208293,1.00000000000000000000,0.00034615383898497955,0.99999993934911302062,-0.0000384615384520558,119.773093173227522356,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006065089064577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -110.000000000000000000,0.00000000000000000000,0.45057694831968025939,0.00000000000000000000,-0.0369230803842363064,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,-0.0000384615384520558,138.956987238246256310,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009023669315411,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -111.000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,-0.0369230817497349581,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,-0.0000384615384520558,176.093567715979560261,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965807405,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -112.000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,-0.1107692457043711747,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,-0.0001153846151285844,124.870808870734364859,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00013165681866667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -113.000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,-0.1107692416078752267,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,-0.0001153846151285844,59.1267375878819194667,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385340566,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -114.000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,-0.1107692381941287468,1.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,-0.0001153846151285844,21.0988516037116866641,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006656805078364,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -115.000000000000000000,0.00000000000000000000,-0.2867307757358520392,0.00000000000000000000,-0.1107692354631316933,1.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,-0.0001153846151285844,91.3069141775618646761,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00004289940966373,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -116.000000000000000000,0.00000000000000000000,-0.2048076946783493057,0.00000000000000000000,-0.1107692334148839830,1.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,-0.0001153846151285844,43.6880876877550221593,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00002514792947749,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -117.000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,-0.1107692320493855464,1.00000000000000000000,-0.0001153846143604915,0.99999998668639045185,-0.0001153846151285844,83.3019891482084062772,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001331360965650,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -118.000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,-0.1107692313666363420,1.00000000000000000000,-0.0000384615381960248,0.99999999260355021402,-0.0001153846151285844,176.656052371639759712,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000739644974601,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -119.000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,-0.1107692313666363420,1.00000000000000000000,0.00003846153819602484,0.99999999260355021402,-0.0001153846151285844,64.8690044565286996203,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000739644974601,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -120.000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,-0.1107692320493855464,1.00000000000000000000,0.00011538461436049158,0.99999998668639045185,-0.0001153846151285844,24.4175906349945783802,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001331360965650,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -121.000000000000000000,0.00000000000000000000,0.20480769467834936126,0.00000000000000000000,-0.1107692334148839830,1.00000000000000000000,0.00019230768984220914,0.99999997485207114955,-0.0001153846151285844,71.2595682757113877414,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00002514792947749,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -122.000000000000000000,0.00000000000000000000,0.28673077573585203925,0.00000000000000000000,-0.1107692354631316933,1.00000000000000000000,0.00026923076418601120,0.99999995710059208509,-0.0001153846151285844,181.365689537805906184,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00004289940966373,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -123.000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,-0.1107692381941287468,1.00000000000000000000,0.00034615383693673202,0.99999993343195370254,-0.0001153846151285844,54.4264495499493605734,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006656805078364,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -124.000000000000000000,0.00000000000000000000,0.45057694831968020388,0.00000000000000000000,-0.1107692416078752267,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,-0.0001153846151285844,129.538024712712058317,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385340566,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -125.000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,-0.1107692457043711747,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,-0.0001153846151285844,0.10407529773751164614,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00013165681866667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -126.000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,-0.1846154110245059876,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,-0.0001923076911223638,70.5137705594566170930,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014349113985190,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -127.000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,-0.1846154041970126669,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,-0.0001923076911223638,60.9562517285710754322,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00010798817424984,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -128.000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,-0.1846153985074351910,1.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,-0.0001923076911223638,32.9311701080135890151,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007840237128675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -129.000000000000000000,0.00000000000000000000,-0.2867307757358520947,0.00000000000000000000,-0.1846153939557734213,1.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,-0.0001923076911223638,106.817884488687369071,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00005473372982578,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -130.000000000000000000,0.00000000000000000000,-0.2048076946783493057,0.00000000000000000000,-0.1846153905420271912,1.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,-0.0001923076911223638,96.9659953138246208936,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224941217,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -131.000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,-0.1846153882661964451,1.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,-0.0001923076911223638,138.487206431684853669,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00002514792947749,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -132.000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,-0.1846153871282810998,1.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,-0.0001923076911223638,53.8824666882591429839,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001923076956700,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -133.000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,-0.1846153871282810998,1.00000000000000000000,0.00003846153774085871,0.99999998076923080070,-0.0001923076911223638,48.8251041268988288379,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001923076956700,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -134.000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,-0.1846153882661964451,1.00000000000000000000,0.00011538461299499319,0.99999997485207114955,-0.0001923076911223638,33.6582091715322349045,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00002514792947749,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -135.000000000000000000,0.00000000000000000000,0.20480769467834936126,0.00000000000000000000,-0.1846153905420271912,1.00000000000000000000,0.00019230768756637849,0.99999996301775195828,-0.0001923076911223638,43.7528445952927782514,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224941217,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -136.000000000000000000,0.00000000000000000000,0.28673077573585209476,0.00000000000000000000,-0.1846153939557734213,1.00000000000000000000,0.00026923076099984833,0.99999994526627311586,-0.0001923076911223638,111.620400452897982290,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00005473372982578,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -137.000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,-0.1846153985074351910,1.00000000000000000000,0.00034615383284023691,0.99999992159763495536,-0.0001923076911223638,80.7672345733193850492,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007840237128675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -138.000000000000000000,0.00000000000000000000,0.45057694831968020388,0.00000000000000000000,-0.1846154041970126669,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,-0.0001923076911223638,12.9784493271676932835,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00010798817424984,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -139.000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,-0.1846154110245059876,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,-0.0001923076911223638,50.7830825286877924895,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014349113985190,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -140.000000000000000000,0.00000000000000000000,-0.5325000416666707536,0.00000000000000000000,-0.2584615786204717546,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,-0.0002692307659782278,49.3752127162588791975,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00016124262219818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -141.000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,-0.2584615690619809780,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,-0.0002692307659782278,139.260854138820633352,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965591400,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -142.000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,-0.2584615610965724230,1.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,-0.0002692307659782278,142.454117662844737424,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385249617,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -143.000000000000000000,0.00000000000000000000,-0.2867307757358520947,0.00000000000000000000,-0.2584615547242458677,1.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,-0.0002692307659782278,29.6173857593949385602,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007248521058045,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -144.000000000000000000,0.00000000000000000000,-0.2048076946783492779,0.00000000000000000000,-0.2584615499450010900,1.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,-0.0002692307659782278,199.548098072304412653,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00005473372982578,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -145.000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,-0.2584615467588380344,1.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,-0.0002692307659782278,53.3562031698776948474,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00004289940966373,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -146.000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,-0.2584615451657565343,1.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,-0.0002692307659782278,195.322990509523776836,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224963954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -147.000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,-0.2584615451657565343,1.00000000000000000000,0.00003846153705810951,0.99999996301775162521,-0.0002692307659782278,82.2074038633628276784,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224963954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -148.000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,-0.2584615467588380344,1.00000000000000000000,0.00011538461094674560,0.99999995710059208509,-0.0002692307659782278,6.61014719088798141655,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00004289940966373,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -149.000000000000000000,0.00000000000000000000,0.20480769467834933350,0.00000000000000000000,-0.2584615499450010900,1.00000000000000000000,0.00019230768415263250,0.99999994526627311586,-0.0002692307659782278,69.0142497115336084334,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00005473372982578,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -150.000000000000000000,0.00000000000000000000,0.28673077573585209476,0.00000000000000000000,-0.2584615547242458677,1.00000000000000000000,0.00026923075622060400,0.99999992751479460650,-0.0002692307659782278,126.870268612837008959,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007248521058045,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -151.000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,-0.2584615610965724230,1.00000000000000000000,0.00034615382669549426,0.99999990384615689009,-0.0002692307659782278,136.141091477158738598,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385249617,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -152.000000000000000000,0.00000000000000000000,0.45057694831968025939,0.00000000000000000000,-0.2584615690619809780,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,-0.0002692307659782278,106.186916890131996638,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965591400,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -153.000000000000000000,0.00000000000000000000,0.53250004166667075367,0.00000000000000000000,-0.2584615786204717546,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,-0.0002692307659782278,89.5566326308894531393,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00016124262219818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -154.000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,-0.3323077494026013822,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,-0.0003461538392410105,110.578617712151867635,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00018491126604658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -155.000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,-0.3323077371131130108,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,-0.0003461538392410105,118.539344826373110208,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014940829908027,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -156.000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,-0.3323077268718732657,1.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,-0.0003461538392410105,16.1706651598612474174,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00011982249475295,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -157.000000000000000000,0.00000000000000000000,-0.2867307757358520392,0.00000000000000000000,-0.3323077186788818693,1.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,-0.0003461538392410105,73.9308919464077121119,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385238248,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -158.000000000000000000,0.00000000000000000000,-0.2048076946783493057,0.00000000000000000000,-0.3323077125341384885,1.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,-0.0003461538392410105,48.4319873266927913846,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007840237128675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -159.000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,-0.3323077084376430123,1.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,-0.0003461538392410105,160.627950998169353624,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006656805078364,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -160.000000000000000000,0.00000000000000000000,-0.0409615384805036841,0.00000000000000000000,-0.3323077063893953853,1.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,-0.0003461538392410105,94.0601261551631893098,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006065089064577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -161.000000000000000000,0.00000000000000000000,0.04096153848050368417,0.00000000000000000000,-0.3323077063893953853,1.00000000000000000000,0.00003846153614777726,0.99999993934911302062,-0.0003461538392410105,196.684627327296112753,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006065089064577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -162.000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,-0.3323077084376430123,1.00000000000000000000,0.00011538460821574884,0.99999993343195370254,-0.0003461538392410105,79.7648886870045430441,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006656805078364,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -163.000000000000000000,0.00000000000000000000,0.20480769467834933350,0.00000000000000000000,-0.3323077125341384885,1.00000000000000000000,0.00019230767960097126,0.99999992159763495536,-0.0003461538392410105,163.286375944336498378,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007840237128675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -164.000000000000000000,0.00000000000000000000,0.28673077573585203925,0.00000000000000000000,-0.3323077186788818693,1.00000000000000000000,0.00026923074984827827,0.99999990384615689009,-0.0003461538392410105,159.669024487880307106,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385238248,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -165.000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,-0.3323077268718732657,1.00000000000000000000,0.00034615381850250414,0.99999988017751961777,-0.0003461538392410105,30.1435086946337236213,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00011982249475295,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -166.000000000000000000,0.00000000000000000000,0.45057694831968025939,0.00000000000000000000,-0.3323077371131130108,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,-0.0003461538392410105,101.639756304593703362,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014940829908027,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -167.000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,-0.3323077494026013822,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,-0.0003461538392410105,139.162562028309935158,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00018491126604658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -168.000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,-0.4061539242812273742,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,-0.0004230769104555456,171.671760215347575240,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00021449707230658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -169.000000000000000000,0.00000000000000000000,-0.4505769483196802593,0.00000000000000000000,-0.4061539092607413525,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,-0.0004230769104555456,65.1917813031915045485,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00017899410420341,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -170.000000000000000000,0.00000000000000000000,-0.3686538599795181614,0.00000000000000000000,-0.4061538967436702507,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,-0.0004230769104555456,44.0482096383460373090,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014940829908027,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -171.000000000000000000,0.00000000000000000000,-0.2867307757358520947,0.00000000000000000000,-0.4061538867300139021,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,-0.0004230769104555456,142.229906921794167828,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965602769,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -172.000000000000000000,0.00000000000000000000,-0.2048076946783493057,0.00000000000000000000,-0.4061538792197718072,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,-0.0004230769104555456,161.900210325117285492,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00010798817424984,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -173.000000000000000000,0.00000000000000000000,-0.1228846158966773183,0.00000000000000000000,-0.4061538742129440215,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,-0.0004230769104555456,69.7331973979559762710,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385351935,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -174.000000000000000000,0.00000000000000000000,-0.0409615384805036841,0.00000000000000000000,-0.4061538717095300454,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,-0.0004230769104555456,19.2353102423332877890,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009023669315411,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -175.000000000000000000,0.00000000000000000000,0.04096153848050368417,0.00000000000000000000,-0.4061538717095300454,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,-0.0004230769104555456,188.104652284668901529,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009023669315411,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -176.000000000000000000,0.00000000000000000000,0.12288461589667731832,0.00000000000000000000,-0.4061538742129440215,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,-0.0004230769104555456,79.5144039857001985183,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385351935,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -177.000000000000000000,0.00000000000000000000,0.20480769467834936126,0.00000000000000000000,-0.4061538792197718072,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,-0.0004230769104555456,103.550269013166015952,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00010798817424984,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -178.000000000000000000,0.00000000000000000000,0.28673077573585209476,0.00000000000000000000,-0.4061538867300139021,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,-0.0004230769104555456,167.542021341515237509,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965602769,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -179.000000000000000000,0.00000000000000000000,0.36865385997951816143,0.00000000000000000000,-0.4061538967436702507,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,-0.0004230769104555456,135.138023396753254701,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014940829908027,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -180.000000000000000000,0.00000000000000000000,0.45057694831968031490,0.00000000000000000000,-0.4061539092607413525,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,-0.0004230769104555456,147.043224830888959786,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00017899410420341,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -181.000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,-0.4061539242812273742,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,-0.0004230769104555456,41.8143235710017222572,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00021449707230658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -182.000000000000000000,0.00000000000000000000,-0.5325000416666707536,0.00000000000000000000,-0.4800001041666824286,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,-0.0004999999791666669,108.289594880372661123,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00025000004166031,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -183.000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,-0.4800000864151985902,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,-0.0004999999791666669,139.156879936148612841,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00021449707230658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -184.000000000000000000,0.00000000000000000000,-0.3686538599795182724,0.00000000000000000000,-0.4800000716222961316,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,-0.0004999999791666669,45.7100036660465463000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00018491126604658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -185.000000000000000000,0.00000000000000000000,-0.2867307757358520392,0.00000000000000000000,-0.4800000597879746089,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,-0.0004999999791666669,34.9909849080701746970,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00016124262219818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -186.000000000000000000,0.00000000000000000000,-0.2048076946783492502,0.00000000000000000000,-0.4800000509122337999,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,-0.0004999999791666669,196.433668582801146840,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014349113985190,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -187.000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,-0.4800000449950734826,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,-0.0004999999791666669,103.327178373776177977,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00013165681866667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -188.000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,-0.4800000420364933240,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,-0.0004999999791666669,52.1658353628976811933,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965807405,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -189.000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,-0.4800000420364933240,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,-0.0004999999791666669,199.250739859242628426,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965807405,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -190.000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,-0.4800000449950734826,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,-0.0004999999791666669,193.083870316176643200,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00013165681866667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -191.000000000000000000,0.00000000000000000000,0.20480769467834930575,0.00000000000000000000,-0.4800000509122337999,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,-0.0004999999791666669,111.658689591954157549,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014349113985190,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -192.000000000000000000,0.00000000000000000000,0.28673077573585203925,0.00000000000000000000,-0.4800000597879746089,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,-0.0004999999791666669,176.527269179124232323,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00016124262219818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -193.000000000000000000,0.00000000000000000000,0.36865385997951827246,0.00000000000000000000,-0.4800000716222961316,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,-0.0004999999791666669,37.7414221963243150526,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00018491126604658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -194.000000000000000000,0.00000000000000000000,0.45057694831968025939,0.00000000000000000000,-0.4800000864151985902,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,-0.0004999999791666669,55.7742703835885649255,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00021449707230658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -195.000000000000000000,0.00000000000000000000,0.53250004166667075367,0.00000000000000000000,-0.4800001041666824286,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,-0.0004999999791666669,140.071565783599282895,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00025000004166031,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -196.000000000000000000,0.00000000000000000000,-0.5325000416666707536,0.00000000000000000000,0.48000010416668242863,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,145.191135244721323260,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00025000004166031,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -197.000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,0.48000008641519859020,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,169.332227848780405565,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00021449707230658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -198.000000000000000000,0.00000000000000000000,-0.3686538599795182724,0.00000000000000000000,0.48000007162229613166,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,179.422050849400022798,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00018491126604658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -199.000000000000000000,0.00000000000000000000,-0.2867307757358520392,0.00000000000000000000,0.48000005978797460892,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,171.264857978388874926,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00016124262219818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +Ray-ID ,Event-ID ,X-position ,Y-position ,Z-position ,Event-type ,X-direction ,Y-direction ,Z-direction ,Energy ,ElectricField-x-real ,ElectricField-x-imag ,ElectricField-y-real ,ElectricField-y-imag ,ElectricField-z-real ,ElectricField-z-imag ,pathLength ,order ,lastElement ,lightSourceIndex +0.00000000000000000000,0.00000000000000000000,-0.5325000416666707536,0.00000000000000000000,0.48000010416668242863,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,159.308596877220224996,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00025000004166031,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +1.00000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,0.48000008641519859020,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,36.6869575429444623182,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00021449707230658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +2.00000000000000000000,0.00000000000000000000,-0.3686538599795182724,0.00000000000000000000,0.48000007162229613166,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,155.938199524753315472,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00018491126604658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +3.00000000000000000000,0.00000000000000000000,-0.2867307757358520392,0.00000000000000000000,0.48000005978797460892,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,119.370032315927105059,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00016124262219818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +4.00000000000000000000,0.00000000000000000000,-0.2048076946783492502,0.00000000000000000000,0.48000005091223379993,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,0.00049999997916666690,89.1665515231822070063,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014349113985190,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +5.00000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,0.48000004499507348265,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,0.00049999997916666690,19.9949841061595314783,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00013165681866667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +6.00000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,0.48000004203649332401,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,0.00049999997916666690,91.8497775895171173488,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965807405,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +7.00000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,0.48000004203649332401,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,0.00049999997916666690,66.7417222789352990730,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965807405,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +8.00000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,0.48000004499507348265,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,0.00049999997916666690,28.5733628618934574205,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00013165681866667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +9.00000000000000000000,0.00000000000000000000,0.20480769467834930575,0.00000000000000000000,0.48000005091223379993,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,0.00049999997916666690,130.177694682538913184,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014349113985190,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +10.0000000000000000000,0.00000000000000000000,0.28673077573585203925,0.00000000000000000000,0.48000005978797460892,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,0.00049999997916666690,11.2823152940911963781,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00016124262219818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +11.0000000000000000000,0.00000000000000000000,0.36865385997951827246,0.00000000000000000000,0.48000007162229613166,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,0.00049999997916666690,144.399754317570426564,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00018491126604658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +12.0000000000000000000,0.00000000000000000000,0.45057694831968025939,0.00000000000000000000,0.48000008641519859020,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,0.00049999997916666690,187.710542880862618630,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00021449707230658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +13.0000000000000000000,0.00000000000000000000,0.53250004166667075367,0.00000000000000000000,0.48000010416668242863,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,0.00049999997916666690,0.15575294386496604803,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00025000004166031,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +14.0000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,0.40615392428122731871,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,0.00042307691045554557,198.442312888438408435,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00021449707230658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +15.0000000000000000000,0.00000000000000000000,-0.4505769483196802593,0.00000000000000000000,0.40615390926074129707,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,0.00042307691045554557,123.496301500940774076,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00017899410420341,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +16.0000000000000000000,0.00000000000000000000,-0.3686538599795181614,0.00000000000000000000,0.40615389674367019523,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,0.00042307691045554557,122.330632508343711606,0.99999994008875814355,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014940829908027,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +17.0000000000000000000,0.00000000000000000000,-0.2867307757358520947,0.00000000000000000000,0.40615388673001384667,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,0.00042307691045554557,1.41326170447591259460,0.99999996375739674814,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965602769,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +18.0000000000000000000,0.00000000000000000000,-0.2048076946783493057,0.00000000000000000000,0.40615387921977175178,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,0.00042307691045554557,4.61248569297894928098,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00010798817424984,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +19.0000000000000000000,0.00000000000000000000,-0.1228846158966773183,0.00000000000000000000,0.40615387421294396608,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,0.00042307691045554557,104.954932375102046648,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385351935,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +20.0000000000000000000,0.00000000000000000000,-0.0409615384805036841,0.00000000000000000000,0.40615387170952998996,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,0.00042307691045554557,79.9721955507928896622,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009023669315411,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +21.0000000000000000000,0.00000000000000000000,0.04096153848050368417,0.00000000000000000000,0.40615387170952998996,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,0.00042307691045554557,9.33313365311667553214,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009023669315411,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +22.0000000000000000000,0.00000000000000000000,0.12288461589667731832,0.00000000000000000000,0.40615387421294396608,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,0.00042307691045554557,194.751104524999647082,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385351935,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +23.0000000000000000000,0.00000000000000000000,0.20480769467834936126,0.00000000000000000000,0.40615387921977175178,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,0.00042307691045554557,46.5542680692286907628,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00010798817424984,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +24.0000000000000000000,0.00000000000000000000,0.28673077573585209476,0.00000000000000000000,0.40615388673001384667,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,0.00042307691045554557,18.1212870911977468324,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965602769,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +25.0000000000000000000,0.00000000000000000000,0.36865385997951816143,0.00000000000000000000,0.40615389674367019523,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,0.00042307691045554557,123.677202948293924578,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014940829908027,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +26.0000000000000000000,0.00000000000000000000,0.45057694831968031490,0.00000000000000000000,0.40615390926074129707,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,0.00042307691045554557,76.4923980172007418332,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00017899410420341,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +27.0000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,0.40615392428122731871,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,0.00042307691045554557,196.646177209132872576,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00021449707230658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +28.0000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,0.33230774940260138228,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,0.00034615383924101053,93.3525797197019073792,0.99999987500000253604,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00018491126604658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +29.0000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,0.33230773711311301088,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,0.00034615383924101053,171.988080668260380434,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014940829908027,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +30.0000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,0.33230772687187326575,1.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,0.00034615383924101053,136.061507774531264658,0.99999994008875792150,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00011982249475295,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +31.0000000000000000000,0.00000000000000000000,-0.2867307757358520392,0.00000000000000000000,0.33230771867888186932,1.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,0.00034615383924101053,90.0998506904812188622,0.99999996375739663712,0.00000000000000000000,0.00026923076597822780,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385238248,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +32.0000000000000000000,0.00000000000000000000,-0.2048076946783493057,0.00000000000000000000,0.33230771253413848853,1.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,0.00034615383924101053,2.65299161026556795661,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007840237128675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +33.0000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,0.33230770843764301236,1.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,0.00034615383924101053,188.440350859528479077,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006656805078364,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +34.0000000000000000000,0.00000000000000000000,-0.0409615384805036841,0.00000000000000000000,0.33230770638939538530,1.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,0.00034615383924101053,112.657642996091780673,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006065089064577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +35.0000000000000000000,0.00000000000000000000,0.04096153848050368417,0.00000000000000000000,0.33230770638939538530,1.00000000000000000000,0.00003846153614777726,0.99999993934911302062,0.00034615383924101053,77.0833012361739093876,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006065089064577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +36.0000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,0.33230770843764301236,1.00000000000000000000,0.00011538460821574884,0.99999993343195370254,0.00034615383924101053,3.19325146339676591011,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006656805078364,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +37.0000000000000000000,0.00000000000000000000,0.20480769467834933350,0.00000000000000000000,0.33230771253413848853,1.00000000000000000000,0.00019230767960097126,0.99999992159763495536,0.00034615383924101053,46.1787641621611015807,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007840237128675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +38.0000000000000000000,0.00000000000000000000,0.28673077573585203925,0.00000000000000000000,0.33230771867888186932,1.00000000000000000000,0.00026923074984827827,0.99999990384615689009,0.00034615383924101053,48.2050938178331307426,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385238248,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +39.0000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,0.33230772687187326575,1.00000000000000000000,0.00034615381850250414,0.99999988017751961777,0.00034615383924101053,136.652704872342923181,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00011982249475295,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +40.0000000000000000000,0.00000000000000000000,0.45057694831968025939,0.00000000000000000000,0.33230773711311301088,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,0.00034615383924101053,121.999331359285719145,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014940829908027,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +41.0000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,0.33230774940260138228,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,0.00034615383924101053,166.638982660751537423,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00018491126604658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +42.0000000000000000000,0.00000000000000000000,-0.5325000416666707536,0.00000000000000000000,0.25846157862047175468,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,0.00026923076597822786,34.6729294477666059037,0.99999987500000242501,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00016124262219818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +43.0000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,0.25846156906198097802,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,0.00026923076597822786,78.2121218923041823245,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965591400,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +44.0000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,0.25846156109657242305,1.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,0.00026923076597822786,36.4472173704875643807,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385249617,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +45.0000000000000000000,0.00000000000000000000,-0.2867307757358520947,0.00000000000000000000,0.25846155472424586774,1.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,0.00026923076597822786,151.072281773917438840,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007248521058045,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +46.0000000000000000000,0.00000000000000000000,-0.2048076946783492779,0.00000000000000000000,0.25846154994500109003,1.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,0.00026923076597822786,85.0311754935028005775,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00005473372982578,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +47.0000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,0.25846154675883803442,1.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,0.00026923076597822786,41.5883327465477208306,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00004289940966373,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +48.0000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,0.25846154516575653437,1.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,0.00026923076597822786,113.540065454677701950,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224963954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +49.0000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,0.25846154516575653437,1.00000000000000000000,0.00003846153705810951,0.99999996301775162521,0.00026923076597822786,6.26265835162779804790,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224963954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +50.0000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,0.25846154675883803442,1.00000000000000000000,0.00011538461094674560,0.99999995710059208509,0.00026923076597822786,168.456954594807911007,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00004289940966373,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +51.0000000000000000000,0.00000000000000000000,0.20480769467834933350,0.00000000000000000000,0.25846154994500109003,1.00000000000000000000,0.00019230768415263250,0.99999994526627311586,0.00026923076597822786,89.9508258071613653328,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00005473372982578,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +52.0000000000000000000,0.00000000000000000000,0.28673077573585209476,0.00000000000000000000,0.25846155472424586774,1.00000000000000000000,0.00026923075622060400,0.99999992751479460650,0.00026923076597822786,79.0300463044620187247,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007248521058045,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +53.0000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,0.25846156109657242305,1.00000000000000000000,0.00034615382669549426,0.99999990384615689009,0.00026923076597822786,185.331772450667756402,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385249617,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +54.0000000000000000000,0.00000000000000000000,0.45057694831968025939,0.00000000000000000000,0.25846156906198097802,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,0.00026923076597822786,145.454399228434624546,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965591400,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +55.0000000000000000000,0.00000000000000000000,0.53250004166667075367,0.00000000000000000000,0.25846157862047175468,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,0.00026923076597822786,65.3081542964345231894,0.99999987500000242501,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00016124262219818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +56.0000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,0.18461541102450593210,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,0.00019230769112236383,114.088795220965707244,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014349113985190,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +57.0000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,0.18461540419701261139,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,0.00019230769112236383,104.166853219309558653,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00010798817424984,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +58.0000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,0.18461539850743513557,1.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,0.00019230769112236383,192.234405780265660723,0.99999994008875814355,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007840237128675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +59.0000000000000000000,0.00000000000000000000,-0.2867307757358520947,0.00000000000000000000,0.18461539395577336586,1.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,0.00019230769112236383,168.906770127105232859,0.99999996375739674814,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00005473372982578,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +60.0000000000000000000,0.00000000000000000000,-0.2048076946783493057,0.00000000000000000000,0.18461539054202713572,1.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,0.00019230769112236383,149.464022216727954628,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224941217,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +61.0000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,0.18461538826619638964,1.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,0.00019230769112236383,107.938425919958007170,0.99999999334319533694,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00002514792947749,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +62.0000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,0.18461538712828104435,1.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,0.00019230769112236383,117.350233699509459484,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001923076956700,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +63.0000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,0.18461538712828104435,1.00000000000000000000,0.00003846153774085871,0.99999998076923080070,0.00019230769112236383,193.051062196737859721,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001923076956700,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +64.0000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,0.18461538826619638964,1.00000000000000000000,0.00011538461299499319,0.99999997485207114955,0.00019230769112236383,121.406850014209481969,0.99999999334319533694,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00002514792947749,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +65.0000000000000000000,0.00000000000000000000,0.20480769467834936126,0.00000000000000000000,0.18461539054202713572,1.00000000000000000000,0.00019230768756637849,0.99999996301775195828,0.00019230769112236383,55.1998367661609847800,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224941217,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +66.0000000000000000000,0.00000000000000000000,0.28673077573585209476,0.00000000000000000000,0.18461539395577336586,1.00000000000000000000,0.00026923076099984833,0.99999994526627311586,0.00019230769112236383,59.2547012630977434355,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00005473372982578,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +67.0000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,0.18461539850743513557,1.00000000000000000000,0.00034615383284023691,0.99999992159763495536,0.00019230769112236383,33.0533882680007735643,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007840237128675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +68.0000000000000000000,0.00000000000000000000,0.45057694831968020388,0.00000000000000000000,0.18461540419701261139,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,0.00019230769112236383,3.12728099597787467800,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00010798817424984,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +69.0000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,0.18461541102450593210,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,0.00019230769112236383,84.6802953827847488810,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014349113985190,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +70.0000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,0.11076924570437117478,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,0.00011538461512858444,78.9763033573926236385,0.99999987500000264706,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00013165681866667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +71.0000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,0.11076924160787522677,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,0.00011538461512858444,58.6976352750085439424,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385340566,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +72.0000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,0.11076923819412874683,1.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,0.00011538461512858444,2.81596472552417909085,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006656805078364,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +73.0000000000000000000,0.00000000000000000000,-0.2867307757358520392,0.00000000000000000000,0.11076923546313169333,1.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,0.00011538461512858444,39.7684806119111584621,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00004289940966373,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +74.0000000000000000000,0.00000000000000000000,-0.2048076946783493057,0.00000000000000000000,0.11076923341488398300,1.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,0.00011538461512858444,142.268389822512006048,0.99999998150887581260,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00002514792947749,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +75.0000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,0.11076923204938554645,1.00000000000000000000,-0.0001153846143604915,0.99999998668639045185,0.00011538461512858444,158.035107086886426941,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001331360965650,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +76.0000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,0.11076923136663634206,1.00000000000000000000,-0.0000384615381960248,0.99999999260355021402,0.00011538461512858444,121.191996084803705002,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000739644974601,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +77.0000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,0.11076923136663634206,1.00000000000000000000,0.00003846153819602484,0.99999999260355021402,0.00011538461512858444,185.260175630743674446,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000739644974601,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +78.0000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,0.11076923204938554645,1.00000000000000000000,0.00011538461436049158,0.99999998668639045185,0.00011538461512858444,130.215406122201898142,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001331360965650,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +79.0000000000000000000,0.00000000000000000000,0.20480769467834936126,0.00000000000000000000,0.11076923341488398300,1.00000000000000000000,0.00019230768984220914,0.99999997485207114955,0.00011538461512858444,182.991935122523443624,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00002514792947749,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +80.0000000000000000000,0.00000000000000000000,0.28673077573585203925,0.00000000000000000000,0.11076923546313169333,1.00000000000000000000,0.00026923076418601120,0.99999995710059208509,0.00011538461512858444,170.007715041285308643,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00004289940966373,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +81.0000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,0.11076923819412874683,1.00000000000000000000,0.00034615383693673202,0.99999993343195370254,0.00011538461512858444,89.8901348677208034132,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006656805078364,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +82.0000000000000000000,0.00000000000000000000,0.45057694831968020388,0.00000000000000000000,0.11076924160787522677,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,0.00011538461512858444,19.0820232078158333877,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385340566,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +83.0000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,0.11076924570437117478,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,0.00011538461512858444,74.1636510179759085303,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00013165681866667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +84.0000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,0.03692308174973495116,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,0.00003846153845205580,133.768251429723648016,0.99999987500000264706,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965807405,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +85.0000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,0.03692308038423629951,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,0.00003846153845205580,133.184470453575357851,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009023669315411,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +86.0000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,0.03692307924632082238,1.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,0.00003846153845205580,118.259557131272629248,0.99999994008875803253,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006065089064577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +87.0000000000000000000,0.00000000000000000000,-0.2867307757358520947,0.00000000000000000000,0.03692307833598847816,1.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,0.00003846153845205580,54.9443582666442651429,0.99999996375739685916,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224963954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +88.0000000000000000000,0.00000000000000000000,-0.2048076946783492779,0.00000000000000000000,0.03692307765323923907,1.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,0.00003846153845205580,112.248684585152361137,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001923076956700,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +89.0000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,0.03692307719807309818,1.00000000000000000000,-0.0001153846150432407,0.99999999260355021402,0.00003846153845205580,76.5853748835123582239,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000739644974601,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +90.0000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,0.03692307697049002773,1.00000000000000000000,-0.0000384615384236079,0.99999999852070997619,0.00003846153845205580,194.342418712177874340,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000147928994920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +91.0000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,0.03692307697049002773,1.00000000000000000000,0.00003846153842360791,0.99999999852070997619,0.00003846153845205580,169.782763852221592060,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000147928994920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +92.0000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,0.03692307719807309818,1.00000000000000000000,0.00011538461504324078,0.99999999260355021402,0.00003846153845205580,144.345903616479120046,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000739644974601,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +93.0000000000000000000,0.00000000000000000000,0.20480769467834933350,0.00000000000000000000,0.03692307765323923907,1.00000000000000000000,0.00019230769098012445,0.99999998076923080070,0.00003846153845205580,47.1969838364042786338,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001923076956700,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +94.0000000000000000000,0.00000000000000000000,0.28673077573585209476,0.00000000000000000000,0.03692307833598847816,1.00000000000000000000,0.00026923076577909266,0.99999996301775162521,0.00003846153845205580,51.2136644337358077905,0.99999996375739685916,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224963954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +95.0000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,0.03692307924632082238,1.00000000000000000000,0.00034615383898497955,0.99999993934911302062,0.00003846153845205580,8.08671834135584433056,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006065089064577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +96.0000000000000000000,0.00000000000000000000,0.45057694831968025939,0.00000000000000000000,0.03692308038423629951,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,0.00003846153845205580,142.132577985090335914,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009023669315411,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +97.0000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,0.03692308174973495116,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,0.00003846153845205580,22.1781652938058044810,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965807405,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +98.0000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,-0.0369230817497349581,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,-0.0000384615384520558,87.8673014901269482379,0.99999987500000264706,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965807405,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +99.0000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,-0.0369230803842363064,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,-0.0000384615384520558,40.3438412678297240177,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009023669315411,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +100.000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,-0.0369230792463208293,1.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,-0.0000384615384520558,179.152719671640710430,0.99999994008875803253,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006065089064577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +101.000000000000000000,0.00000000000000000000,-0.2867307757358520947,0.00000000000000000000,-0.0369230783359884850,1.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,-0.0000384615384520558,95.0740449351896614871,0.99999996375739685916,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224963954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +102.000000000000000000,0.00000000000000000000,-0.2048076946783492779,0.00000000000000000000,-0.0369230776532392460,1.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,-0.0000384615384520558,112.655114967528518832,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001923076956700,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +103.000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,-0.0369230771980731051,1.00000000000000000000,-0.0001153846150432407,0.99999999260355021402,-0.0000384615384520558,139.103216104931959762,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000739644974601,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +104.000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,-0.0369230769704900346,1.00000000000000000000,-0.0000384615384236079,0.99999999852070997619,-0.0000384615384520558,27.8662907024534156619,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000147928994920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +105.000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,-0.0369230769704900346,1.00000000000000000000,0.00003846153842360791,0.99999999852070997619,-0.0000384615384520558,120.883475551587409313,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000147928994920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +106.000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,-0.0369230771980731051,1.00000000000000000000,0.00011538461504324078,0.99999999260355021402,-0.0000384615384520558,107.968217811539830108,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000739644974601,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +107.000000000000000000,0.00000000000000000000,0.20480769467834933350,0.00000000000000000000,-0.0369230776532392460,1.00000000000000000000,0.00019230769098012445,0.99999998076923080070,-0.0000384615384520558,40.6122459193254456977,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001923076956700,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +108.000000000000000000,0.00000000000000000000,0.28673077573585209476,0.00000000000000000000,-0.0369230783359884850,1.00000000000000000000,0.00026923076577909266,0.99999996301775162521,-0.0000384615384520558,188.570714599585784299,0.99999996375739685916,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224963954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +109.000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,-0.0369230792463208293,1.00000000000000000000,0.00034615383898497955,0.99999993934911302062,-0.0000384615384520558,119.773093173227522356,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006065089064577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +110.000000000000000000,0.00000000000000000000,0.45057694831968025939,0.00000000000000000000,-0.0369230803842363064,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,-0.0000384615384520558,138.956987238246256310,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009023669315411,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +111.000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,-0.0369230817497349581,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,-0.0000384615384520558,176.093567715979560261,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965807405,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +112.000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,-0.1107692457043711747,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,-0.0001153846151285844,124.870808870734364859,0.99999987500000264706,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00013165681866667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +113.000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,-0.1107692416078752267,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,-0.0001153846151285844,59.1267375878819194667,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385340566,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +114.000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,-0.1107692381941287468,1.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,-0.0001153846151285844,21.0988516037116866641,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006656805078364,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +115.000000000000000000,0.00000000000000000000,-0.2867307757358520392,0.00000000000000000000,-0.1107692354631316933,1.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,-0.0001153846151285844,91.3069141775618646761,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00004289940966373,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +116.000000000000000000,0.00000000000000000000,-0.2048076946783493057,0.00000000000000000000,-0.1107692334148839830,1.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,-0.0001153846151285844,43.6880876877550221593,0.99999998150887581260,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00002514792947749,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +117.000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,-0.1107692320493855464,1.00000000000000000000,-0.0001153846143604915,0.99999998668639045185,-0.0001153846151285844,83.3019891482084062772,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001331360965650,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +118.000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,-0.1107692313666363420,1.00000000000000000000,-0.0000384615381960248,0.99999999260355021402,-0.0001153846151285844,176.656052371639759712,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000739644974601,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +119.000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,-0.1107692313666363420,1.00000000000000000000,0.00003846153819602484,0.99999999260355021402,-0.0001153846151285844,64.8690044565286996203,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00000739644974601,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +120.000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,-0.1107692320493855464,1.00000000000000000000,0.00011538461436049158,0.99999998668639045185,-0.0001153846151285844,24.4175906349945783802,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001331360965650,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +121.000000000000000000,0.00000000000000000000,0.20480769467834936126,0.00000000000000000000,-0.1107692334148839830,1.00000000000000000000,0.00019230768984220914,0.99999997485207114955,-0.0001153846151285844,71.2595682757113877414,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00002514792947749,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +122.000000000000000000,0.00000000000000000000,0.28673077573585203925,0.00000000000000000000,-0.1107692354631316933,1.00000000000000000000,0.00026923076418601120,0.99999995710059208509,-0.0001153846151285844,181.365689537805906184,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00004289940966373,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +123.000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,-0.1107692381941287468,1.00000000000000000000,0.00034615383693673202,0.99999993343195370254,-0.0001153846151285844,54.4264495499493605734,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006656805078364,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +124.000000000000000000,0.00000000000000000000,0.45057694831968020388,0.00000000000000000000,-0.1107692416078752267,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,-0.0001153846151285844,129.538024712712058317,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385340566,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +125.000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,-0.1107692457043711747,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,-0.0001153846151285844,0.10407529773751164614,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00013165681866667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +126.000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,-0.1846154110245059876,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,-0.0001923076911223638,70.5137705594566170930,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014349113985190,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +127.000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,-0.1846154041970126669,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,-0.0001923076911223638,60.9562517285710754322,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00010798817424984,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +128.000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,-0.1846153985074351910,1.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,-0.0001923076911223638,32.9311701080135890151,0.99999994008875814355,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007840237128675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +129.000000000000000000,0.00000000000000000000,-0.2867307757358520947,0.00000000000000000000,-0.1846153939557734213,1.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,-0.0001923076911223638,106.817884488687369071,0.99999996375739674814,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00005473372982578,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +130.000000000000000000,0.00000000000000000000,-0.2048076946783493057,0.00000000000000000000,-0.1846153905420271912,1.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,-0.0001923076911223638,96.9659953138246208936,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224941217,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +131.000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,-0.1846153882661964451,1.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,-0.0001923076911223638,138.487206431684853669,0.99999999334319533694,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00002514792947749,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +132.000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,-0.1846153871282810998,1.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,-0.0001923076911223638,53.8824666882591429839,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001923076956700,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +133.000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,-0.1846153871282810998,1.00000000000000000000,0.00003846153774085871,0.99999998076923080070,-0.0001923076911223638,48.8251041268988288379,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00001923076956700,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +134.000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,-0.1846153882661964451,1.00000000000000000000,0.00011538461299499319,0.99999997485207114955,-0.0001923076911223638,33.6582091715322349045,0.99999999334319533694,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00002514792947749,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +135.000000000000000000,0.00000000000000000000,0.20480769467834936126,0.00000000000000000000,-0.1846153905420271912,1.00000000000000000000,0.00019230768756637849,0.99999996301775195828,-0.0001923076911223638,43.7528445952927782514,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224941217,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +136.000000000000000000,0.00000000000000000000,0.28673077573585209476,0.00000000000000000000,-0.1846153939557734213,1.00000000000000000000,0.00026923076099984833,0.99999994526627311586,-0.0001923076911223638,111.620400452897982290,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00005473372982578,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +137.000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,-0.1846153985074351910,1.00000000000000000000,0.00034615383284023691,0.99999992159763495536,-0.0001923076911223638,80.7672345733193850492,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007840237128675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +138.000000000000000000,0.00000000000000000000,0.45057694831968020388,0.00000000000000000000,-0.1846154041970126669,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,-0.0001923076911223638,12.9784493271676932835,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00010798817424984,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +139.000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,-0.1846154110245059876,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,-0.0001923076911223638,50.7830825286877924895,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014349113985190,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +140.000000000000000000,0.00000000000000000000,-0.5325000416666707536,0.00000000000000000000,-0.2584615786204717546,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,-0.0002692307659782278,49.3752127162588791975,0.99999987500000242501,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00016124262219818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +141.000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,-0.2584615690619809780,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,-0.0002692307659782278,139.260854138820633352,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965591400,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +142.000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,-0.2584615610965724230,1.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,-0.0002692307659782278,142.454117662844737424,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385249617,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +143.000000000000000000,0.00000000000000000000,-0.2867307757358520947,0.00000000000000000000,-0.2584615547242458677,1.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,-0.0002692307659782278,29.6173857593949385602,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007248521058045,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +144.000000000000000000,0.00000000000000000000,-0.2048076946783492779,0.00000000000000000000,-0.2584615499450010900,1.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,-0.0002692307659782278,199.548098072304412653,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00005473372982578,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +145.000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,-0.2584615467588380344,1.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,-0.0002692307659782278,53.3562031698776948474,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00004289940966373,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +146.000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,-0.2584615451657565343,1.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,-0.0002692307659782278,195.322990509523776836,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224963954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +147.000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,-0.2584615451657565343,1.00000000000000000000,0.00003846153705810951,0.99999996301775162521,-0.0002692307659782278,82.2074038633628276784,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00003698224963954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +148.000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,-0.2584615467588380344,1.00000000000000000000,0.00011538461094674560,0.99999995710059208509,-0.0002692307659782278,6.61014719088798141655,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00004289940966373,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +149.000000000000000000,0.00000000000000000000,0.20480769467834933350,0.00000000000000000000,-0.2584615499450010900,1.00000000000000000000,0.00019230768415263250,0.99999994526627311586,-0.0002692307659782278,69.0142497115336084334,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00005473372982578,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +150.000000000000000000,0.00000000000000000000,0.28673077573585209476,0.00000000000000000000,-0.2584615547242458677,1.00000000000000000000,0.00026923075622060400,0.99999992751479460650,-0.0002692307659782278,126.870268612837008959,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007248521058045,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +151.000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,-0.2584615610965724230,1.00000000000000000000,0.00034615382669549426,0.99999990384615689009,-0.0002692307659782278,136.141091477158738598,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385249617,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +152.000000000000000000,0.00000000000000000000,0.45057694831968025939,0.00000000000000000000,-0.2584615690619809780,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,-0.0002692307659782278,106.186916890131996638,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965591400,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +153.000000000000000000,0.00000000000000000000,0.53250004166667075367,0.00000000000000000000,-0.2584615786204717546,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,-0.0002692307659782278,89.5566326308894531393,0.99999987500000242501,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00016124262219818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +154.000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,-0.3323077494026013822,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,-0.0003461538392410105,110.578617712151867635,0.99999987500000253604,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00018491126604658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +155.000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,-0.3323077371131130108,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,-0.0003461538392410105,118.539344826373110208,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014940829908027,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +156.000000000000000000,0.00000000000000000000,-0.3686538599795182169,0.00000000000000000000,-0.3323077268718732657,1.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,-0.0003461538392410105,16.1706651598612474174,0.99999994008875792150,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00011982249475295,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +157.000000000000000000,0.00000000000000000000,-0.2867307757358520392,0.00000000000000000000,-0.3323077186788818693,1.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,-0.0003461538392410105,73.9308919464077121119,0.99999996375739663712,0.00000000000000000000,0.00026923076597822780,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385238248,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +158.000000000000000000,0.00000000000000000000,-0.2048076946783493057,0.00000000000000000000,-0.3323077125341384885,1.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,-0.0003461538392410105,48.4319873266927913846,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007840237128675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +159.000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,-0.3323077084376430123,1.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,-0.0003461538392410105,160.627950998169353624,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006656805078364,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +160.000000000000000000,0.00000000000000000000,-0.0409615384805036841,0.00000000000000000000,-0.3323077063893953853,1.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,-0.0003461538392410105,94.0601261551631893098,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006065089064577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +161.000000000000000000,0.00000000000000000000,0.04096153848050368417,0.00000000000000000000,-0.3323077063893953853,1.00000000000000000000,0.00003846153614777726,0.99999993934911302062,-0.0003461538392410105,196.684627327296112753,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006065089064577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +162.000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,-0.3323077084376430123,1.00000000000000000000,0.00011538460821574884,0.99999993343195370254,-0.0003461538392410105,79.7648886870045430441,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00006656805078364,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +163.000000000000000000,0.00000000000000000000,0.20480769467834933350,0.00000000000000000000,-0.3323077125341384885,1.00000000000000000000,0.00019230767960097126,0.99999992159763495536,-0.0003461538392410105,163.286375944336498378,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00007840237128675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +164.000000000000000000,0.00000000000000000000,0.28673077573585203925,0.00000000000000000000,-0.3323077186788818693,1.00000000000000000000,0.00026923074984827827,0.99999990384615689009,-0.0003461538392410105,159.669024487880307106,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385238248,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +165.000000000000000000,0.00000000000000000000,0.36865385997951821694,0.00000000000000000000,-0.3323077268718732657,1.00000000000000000000,0.00034615381850250414,0.99999988017751961777,-0.0003461538392410105,30.1435086946337236213,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00011982249475295,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +166.000000000000000000,0.00000000000000000000,0.45057694831968025939,0.00000000000000000000,-0.3323077371131130108,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,-0.0003461538392410105,101.639756304593703362,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014940829908027,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +167.000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,-0.3323077494026013822,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,-0.0003461538392410105,139.162562028309935158,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00018491126604658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +168.000000000000000000,0.00000000000000000000,-0.5325000416666708646,0.00000000000000000000,-0.4061539242812273742,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,-0.0004230769104555456,171.671760215347575240,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00021449707230658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +169.000000000000000000,0.00000000000000000000,-0.4505769483196802593,0.00000000000000000000,-0.4061539092607413525,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,-0.0004230769104555456,65.1917813031915045485,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00017899410420341,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +170.000000000000000000,0.00000000000000000000,-0.3686538599795181614,0.00000000000000000000,-0.4061538967436702507,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,-0.0004230769104555456,44.0482096383460373090,0.99999994008875814355,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014940829908027,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +171.000000000000000000,0.00000000000000000000,-0.2867307757358520947,0.00000000000000000000,-0.4061538867300139021,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,-0.0004230769104555456,142.229906921794167828,0.99999996375739674814,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965602769,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +172.000000000000000000,0.00000000000000000000,-0.2048076946783493057,0.00000000000000000000,-0.4061538792197718072,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,-0.0004230769104555456,161.900210325117285492,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00010798817424984,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +173.000000000000000000,0.00000000000000000000,-0.1228846158966773183,0.00000000000000000000,-0.4061538742129440215,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,-0.0004230769104555456,69.7331973979559762710,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385351935,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +174.000000000000000000,0.00000000000000000000,-0.0409615384805036841,0.00000000000000000000,-0.4061538717095300454,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,-0.0004230769104555456,19.2353102423332877890,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009023669315411,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +175.000000000000000000,0.00000000000000000000,0.04096153848050368417,0.00000000000000000000,-0.4061538717095300454,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,-0.0004230769104555456,188.104652284668901529,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009023669315411,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +176.000000000000000000,0.00000000000000000000,0.12288461589667731832,0.00000000000000000000,-0.4061538742129440215,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,-0.0004230769104555456,79.5144039857001985183,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00009615385351935,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +177.000000000000000000,0.00000000000000000000,0.20480769467834936126,0.00000000000000000000,-0.4061538792197718072,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,-0.0004230769104555456,103.550269013166015952,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00010798817424984,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +178.000000000000000000,0.00000000000000000000,0.28673077573585209476,0.00000000000000000000,-0.4061538867300139021,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,-0.0004230769104555456,167.542021341515237509,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965602769,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +179.000000000000000000,0.00000000000000000000,0.36865385997951816143,0.00000000000000000000,-0.4061538967436702507,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,-0.0004230769104555456,135.138023396753254701,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014940829908027,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +180.000000000000000000,0.00000000000000000000,0.45057694831968031490,0.00000000000000000000,-0.4061539092607413525,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,-0.0004230769104555456,147.043224830888959786,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00017899410420341,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +181.000000000000000000,0.00000000000000000000,0.53250004166667086469,0.00000000000000000000,-0.4061539242812273742,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,-0.0004230769104555456,41.8143235710017222572,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00021449707230658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +182.000000000000000000,0.00000000000000000000,-0.5325000416666707536,0.00000000000000000000,-0.4800001041666824286,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,-0.0004999999791666669,108.289594880372661123,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00025000004166031,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +183.000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,-0.4800000864151985902,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,-0.0004999999791666669,139.156879936148612841,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00021449707230658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +184.000000000000000000,0.00000000000000000000,-0.3686538599795182724,0.00000000000000000000,-0.4800000716222961316,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,-0.0004999999791666669,45.7100036660465463000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00018491126604658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +185.000000000000000000,0.00000000000000000000,-0.2867307757358520392,0.00000000000000000000,-0.4800000597879746089,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,-0.0004999999791666669,34.9909849080701746970,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00016124262219818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +186.000000000000000000,0.00000000000000000000,-0.2048076946783492502,0.00000000000000000000,-0.4800000509122337999,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,-0.0004999999791666669,196.433668582801146840,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014349113985190,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +187.000000000000000000,0.00000000000000000000,-0.1228846158966773044,0.00000000000000000000,-0.4800000449950734826,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,-0.0004999999791666669,103.327178373776177977,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00013165681866667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +188.000000000000000000,0.00000000000000000000,-0.0409615384805036911,0.00000000000000000000,-0.4800000420364933240,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,-0.0004999999791666669,52.1658353628976811933,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965807405,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +189.000000000000000000,0.00000000000000000000,0.04096153848050369111,0.00000000000000000000,-0.4800000420364933240,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,-0.0004999999791666669,199.250739859242628426,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00012573965807405,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +190.000000000000000000,0.00000000000000000000,0.12288461589667730444,0.00000000000000000000,-0.4800000449950734826,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,-0.0004999999791666669,193.083870316176643200,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00013165681866667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +191.000000000000000000,0.00000000000000000000,0.20480769467834930575,0.00000000000000000000,-0.4800000509122337999,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,-0.0004999999791666669,111.658689591954157549,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00014349113985190,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +192.000000000000000000,0.00000000000000000000,0.28673077573585203925,0.00000000000000000000,-0.4800000597879746089,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,-0.0004999999791666669,176.527269179124232323,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00016124262219818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +193.000000000000000000,0.00000000000000000000,0.36865385997951827246,0.00000000000000000000,-0.4800000716222961316,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,-0.0004999999791666669,37.7414221963243150526,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00018491126604658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +194.000000000000000000,0.00000000000000000000,0.45057694831968025939,0.00000000000000000000,-0.4800000864151985902,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,-0.0004999999791666669,55.7742703835885649255,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00021449707230658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +195.000000000000000000,0.00000000000000000000,0.53250004166667075367,0.00000000000000000000,-0.4800001041666824286,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,-0.0004999999791666669,140.071565783599282895,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00025000004166031,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +196.000000000000000000,0.00000000000000000000,-0.5325000416666707536,0.00000000000000000000,0.48000010416668242863,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,145.191135244721323260,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00025000004166031,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +197.000000000000000000,0.00000000000000000000,-0.4505769483196802038,0.00000000000000000000,0.48000008641519859020,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,169.332227848780405565,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00021449707230658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +198.000000000000000000,0.00000000000000000000,-0.3686538599795182724,0.00000000000000000000,0.48000007162229613166,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,179.422050849400022798,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00018491126604658,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +199.000000000000000000,0.00000000000000000000,-0.2867307757358520392,0.00000000000000000000,0.48000005978797460892,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,171.264857978388874926,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00016124262219818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 diff --git a/Intern/rayx-core/tests/input/MatrixSource_seeded.correct.csv b/Intern/rayx-core/tests/input/MatrixSource_seeded.correct.csv index 4c062f70..729b1074 100644 --- a/Intern/rayx-core/tests/input/MatrixSource_seeded.correct.csv +++ b/Intern/rayx-core/tests/input/MatrixSource_seeded.correct.csv @@ -1,201 +1,201 @@ -Ray-ID ,Event-ID ,X-position ,Y-position ,Z-position ,Event-type ,X-direction ,Y-direction ,Z-direction ,Energy ,Stokes0 ,Stokes1 ,Stokes2 ,Stokes3 ,pathLength ,order ,lastElement ,lightSourceIndex -0.00000000000000000000,0.00000000000000000000,-0.5387730364695781926,0.00000000000000000000,0.48627309975371429962,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1012.54624169685496326,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -1.00000000000000000000,0.00000000000000000000,-0.4315082647603292742,0.00000000000000000000,0.45746436693115022364,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,954.928773650998891753,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -2.00000000000000000000,0.00000000000000000000,-0.3606233002491213146,0.00000000000000000000,0.46840037303565262849,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,976.800786771337698155,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -3.00000000000000000000,0.00000000000000000000,-0.2840745856529754420,0.00000000000000000000,0.47506713487767548986,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,990.134311010946817077,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -4.00000000000000000000,0.00000000000000000000,-0.2114227209415486807,0.00000000000000000000,0.49719912073581812306,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,0.00049999997916666690,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1034.39828457156431795,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -5.00000000000000000000,0.00000000000000000000,-0.1268539098702317069,0.00000000000000000000,0.49720032035199840381,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,0.00049999997916666690,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1034.40068380402499315,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -6.00000000000000000000,0.00000000000000000000,-0.0426612169002327165,0.00000000000000000000,0.50209586333973688088,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,0.00049999997916666690,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1044.19177018746358953,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -7.00000000000000000000,0.00000000000000000000,0.03955316867655773310,0.00000000000000000000,0.46169123305494774722,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,0.00049999997916666690,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,963.382506250832761907,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -8.00000000000000000000,0.00000000000000000000,0.12171790422014708288,0.00000000000000000000,0.47494429396424486800,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,0.00049999997916666690,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,989.888629173848812570,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -9.00000000000000000000,0.00000000000000000000,0.20080629888928178128,0.00000000000000000000,0.46959642092956410674,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,0.00049999997916666690,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,979.192882658831308617,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -10.0000000000000000000,0.00000000000000000000,0.29963811646545362998,0.00000000000000000000,0.50397083771581585587,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,0.00049999997916666690,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1047.94171909586930269,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -11.0000000000000000000,0.00000000000000000000,0.35238774923302068620,0.00000000000000000000,0.45650457589462684060,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,0.00049999997916666690,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,953.009191497969595729,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -12.0000000000000000000,0.00000000000000000000,0.43651206670285430666,0.00000000000000000000,0.46337795171425821827,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,0.00049999997916666690,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,966.755943710013639247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -13.0000000000000000000,0.00000000000000000000,0.54688308727095458205,0.00000000000000000000,0.49438315156884721224,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,0.00049999997916666690,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1028.76634600295824384,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -14.0000000000000000000,0.00000000000000000000,-0.5484087946386686507,0.00000000000000000000,0.41961517816004184622,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,0.00042307691045554557,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1031.81772461437026322,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -15.0000000000000000000,0.00000000000000000000,-0.4639713736978018920,0.00000000000000000000,0.41954833583762446425,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,0.00042307691045554557,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1031.65973366576145053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -16.0000000000000000000,0.00000000000000000000,-0.3754300903682085133,0.00000000000000000000,0.41443595676716776798,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,0.00042307691045554557,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1019.57592822964829792,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -17.0000000000000000000,0.00000000000000000000,-0.2860642562730613125,0.00000000000000000000,0.40510649892762579105,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,0.00042307691045554557,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,997.524481769248154705,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -18.0000000000000000000,0.00000000000000000000,-0.2061164442880983049,0.00000000000000000000,0.40903312855075596443,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,0.00042307691045554557,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1006.80560660988817289,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -19.0000000000000000000,0.00000000000000000000,-0.1252935104448915648,0.00000000000000000000,0.41498648810299038069,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,0.00042307691045554557,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1020.87718415313941022,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -20.0000000000000000000,0.00000000000000000000,-0.0405313350266790980,0.00000000000000000000,0.40142163343394526853,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,0.00042307691045554557,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,988.814799433445728027,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -21.0000000000000000000,0.00000000000000000000,0.04234810054875542961,0.00000000000000000000,0.42140605537407649361,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,0.00042307691045554557,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1036.05070724655047342,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -22.0000000000000000000,0.00000000000000000000,0.12528294689615207535,0.00000000000000000000,0.41494775508854869761,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,0.00042307691045554557,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1020.78563338900062262,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -23.0000000000000000000,0.00000000000000000000,0.20737765922662326767,0.00000000000000000000,0.41180780159816310348,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,0.00042307691045554557,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1013.36392491759136191,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -24.0000000000000000000,0.00000000000000000000,0.28791350679211474838,0.00000000000000000000,0.40801246423748555036,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,0.00042307691045554557,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1004.39312725200636577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -25.0000000000000000000,0.00000000000000000000,0.35878238403888523810,0.00000000000000000000,0.39408875852208802292,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,0.00042307691045554557,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,971.482549124721458611,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -26.0000000000000000000,0.00000000000000000000,0.46328305823544563279,0.00000000000000000000,0.41886002031366592612,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,0.00042307691045554557,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1030.03280601514234149,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -27.0000000000000000000,0.00000000000000000000,0.53178831979086194081,0.00000000000000000000,0.40555169801759538561,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,0.00042307691045554557,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,998.576770558750354211,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -28.0000000000000000000,0.00000000000000000000,-0.5278793126446065242,0.00000000000000000000,0.32910878289549722053,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,0.00034615383924101053,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,990.758725928409603511,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -29.0000000000000000000,0.00000000000000000000,-0.4697655861003967037,0.00000000000000000000,0.34800753275639656481,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,0.00034615383924101053,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1045.35511550576438821,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -30.0000000000000000000,0.00000000000000000000,-0.3649311534443439586,0.00000000000000000000,0.32858502011366702566,1.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,0.00034615383924101053,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,989.245633417349722549,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -31.0000000000000000000,0.00000000000000000000,-0.2956012802763716140,0.00000000000000000000,0.34371265368142528418,1.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,0.00034615383924101053,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1032.94768681917707908,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -32.0000000000000000000,0.00000000000000000000,-0.2131720871987957122,0.00000000000000000000,0.34736361976508761673,1.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,0.00034615383924101053,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1043.49492238261223064,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -33.0000000000000000000,0.00000000000000000000,-0.1177051674373130740,0.00000000000000000000,0.31676936240445735526,1.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,0.00034615383924101053,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,955.111510464626803695,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -34.0000000000000000000,0.00000000000000000000,-0.0391706460358167835,0.00000000000000000000,0.31618967373947182153,1.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,0.00034615383924101053,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,953.436854287891833337,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -35.0000000000000000000,0.00000000000000000000,0.03977539482841409290,0.00000000000000000000,0.32163241309157691860,1.00000000000000000000,0.00003846153614777726,0.99999993934911302062,0.00034615383924101053,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,969.160323841310741954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -36.0000000000000000000,0.00000000000000000000,0.12513907239528249126,0.00000000000000000000,0.33907107821860071883,1.00000000000000000000,0.00011538460821574884,0.99999993343195370254,0.00034615383924101053,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1019.53869076990065423,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -37.0000000000000000000,0.00000000000000000000,0.21254476944746891753,0.00000000000000000000,0.34623444776063938554,1.00000000000000000000,0.00019230767960097126,0.99999992159763495536,0.00034615383924101053,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1040.23286986017274102,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -38.0000000000000000000,0.00000000000000000000,0.28177065559640585012,0.00000000000000000000,0.32593042102497882250,1.00000000000000000000,0.00026923074984827827,0.99999990384615689009,0.00034615383924101053,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,981.576791452433894846,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -39.0000000000000000000,0.00000000000000000000,0.37072550456957287234,0.00000000000000000000,0.33437937158604275067,1.00000000000000000000,0.00034615381850250414,0.99999988017751961777,0.00034615383924101053,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1005.98487133850244390,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -40.0000000000000000000,0.00000000000000000000,0.46656763946999518788,0.00000000000000000000,0.34539103078532451540,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,0.00034615383924101053,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1037.79633188282673472,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -41.0000000000000000000,0.00000000000000000000,0.53274119615986526010,0.00000000000000000000,0.33247470252689909075,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,0.00034615383924101053,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.48249394664708233,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -42.0000000000000000000,0.00000000000000000000,-0.5557806174521595643,0.00000000000000000000,0.27099727409940121969,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,0.00026923076597822786,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1046.56131644114520895,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -43.0000000000000000000,0.00000000000000000000,-0.4332595456462873806,0.00000000000000000000,0.24744140312934365111,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,0.00026923076597822786,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,959.068080352508331998,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -44.0000000000000000000,0.00000000000000000000,-0.3770037840476019863,0.00000000000000000000,0.26495594676947098466,1.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,0.00026923076597822786,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1024.12210037317618116,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -45.0000000000000000000,0.00000000000000000000,-0.2823551757702407738,0.00000000000000000000,0.25408595460005140020,1.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,0.00026923076597822786,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,983.747843256147348256,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -46.0000000000000000000,0.00000000000000000000,-0.2084286356224638314,0.00000000000000000000,0.26353086742049075530,1.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,0.00026923076597822786,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1018.82894844158943215,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -47.0000000000000000000,0.00000000000000000000,-0.1226530618081831669,0.00000000000000000000,0.25792125387143172154,1.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,0.00026923076597822786,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,997.993240721942470372,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -48.0000000000000000000,0.00000000000000000000,-0.0407818835675829854,0.00000000000000000000,0.25720396074461610025,1.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,0.00026923076597822786,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,995.329009075869635125,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -49.0000000000000000000,0.00000000000000000000,0.04217363671100634453,0.00000000000000000000,0.26694623298637176755,1.00000000000000000000,0.00003846153705810951,0.99999996301775162521,0.00026923076597822786,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1031.51459212525787734,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -50.0000000000000000000,0.00000000000000000000,0.11746633169532724738,0.00000000000000000000,0.24581888328883261252,1.00000000000000000000,0.00011538461094674560,0.99999995710059208509,0.00026923076597822786,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,953.041578014947617703,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -51.0000000000000000000,0.00000000000000000000,0.19951667872828965366,0.00000000000000000000,0.25105412739028420965,1.00000000000000000000,0.00019230768415263250,0.99999994526627311586,0.00026923076597822786,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,972.486770626682641704,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -52.0000000000000000000,0.00000000000000000000,0.27489811170571726295,0.00000000000000000000,0.24662889026526446656,1.00000000000000000000,0.00026923075622060400,0.99999992751479460650,0.00026923076597822786,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,956.050175392326877954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -53.0000000000000000000,0.00000000000000000000,0.35498675883996821944,0.00000000000000000000,0.24783159307446572805,1.00000000000000000000,0.00034615382669549426,0.99999990384615689009,0.00026923076597822786,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,960.517357309041813095,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -54.0000000000000000000,0.00000000000000000000,0.44643502598738660225,0.00000000000000000000,0.25582580016275097145,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,0.00026923076597822786,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,990.210126852815619713,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -55.0000000000000000000,0.00000000000000000000,0.51140632809399644287,0.00000000000000000000,0.24710342441057336904,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,0.00026923076597822786,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,957.812730810481525622,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -56.0000000000000000000,0.00000000000000000000,-0.5530754184086756897,0.00000000000000000000,0.19252901789102649932,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,0.00019230769112236383,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1041.15089945068802990,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -57.0000000000000000000,0.00000000000000000000,-0.4634392125456729960,0.00000000000000000000,0.19046188818258663610,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,0.00019230769112236383,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1030.40182490054644404,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -58.0000000000000000000,0.00000000000000000000,-0.3843959929693127053,0.00000000000000000000,0.19336102822867470840,1.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,0.00019230769112236383,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1045.47735323312576838,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -59.0000000000000000000,0.00000000000000000000,-0.2914334209139534670,0.00000000000000000000,0.18797442630783398054,1.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,0.00019230769112236383,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1017.46702307210625804,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -60.0000000000000000000,0.00000000000000000000,-0.2069485160950387814,0.00000000000000000000,0.18675621199830280683,1.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,0.00019230769112236383,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1011.13230862349894323,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -61.0000000000000000000,0.00000000000000000000,-0.1255228963109913109,0.00000000000000000000,0.18901252235401536094,1.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,0.00019230769112236383,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1022.86512254552178546,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -62.0000000000000000000,0.00000000000000000000,-0.0396971634428423050,0.00000000000000000000,0.17829351186048308930,1.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,0.00019230769112236383,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,967.126267635595809224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -63.0000000000000000000,0.00000000000000000000,0.04151248722921495326,0.00000000000000000000,0.18737013090647539059,1.00000000000000000000,0.00003846153774085871,0.99999998076923080070,0.00019230769112236383,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1014.32468696567332244,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -64.0000000000000000000,0.00000000000000000000,0.12541229462116643134,0.00000000000000000000,0.18882818620162578060,1.00000000000000000000,0.00011538461299499319,0.99999997485207114955,0.00019230769112236383,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1021.90657454718780172,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -65.0000000000000000000,0.00000000000000000000,0.20398661606217607933,0.00000000000000000000,0.18379431191067119311,1.00000000000000000000,0.00019230768756637849,0.99999996301775195828,0.00019230769112236383,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,995.730428072881977641,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -66.0000000000000000000,0.00000000000000000000,0.29639820069005051728,0.00000000000000000000,0.19152069766303314590,1.00000000000000000000,0.00026923076099984833,0.99999994526627311586,0.00019230769112236383,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1035.90763423280441202,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -67.0000000000000000000,0.00000000000000000000,0.35819319476662597745,0.00000000000000000000,0.17880391764590788938,1.00000000000000000000,0.00034615383284023691,0.99999992159763495536,0.00019230769112236383,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,969.780377736164155066,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -68.0000000000000000000,0.00000000000000000000,0.46857672985752818473,0.00000000000000000000,0.19279712342279192727,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,0.00019230769112236383,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1042.54504822446142497,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -69.0000000000000000000,0.00000000000000000000,0.50815569288434048189,0.00000000000000000000,0.17525219944882086675,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,0.00019230769112236383,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,951.311442997474614458,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -70.0000000000000000000,0.00000000000000000000,-0.5188878019378441175,0.00000000000000000000,0.10762795946827592719,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,0.00011538461512858444,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,972.775650883583807626,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -71.0000000000000000000,0.00000000000000000000,-0.4633235933051890742,0.00000000000000000000,0.11424559945033134489,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,0.00011538461512858444,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1030.12853085532651675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -72.0000000000000000000,0.00000000000000000000,-0.3857704025809524095,0.00000000000000000000,0.11647475253386861682,1.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,0.00011538461512858444,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1049.44785762218452873,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -73.0000000000000000000,0.00000000000000000000,-0.2782375831981779845,0.00000000000000000000,0.10712929574400131826,1.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,0.00011538461512858444,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,968.453898596947283294,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -74.0000000000000000000,0.00000000000000000000,-0.2008296688132032992,0.00000000000000000000,0.10838241787049238129,1.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,0.00011538461512858444,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,979.314290383968682363,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -75.0000000000000000000,0.00000000000000000000,-0.1202422255450762839,0.00000000000000000000,0.10812684168019466579,1.00000000000000000000,-0.0001153846143604915,0.99999998668639045185,0.00011538461512858444,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,977.099296729806724215,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -76.0000000000000000000,0.00000000000000000000,-0.0399181910094093400,0.00000000000000000000,0.10763918893869088566,1.00000000000000000000,-0.0000384615381960248,0.99999999260355021402,0.00011538461512858444,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,972.872972960729271107,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -77.0000000000000000000,0.00000000000000000000,0.04259982830523007663,0.00000000000000000000,0.11568410086383883184,1.00000000000000000000,0.00003846153819602484,0.99999999260355021402,0.00011538461512858444,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1042.59554313338821884,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -78.0000000000000000000,0.00000000000000000000,0.12451770369038070440,0.00000000000000000000,0.11240231985396009761,1.00000000000000000000,0.00011538461436049158,0.99999998668639045185,0.00011538461512858444,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1014.15344098466118794,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -79.0000000000000000000,0.00000000000000000000,0.21219482833484110129,0.00000000000000000000,0.11520151365576819513,1.00000000000000000000,0.00019230768984220914,0.99999997485207114955,0.00011538461512858444,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1038.41312065416195764,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -80.0000000000000000000,0.00000000000000000000,0.27695491416125889161,0.00000000000000000000,0.10657958043338394693,1.00000000000000000000,0.00026923076418601120,0.99999995710059208509,0.00011538461512858444,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,963.689699227692017302,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -81.0000000000000000000,0.00000000000000000000,0.36438584778103316752,0.00000000000000000000,0.10934656742657544725,1.00000000000000000000,0.00034615383693673202,0.99999993343195370254,0.00011538461512858444,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,987.670253221896473405,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -82.0000000000000000000,0.00000000000000000000,0.45773126309666223310,0.00000000000000000000,0.11272041843210119094,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,0.00011538461512858444,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1016.91029533466780776,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -83.0000000000000000000,0.00000000000000000000,0.55432212593365448594,0.00000000000000000000,0.11580511153662056966,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,0.00011538461512858444,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1043.64430229982349374,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -84.0000000000000000000,0.00000000000000000000,-0.5419509263578902169,0.00000000000000000000,0.03765007291047852561,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,0.00003846153845205580,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1018.90189592365118187,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -85.0000000000000000000,0.00000000000000000000,-0.4579730389630555786,0.00000000000000000000,0.03759545228129676508,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,0.00003846153845205580,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1017.48175956457532720,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -86.0000000000000000000,0.00000000000000000000,-0.3607059536193307214,0.00000000000000000000,0.03603997852156198139,1.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,0.00003846153845205580,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,977.039441801499947359,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -87.0000000000000000000,0.00000000000000000000,-0.2830273052709604830,0.00000000000000000000,0.03639401112006577371,1.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,0.00003846153845205580,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,986.244289364867768199,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -88.0000000000000000000,0.00000000000000000000,-0.1973612956508831728,0.00000000000000000000,0.03543379783783217468,1.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,0.00003846153845205580,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,961.278744020639237533,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -89.0000000000000000000,0.00000000000000000000,-0.1232052129471131324,0.00000000000000000000,0.03702994288184152660,1.00000000000000000000,-0.0001153846150432407,0.99999999260355021402,0.00003846153845205580,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1002.77851517511396650,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -90.0000000000000000000,0.00000000000000000000,-0.0424246375594649408,0.00000000000000000000,0.03838617605053346037,1.00000000000000000000,-0.0000384615384236079,0.99999999852070997619,0.00003846153845205580,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1038.04057756979818805,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -91.0000000000000000000,0.00000000000000000000,0.04014136623359557815,0.00000000000000000000,0.03610290472297528197,1.00000000000000000000,0.00003846153842360791,0.99999999852070997619,0.00003846153845205580,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,978.675523038649089357,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -92.0000000000000000000,0.00000000000000000000,0.11987555769005356354,0.00000000000000000000,0.03592005779314496466,1.00000000000000000000,0.00011538461504324078,0.99999999260355021402,0.00003846153845205580,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,973.921502861888711777,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -93.0000000000000000000,0.00000000000000000000,0.20362928693761644938,0.00000000000000000000,0.03668739610352377694,1.00000000000000000000,0.00019230769098012445,0.99999998076923080070,0.00003846153845205580,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,993.872298936656648038,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -94.0000000000000000000,0.00000000000000000000,0.27943550518851684172,0.00000000000000000000,0.03588089681612195019,1.00000000000000000000,0.00026923076577909266,0.99999996301775162521,0.00003846153845205580,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,972.903317459039271852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -95.0000000000000000000,0.00000000000000000000,0.36886862776434303778,0.00000000000000000000,0.03694694233401190491,1.00000000000000000000,0.00034615383898497955,0.99999993934911302062,0.00003846153845205580,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.62050093101174752,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -96.0000000000000000000,0.00000000000000000000,0.44961517485157920237,0.00000000000000000000,0.03683564642993927829,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,0.00003846153845205580,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,997.726807424410026214,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -97.0000000000000000000,0.00000000000000000000,0.53612299092400717004,0.00000000000000000000,0.03720177016589487628,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,0.00003846153845205580,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1007.24602456160266683,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -98.0000000000000000000,0.00000000000000000000,-0.5562290873654824885,0.00000000000000000000,-0.0387483930342905416,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,-0.0000384615384520558,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1047.45821914980410838,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -99.0000000000000000000,0.00000000000000000000,-0.4671661581117621531,0.00000000000000000000,-0.0384311904110687732,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,-0.0000384615384520558,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1039.21095094400448033,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -100.000000000000000000,0.00000000000000000000,-0.3848736195733291065,0.00000000000000000000,-0.0387252747936235111,1.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,-0.0000384615384520558,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1046.85714489231327206,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -101.000000000000000000,0.00000000000000000000,-0.2830581877053078843,0.00000000000000000000,-0.0363984228964566031,1.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,-0.0000384615384520558,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,986.358995551057660122,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -102.000000000000000000,0.00000000000000000000,-0.2083777720035789038,0.00000000000000000000,-0.0376370931230382357,1.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,-0.0000384615384520558,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1018.56442145012022137,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -103.000000000000000000,0.00000000000000000000,-0.1227857232810207616,0.00000000000000000000,-0.0368901129927648591,1.00000000000000000000,-0.0001153846150432407,0.99999999260355021402,-0.0000384615384520558,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.142938058223990083,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -104.000000000000000000,0.00000000000000000000,-0.0393939750956869144,0.00000000000000000000,-0.0353555135845138243,1.00000000000000000000,-0.0000384615384236079,0.99999999852070997619,-0.0000384615384520558,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,959.243353433859965662,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -105.000000000000000000,0.00000000000000000000,0.04192579913549480258,0.00000000000000000000,-0.0378873376261943603,1.00000000000000000000,0.00003846153842360791,0.99999999852070997619,-0.0000384615384520558,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1025.07077853378359577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -106.000000000000000000,0.00000000000000000000,0.12391865911007758638,0.00000000000000000000,-0.0372677582701413170,1.00000000000000000000,0.00011538461504324078,0.99999999260355021402,-0.0000384615384520558,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1008.96171527243279797,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -107.000000000000000000,0.00000000000000000000,0.19989324962672178065,0.00000000000000000000,-0.0359401886363708358,1.00000000000000000000,0.00019230769098012445,0.99999998076923080070,-0.0000384615384520558,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,974.444904785890344101,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -108.000000000000000000,0.00000000000000000000,0.29403236393330939302,0.00000000000000000000,-0.0379661623773123735,1.00000000000000000000,0.00026923076577909266,0.99999996301775162521,-0.0000384615384520558,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1027.12022206335723240,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -109.000000000000000000,0.00000000000000000000,0.38329686358966758019,0.00000000000000000000,-0.0385500796807426715,1.00000000000000000000,0.00034615383898497955,0.99999993934911302062,-0.0000384615384520558,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1042.30207195628804583,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -110.000000000000000000,0.00000000000000000000,0.45947207964870923069,0.00000000000000000000,-0.0377317287113979257,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,-0.0000384615384520558,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1021.02494674807883257,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -111.000000000000000000,0.00000000000000000000,0.54943897879719949539,0.00000000000000000000,-0.0382260769685557472,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,-0.0000384615384520558,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1033.87800143735125857,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -112.000000000000000000,0.00000000000000000000,-0.5110151574692605169,0.00000000000000000000,-0.1058111952763801655,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,-0.0001153846151285844,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,957.030361185549509173,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -113.000000000000000000,0.00000000000000000000,-0.4375410852965807007,0.00000000000000000000,-0.1072140061161002827,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,-0.0001153846151285844,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,969.188055156767518383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -114.000000000000000000,0.00000000000000000000,-0.3640360372830070967,0.00000000000000000000,-0.1092299639243873299,1.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,-0.0001153846151285844,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,986.659689534023868873,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -115.000000000000000000,0.00000000000000000000,-0.2767299135054704928,0.00000000000000000000,-0.1064831515793103339,1.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,-0.0001153846151285844,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,962.853982490533098825,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -116.000000000000000000,0.00000000000000000000,-0.1989678468804907118,0.00000000000000000000,-0.1072653246990218772,1.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,-0.0001153846151285844,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,969.632816209741690727,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -117.000000000000000000,0.00000000000000000000,-0.1265011152390264625,0.00000000000000000000,-0.1143857314158090304,1.00000000000000000000,-0.0001153846143604915,0.99999998668639045185,-0.0001153846151285844,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1031.34300789216081284,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -118.000000000000000000,0.00000000000000000000,-0.0394516961764171461,0.00000000000000000000,-0.1062397044331585271,1.00000000000000000000,-0.0000384615381960248,0.99999999260355021402,-0.0001153846151285844,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,960.744107219202419400,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -119.000000000000000000,0.00000000000000000000,0.04081022216522532664,0.00000000000000000000,-0.1103152824186747898,1.00000000000000000000,0.00003846153819602484,0.99999999260355021402,-0.0001153846151285844,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,996.065783172053102134,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -120.000000000000000000,0.00000000000000000000,0.11933722941635908909,0.00000000000000000000,-0.1072218455454530816,1.00000000000000000000,0.00011538461436049158,0.99999998668639045185,-0.0001153846151285844,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,969.255996877975803727,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -121.000000000000000000,0.00000000000000000000,0.19719055412745098432,0.00000000000000000000,-0.1061989490358927479,1.00000000000000000000,0.00019230768984220914,0.99999997485207114955,-0.0001153846151285844,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,960.390893775448489577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -122.000000000000000000,0.00000000000000000000,0.29163068243960604819,0.00000000000000000000,-0.1128691955137149649,1.00000000000000000000,0.00026923076418601120,0.99999995710059208509,-0.0001153846151285844,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1018.19969671151500278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -123.000000000000000000,0.00000000000000000000,0.38215206320044836640,0.00000000000000000000,-0.1152686393775947809,1.00000000000000000000,0.00034615383693673202,0.99999993343195370254,-0.0001153846151285844,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1038.99487691128342703,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -124.000000000000000000,0.00000000000000000000,0.46208738440286967197,0.00000000000000000000,-0.1139084515563264649,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,-0.0001153846151285844,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1027.20658243413367927,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -125.000000000000000000,0.00000000000000000000,0.53614465219669282802,0.00000000000000000000,-0.1116103097116146469,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,-0.0001153846151285844,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1007.28935306910295821,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -126.000000000000000000,0.00000000000000000000,-0.5165993019461145863,0.00000000000000000000,-0.1784997415710051771,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,-0.0001923076911223638,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,968.198662136920688681,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -127.000000000000000000,0.00000000000000000000,-0.4353152688955023164,0.00000000000000000000,-0.1776782768935550593,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,-0.0001923076911223638,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,963.927045787850943270,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -128.000000000000000000,0.00000000000000000000,-0.3857209022907011619,0.00000000000000000000,-0.1940970889865526460,1.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,-0.0001923076911223638,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1049.30486919768236475,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -129.000000000000000000,0.00000000000000000000,-0.2864414253349025774,0.00000000000000000000,-0.1844087150929076823,1.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,-0.0001923076911223638,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,998.925324640203712078,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -130.000000000000000000,0.00000000000000000000,-0.2063959446691524535,0.00000000000000000000,-0.1862036405621988743,1.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,-0.0001923076911223638,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1008.25893713804759954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -131.000000000000000000,0.00000000000000000000,-0.1260910642998142316,0.00000000000000000000,-0.1899594690158282195,1.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,-0.0001923076911223638,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1027.78924521729913976,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -132.000000000000000000,0.00000000000000000000,-0.0424235947522043702,0.00000000000000000000,-0.1919256685787037453,1.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,-0.0001923076911223638,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1038.01348300727136120,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -133.000000000000000000,0.00000000000000000000,0.04158609551071744403,0.00000000000000000000,-0.1877381723186156703,1.00000000000000000000,0.00003846153774085871,0.99999998076923080070,-0.0001923076911223638,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1016.23850232059851350,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -134.000000000000000000,0.00000000000000000000,0.11777411926471503811,0.00000000000000000000,-0.1760978937556942069,1.00000000000000000000,0.00011538461299499319,0.99999997485207114955,-0.0001923076911223638,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,955.709053420321197336,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -135.000000000000000000,0.00000000000000000000,0.20820763827111707366,0.00000000000000000000,-0.1880153341976636971,1.00000000000000000000,0.00019230768756637849,0.99999996301775195828,-0.0001923076911223638,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1017.67974410053170686,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -136.000000000000000000,0.00000000000000000000,0.28622487428337456405,0.00000000000000000000,-0.1842540357666122008,1.00000000000000000000,0.00026923076099984833,0.99999994526627311586,-0.0001923076911223638,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,998.120992138509564028,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -137.000000000000000000,0.00000000000000000000,0.36162628038646837946,0.00000000000000000000,-0.1807111874963099606,1.00000000000000000000,0.00034615383284023691,0.99999992159763495536,-0.0001923076911223638,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,979.698181019385174295,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -138.000000000000000000,0.00000000000000000000,0.45634646534559597519,0.00000000000000000000,-0.1872379120466295676,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,-0.0001923076911223638,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1013.63714889023697196,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -139.000000000000000000,0.00000000000000000000,0.50891093546187726737,0.00000000000000000000,-0.1755426773789422190,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,-0.0001923076911223638,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,952.821928243415527504,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -140.000000000000000000,0.00000000000000000000,-0.5093776748522762520,0.00000000000000000000,-0.2460110725931239916,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,-0.0002692307659782278,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,953.755424010939691470,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -141.000000000000000000,0.00000000000000000000,-0.4610784671311338178,0.00000000000000000000,-0.2651443541210096177,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,-0.0002692307659782278,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1024.82189911591649433,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -142.000000000000000000,0.00000000000000000000,-0.3687491041817552162,0.00000000000000000000,-0.2585356399238037949,1.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,-0.0002692307659782278,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.27524608689304841,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -143.000000000000000000,0.00000000000000000000,-0.2920917443747614306,0.00000000000000000000,-0.2638225235574506721,1.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,-0.0002692307659782278,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1019.91224267767029232,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -144.000000000000000000,0.00000000000000000000,-0.2089453775998306173,0.00000000000000000000,-0.2642543062107429174,1.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,-0.0002692307659782278,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1021.51600683784499778,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -145.000000000000000000,0.00000000000000000000,-0.1282282280461522760,0.00000000000000000000,-0.2709299754365384615,1.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,-0.0002692307659782278,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1046.31134997606363867,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -146.000000000000000000,0.00000000000000000000,-0.0405401372088698835,0.00000000000000000000,-0.2555117361923200935,1.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,-0.0002692307659782278,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,989.043603519979683369,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -147.000000000000000000,0.00000000000000000000,0.04095123455543604046,0.00000000000000000000,-0.2583894176885224713,1.00000000000000000000,0.00003846153705810951,0.99999996301775162521,-0.0002692307659782278,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.732134920715338921,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -148.000000000000000000,0.00000000000000000000,0.12805986104381544832,0.00000000000000000000,-0.2705371190873887554,1.00000000000000000000,0.00011538461094674560,0.99999995710059208509,-0.0002692307659782278,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1044.85216923302232316,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -149.000000000000000000,0.00000000000000000000,0.20906449352578948541,0.00000000000000000000,-0.2644210685121423654,1.00000000000000000000,0.00019230768415263250,0.99999994526627311586,-0.0002692307659782278,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1022.13540967909727896,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -150.000000000000000000,0.00000000000000000000,0.27573900173887605502,0.00000000000000000000,-0.2474697803288993247,1.00000000000000000000,0.00026923075622060400,0.99999992751479460650,-0.0002692307659782278,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,959.173481380702696696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -151.000000000000000000,0.00000000000000000000,0.37766902569121280075,0.00000000000000000000,-0.2654733569595582598,1.00000000000000000000,0.00034615382669549426,0.99999990384615689009,-0.0002692307659782278,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1026.04390967386007105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -152.000000000000000000,0.00000000000000000000,0.46560062786059347450,0.00000000000000000000,-0.2680220929224101933,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,-0.0002692307659782278,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1035.51064336453396208,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -153.000000000000000000,0.00000000000000000000,0.53302740372979684480,0.00000000000000000000,-0.2587455428270017954,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,-0.0002692307659782278,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1001.05488545104708464,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -154.000000000000000000,0.00000000000000000000,-0.5082175167712037477,0.00000000000000000000,-0.3154967692569144999,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,-0.0003461538392410105,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,951.435130187195454709,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -155.000000000000000000,0.00000000000000000000,-0.4614899950551638041,0.00000000000000000000,-0.3412365941560489002,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,-0.0003461538392410105,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1025.79462582524024583,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -156.000000000000000000,0.00000000000000000000,-0.3626953215533518237,0.00000000000000000000,-0.3263491880887234297,1.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,-0.0003461538392410105,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,982.786562994077712573,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -157.000000000000000000,0.00000000000000000000,-0.2796871705442759981,0.00000000000000000000,-0.3232516543900293415,1.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,-0.0003461538392410105,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,973.838132130257804419,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -158.000000000000000000,0.00000000000000000000,-0.2098531265040638749,0.00000000000000000000,-0.3413894902391358399,1.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,-0.0003461538392410105,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1026.23632562964576209,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -159.000000000000000000,0.00000000000000000000,-0.1202513503105780701,0.00000000000000000000,-0.3244079113462917662,1.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,-0.0003461538392410105,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,977.178430070611739211,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -160.000000000000000000,0.00000000000000000000,-0.0414700648859237658,0.00000000000000000000,-0.3368844442221031187,1.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,-0.0003461538392410105,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1013.22174798720004673,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -161.000000000000000000,0.00000000000000000000,0.04045266991164696290,0.00000000000000000000,-0.3277278890856339388,1.00000000000000000000,0.00003846153614777726,0.99999993934911302062,-0.0003461538392410105,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,986.769477064693205647,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -162.000000000000000000,0.00000000000000000000,0.12134388847713499515,0.00000000000000000000,-0.3276855259841459644,1.00000000000000000000,0.00011538460821574884,0.99999993343195370254,-0.0003461538392410105,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,986.647094769061595798,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -163.000000000000000000,0.00000000000000000000,0.20411972004592765506,0.00000000000000000000,-0.3310693581386857098,1.00000000000000000000,0.00019230767960097126,0.99999992159763495536,-0.0003461538392410105,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,996.422610077397393979,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -164.000000000000000000,0.00000000000000000000,0.29776143610491695445,0.00000000000000000000,-0.3464899970340372115,1.00000000000000000000,0.00026923074984827827,0.99999990384615689009,-0.0003461538392410105,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1040.97112333139853035,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -165.000000000000000000,0.00000000000000000000,0.35704723470075883096,0.00000000000000000000,-0.3207011008977465049,1.00000000000000000000,0.00034615381850250414,0.99999988017751961777,-0.0003461538392410105,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,966.469866338737688238,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -166.000000000000000000,0.00000000000000000000,0.45815933052972995787,0.00000000000000000000,-0.3385115048087375400,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,-0.0003461538392410105,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1017.92214533134608700,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -167.000000000000000000,0.00000000000000000000,0.54817411765168266857,0.00000000000000000000,-0.3431590336623864256,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,-0.0003461538392410105,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1031.34834006556957319,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -168.000000000000000000,0.00000000000000000000,-0.5554612864956957052,0.00000000000000000000,-0.4255826718745283065,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,-0.0004230769104555456,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1045.92271017848679548,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -169.000000000000000000,0.00000000000000000000,-0.4467314773266597982,0.00000000000000000000,-0.4023084379235625784,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,-0.0004230769104555456,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,990.910882835072129637,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -170.000000000000000000,0.00000000000000000000,-0.3625074008966603922,0.00000000000000000000,-0.3986415572663758455,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,-0.0004230769104555456,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,982.243710114068676375,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -171.000000000000000000,0.00000000000000000000,-0.2997457191473566484,0.00000000000000000000,-0.4266059421297224152,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,-0.0004230769104555456,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1048.34134903564472551,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -172.000000000000000000,0.00000000000000000000,-0.2045751359667724589,0.00000000000000000000,-0.4056422500206230408,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,-0.0004230769104555456,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,998.790802572291568139,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -173.000000000000000000,0.00000000000000000000,-0.1260404338701763549,0.00000000000000000000,-0.4177252074985165486,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,-0.0004230769104555456,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1027.35052109931598351,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -174.000000000000000000,0.00000000000000000000,-0.0404031815684558828,0.00000000000000000000,-0.4000119453090337784,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,-0.0004230769104555456,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,985.482809220617355094,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -175.000000000000000000,0.00000000000000000000,0.04221397530242154000,0.00000000000000000000,-0.4199306775760120458,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,-0.0004230769104555456,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1032.56345052891015257,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -176.000000000000000000,0.00000000000000000000,0.12068148817188631416,0.00000000000000000000,-0.3980757387221393606,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,-0.0004230769104555456,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,980.906320787794015814,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -177.000000000000000000,0.00000000000000000000,0.20698586105614699692,0.00000000000000000000,-0.4109458455663740905,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,-0.0004230769104555456,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1011.32657423622026726,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -178.000000000000000000,0.00000000000000000000,0.27497266042598372814,0.00000000000000000000,-0.3876768470602894312,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,-0.0004230769104555456,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,956.327121581075402900,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -179.000000000000000000,0.00000000000000000000,0.38120121258723305146,0.00000000000000000000,-0.4214895511521338233,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,-0.0004230769104555456,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1036.24806090966421834,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -180.000000000000000000,0.00000000000000000000,0.45730106460040564897,0.00000000000000000000,-0.4128780261432552500,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,-0.0004230769104555456,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1015.89354664509187387,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -181.000000000000000000,0.00000000000000000000,0.55182636701233600540,0.00000000000000000000,-0.4225069704615588839,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,-0.0004230769104555456,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1038.65287025822794930,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -182.000000000000000000,0.00000000000000000000,-0.5112653589180122803,0.00000000000000000000,-0.4587654187636883151,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,-0.0004999999791666669,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,957.530877424496225103,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -183.000000000000000000,0.00000000000000000000,-0.4346125900337609593,0.00000000000000000000,-0.4611331153967458962,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,-0.0004999999791666669,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,962.266270887919290544,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -184.000000000000000000,0.00000000000000000000,-0.3770328040109402478,0.00000000000000000000,-0.4921029920290715398,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,-0.0004999999791666669,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1024.20602673339385546,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -185.000000000000000000,0.00000000000000000000,-0.2824235127156454194,0.00000000000000000000,-0.4720008562729246515,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,-0.0004999999791666669,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,984.001753545921928889,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -186.000000000000000000,0.00000000000000000000,-0.1987072677013288490,0.00000000000000000000,-0.4641389393524580908,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,-0.0004999999791666669,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,968.277919049829165487,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -187.000000000000000000,0.00000000000000000000,-0.1222476834307649751,0.00000000000000000000,-0.4772400040733256187,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,-0.0004999999791666669,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,994.480049583319441808,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -188.000000000000000000,0.00000000000000000000,-0.0408474977772842889,0.00000000000000000000,-0.4785175127707315123,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,-0.0004999999791666669,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,997.035067084590309605,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -189.000000000000000000,0.00000000000000000000,0.04195441431265894277,0.00000000000000000000,-0.4929074289333094660,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,-0.0004999999791666669,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1025.81490060890610038,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -190.000000000000000000,0.00000000000000000000,0.12757958402373872908,0.00000000000000000000,-0.5003449086195556061,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,-0.0004999999791666669,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1040.68986060118800196,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -191.000000000000000000,0.00000000000000000000,0.19716893003488014657,0.00000000000000000000,-0.4601392610617319745,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,-0.0004999999791666669,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,960.278562135070387739,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -192.000000000000000000,0.00000000000000000000,0.27595028946731137153,0.00000000000000000000,-0.4599791548075489733,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,-0.0004999999791666669,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,959.958349613361974661,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -193.000000000000000000,0.00000000000000000000,0.36404650149313255713,0.00000000000000000000,-0.4733449975655781849,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,-0.0004999999791666669,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,986.690036243240797375,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -194.000000000000000000,0.00000000000000000000,0.45738722680279109145,0.00000000000000000000,-0.4880485982605993755,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,-0.0004999999791666669,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1016.09723885858329595,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -195.000000000000000000,0.00000000000000000000,0.54003956379788653485,0.00000000000000000000,-0.4875396272403385578,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,-0.0004999999791666669,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1015.07929677564743542,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -196.000000000000000000,0.00000000000000000000,-0.5387730364695781926,0.00000000000000000000,0.48627309975371429962,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1012.54624169685496326,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -197.000000000000000000,0.00000000000000000000,-0.4315082647603292742,0.00000000000000000000,0.45746436693115022364,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,954.928773650998891753,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -198.000000000000000000,0.00000000000000000000,-0.3606233002491213146,0.00000000000000000000,0.46840037303565262849,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,976.800786771337698155,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -199.000000000000000000,0.00000000000000000000,-0.2840745856529754420,0.00000000000000000000,0.47506713487767548986,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,990.134311010946817077,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +Ray-ID ,Event-ID ,X-position ,Y-position ,Z-position ,Event-type ,X-direction ,Y-direction ,Z-direction ,Energy ,ElectricField-x-real ,ElectricField-x-imag ,ElectricField-y-real ,ElectricField-y-imag ,ElectricField-z-real ,ElectricField-z-imag ,pathLength ,order ,lastElement ,lightSourceIndex +0.00000000000000000000,0.00000000000000000000,-0.5387730364695781926,0.00000000000000000000,0.48627309975371429962,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,100.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1012.54624169685496326,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +1.00000000000000000000,0.00000000000000000000,-0.4315082647603292742,0.00000000000000000000,0.45746436693115022364,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,100.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,954.928773650998891753,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +2.00000000000000000000,0.00000000000000000000,-0.3606233002491213146,0.00000000000000000000,0.46840037303565262849,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,100.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,976.800786771337698155,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +3.00000000000000000000,0.00000000000000000000,-0.2840745856529754420,0.00000000000000000000,0.47506713487767548986,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,100.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,990.134311010946817077,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +4.00000000000000000000,0.00000000000000000000,-0.2114227209415486807,0.00000000000000000000,0.49719912073581812306,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,0.00049999997916666690,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1034.39828457156431795,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +5.00000000000000000000,0.00000000000000000000,-0.1268539098702317069,0.00000000000000000000,0.49720032035199840381,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,0.00049999997916666690,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1034.40068380402499315,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +6.00000000000000000000,0.00000000000000000000,-0.0426612169002327165,0.00000000000000000000,0.50209586333973688088,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,0.00049999997916666690,100.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1044.19177018746358953,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +7.00000000000000000000,0.00000000000000000000,0.03955316867655773310,0.00000000000000000000,0.46169123305494774722,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,0.00049999997916666690,100.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,963.382506250832761907,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +8.00000000000000000000,0.00000000000000000000,0.12171790422014708288,0.00000000000000000000,0.47494429396424486800,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,0.00049999997916666690,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,989.888629173848812570,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +9.00000000000000000000,0.00000000000000000000,0.20080629888928178128,0.00000000000000000000,0.46959642092956410674,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,0.00049999997916666690,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,979.192882658831308617,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +10.0000000000000000000,0.00000000000000000000,0.29963811646545362998,0.00000000000000000000,0.50397083771581585587,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,0.00049999997916666690,100.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1047.94171909586930269,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +11.0000000000000000000,0.00000000000000000000,0.35238774923302068620,0.00000000000000000000,0.45650457589462684060,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,0.00049999997916666690,100.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,953.009191497969595729,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +12.0000000000000000000,0.00000000000000000000,0.43651206670285430666,0.00000000000000000000,0.46337795171425821827,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,0.00049999997916666690,100.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,966.755943710013639247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +13.0000000000000000000,0.00000000000000000000,0.54688308727095458205,0.00000000000000000000,0.49438315156884721224,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,0.00049999997916666690,100.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1028.76634600295824384,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +14.0000000000000000000,0.00000000000000000000,-0.5484087946386686507,0.00000000000000000000,0.41961517816004184622,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,0.00042307691045554557,100.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1031.81772461437026322,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +15.0000000000000000000,0.00000000000000000000,-0.4639713736978018920,0.00000000000000000000,0.41954833583762446425,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,0.00042307691045554557,100.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1031.65973366576145053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +16.0000000000000000000,0.00000000000000000000,-0.3754300903682085133,0.00000000000000000000,0.41443595676716776798,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,0.00042307691045554557,100.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1019.57592822964829792,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +17.0000000000000000000,0.00000000000000000000,-0.2860642562730613125,0.00000000000000000000,0.40510649892762579105,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,0.00042307691045554557,100.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,997.524481769248154705,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +18.0000000000000000000,0.00000000000000000000,-0.2061164442880983049,0.00000000000000000000,0.40903312855075596443,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,0.00042307691045554557,100.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1006.80560660988817289,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +19.0000000000000000000,0.00000000000000000000,-0.1252935104448915648,0.00000000000000000000,0.41498648810299038069,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,0.00042307691045554557,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1020.87718415313941022,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +20.0000000000000000000,0.00000000000000000000,-0.0405313350266790980,0.00000000000000000000,0.40142163343394526853,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,0.00042307691045554557,100.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,988.814799433445728027,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +21.0000000000000000000,0.00000000000000000000,0.04234810054875542961,0.00000000000000000000,0.42140605537407649361,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,0.00042307691045554557,100.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1036.05070724655047342,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +22.0000000000000000000,0.00000000000000000000,0.12528294689615207535,0.00000000000000000000,0.41494775508854869761,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,0.00042307691045554557,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1020.78563338900062262,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +23.0000000000000000000,0.00000000000000000000,0.20737765922662326767,0.00000000000000000000,0.41180780159816310348,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,0.00042307691045554557,100.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1013.36392491759136191,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +24.0000000000000000000,0.00000000000000000000,0.28791350679211474838,0.00000000000000000000,0.40801246423748555036,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,0.00042307691045554557,100.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1004.39312725200636577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +25.0000000000000000000,0.00000000000000000000,0.35878238403888523810,0.00000000000000000000,0.39408875852208802292,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,0.00042307691045554557,100.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,971.482549124721458611,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +26.0000000000000000000,0.00000000000000000000,0.46328305823544563279,0.00000000000000000000,0.41886002031366592612,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,0.00042307691045554557,100.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1030.03280601514234149,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +27.0000000000000000000,0.00000000000000000000,0.53178831979086194081,0.00000000000000000000,0.40555169801759538561,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,0.00042307691045554557,100.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,998.576770558750354211,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +28.0000000000000000000,0.00000000000000000000,-0.5278793126446065242,0.00000000000000000000,0.32910878289549722053,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,0.00034615383924101053,100.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,990.758725928409603511,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +29.0000000000000000000,0.00000000000000000000,-0.4697655861003967037,0.00000000000000000000,0.34800753275639656481,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,0.00034615383924101053,100.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1045.35511550576438821,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +30.0000000000000000000,0.00000000000000000000,-0.3649311534443439586,0.00000000000000000000,0.32858502011366702566,1.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,0.00034615383924101053,100.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,989.245633417349722549,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +31.0000000000000000000,0.00000000000000000000,-0.2956012802763716140,0.00000000000000000000,0.34371265368142528418,1.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,0.00034615383924101053,100.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822780,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1032.94768681917707908,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +32.0000000000000000000,0.00000000000000000000,-0.2131720871987957122,0.00000000000000000000,0.34736361976508761673,1.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,0.00034615383924101053,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1043.49492238261223064,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +33.0000000000000000000,0.00000000000000000000,-0.1177051674373130740,0.00000000000000000000,0.31676936240445735526,1.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,0.00034615383924101053,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,955.111510464626803695,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +34.0000000000000000000,0.00000000000000000000,-0.0391706460358167835,0.00000000000000000000,0.31618967373947182153,1.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,0.00034615383924101053,100.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,953.436854287891833337,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +35.0000000000000000000,0.00000000000000000000,0.03977539482841409290,0.00000000000000000000,0.32163241309157691860,1.00000000000000000000,0.00003846153614777726,0.99999993934911302062,0.00034615383924101053,100.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,969.160323841310741954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +36.0000000000000000000,0.00000000000000000000,0.12513907239528249126,0.00000000000000000000,0.33907107821860071883,1.00000000000000000000,0.00011538460821574884,0.99999993343195370254,0.00034615383924101053,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1019.53869076990065423,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +37.0000000000000000000,0.00000000000000000000,0.21254476944746891753,0.00000000000000000000,0.34623444776063938554,1.00000000000000000000,0.00019230767960097126,0.99999992159763495536,0.00034615383924101053,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1040.23286986017274102,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +38.0000000000000000000,0.00000000000000000000,0.28177065559640585012,0.00000000000000000000,0.32593042102497882250,1.00000000000000000000,0.00026923074984827827,0.99999990384615689009,0.00034615383924101053,100.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,981.576791452433894846,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +39.0000000000000000000,0.00000000000000000000,0.37072550456957287234,0.00000000000000000000,0.33437937158604275067,1.00000000000000000000,0.00034615381850250414,0.99999988017751961777,0.00034615383924101053,100.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1005.98487133850244390,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +40.0000000000000000000,0.00000000000000000000,0.46656763946999518788,0.00000000000000000000,0.34539103078532451540,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,0.00034615383924101053,100.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1037.79633188282673472,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +41.0000000000000000000,0.00000000000000000000,0.53274119615986526010,0.00000000000000000000,0.33247470252689909075,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,0.00034615383924101053,100.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.48249394664708233,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +42.0000000000000000000,0.00000000000000000000,-0.5557806174521595643,0.00000000000000000000,0.27099727409940121969,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,0.00026923076597822786,100.000000000000000000,0.99999987500000242501,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1046.56131644114520895,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +43.0000000000000000000,0.00000000000000000000,-0.4332595456462873806,0.00000000000000000000,0.24744140312934365111,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,0.00026923076597822786,100.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,959.068080352508331998,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +44.0000000000000000000,0.00000000000000000000,-0.3770037840476019863,0.00000000000000000000,0.26495594676947098466,1.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,0.00026923076597822786,100.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1024.12210037317618116,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +45.0000000000000000000,0.00000000000000000000,-0.2823551757702407738,0.00000000000000000000,0.25408595460005140020,1.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,0.00026923076597822786,100.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,983.747843256147348256,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +46.0000000000000000000,0.00000000000000000000,-0.2084286356224638314,0.00000000000000000000,0.26353086742049075530,1.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,0.00026923076597822786,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1018.82894844158943215,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +47.0000000000000000000,0.00000000000000000000,-0.1226530618081831669,0.00000000000000000000,0.25792125387143172154,1.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,0.00026923076597822786,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,997.993240721942470372,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +48.0000000000000000000,0.00000000000000000000,-0.0407818835675829854,0.00000000000000000000,0.25720396074461610025,1.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,0.00026923076597822786,100.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,995.329009075869635125,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +49.0000000000000000000,0.00000000000000000000,0.04217363671100634453,0.00000000000000000000,0.26694623298637176755,1.00000000000000000000,0.00003846153705810951,0.99999996301775162521,0.00026923076597822786,100.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1031.51459212525787734,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +50.0000000000000000000,0.00000000000000000000,0.11746633169532724738,0.00000000000000000000,0.24581888328883261252,1.00000000000000000000,0.00011538461094674560,0.99999995710059208509,0.00026923076597822786,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,953.041578014947617703,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +51.0000000000000000000,0.00000000000000000000,0.19951667872828965366,0.00000000000000000000,0.25105412739028420965,1.00000000000000000000,0.00019230768415263250,0.99999994526627311586,0.00026923076597822786,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,972.486770626682641704,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +52.0000000000000000000,0.00000000000000000000,0.27489811170571726295,0.00000000000000000000,0.24662889026526446656,1.00000000000000000000,0.00026923075622060400,0.99999992751479460650,0.00026923076597822786,100.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,956.050175392326877954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +53.0000000000000000000,0.00000000000000000000,0.35498675883996821944,0.00000000000000000000,0.24783159307446572805,1.00000000000000000000,0.00034615382669549426,0.99999990384615689009,0.00026923076597822786,100.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,960.517357309041813095,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +54.0000000000000000000,0.00000000000000000000,0.44643502598738660225,0.00000000000000000000,0.25582580016275097145,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,0.00026923076597822786,100.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,990.210126852815619713,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +55.0000000000000000000,0.00000000000000000000,0.51140632809399644287,0.00000000000000000000,0.24710342441057336904,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,0.00026923076597822786,100.000000000000000000,0.99999987500000242501,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,957.812730810481525622,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +56.0000000000000000000,0.00000000000000000000,-0.5530754184086756897,0.00000000000000000000,0.19252901789102649932,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,0.00019230769112236383,100.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1041.15089945068802990,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +57.0000000000000000000,0.00000000000000000000,-0.4634392125456729960,0.00000000000000000000,0.19046188818258663610,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,0.00019230769112236383,100.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1030.40182490054644404,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +58.0000000000000000000,0.00000000000000000000,-0.3843959929693127053,0.00000000000000000000,0.19336102822867470840,1.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,0.00019230769112236383,100.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1045.47735323312576838,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +59.0000000000000000000,0.00000000000000000000,-0.2914334209139534670,0.00000000000000000000,0.18797442630783398054,1.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,0.00019230769112236383,100.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1017.46702307210625804,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +60.0000000000000000000,0.00000000000000000000,-0.2069485160950387814,0.00000000000000000000,0.18675621199830280683,1.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,0.00019230769112236383,100.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1011.13230862349894323,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +61.0000000000000000000,0.00000000000000000000,-0.1255228963109913109,0.00000000000000000000,0.18901252235401536094,1.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,0.00019230769112236383,100.000000000000000000,0.99999999334319533694,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1022.86512254552178546,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +62.0000000000000000000,0.00000000000000000000,-0.0396971634428423050,0.00000000000000000000,0.17829351186048308930,1.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,0.00019230769112236383,100.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,967.126267635595809224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +63.0000000000000000000,0.00000000000000000000,0.04151248722921495326,0.00000000000000000000,0.18737013090647539059,1.00000000000000000000,0.00003846153774085871,0.99999998076923080070,0.00019230769112236383,100.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1014.32468696567332244,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +64.0000000000000000000,0.00000000000000000000,0.12541229462116643134,0.00000000000000000000,0.18882818620162578060,1.00000000000000000000,0.00011538461299499319,0.99999997485207114955,0.00019230769112236383,100.000000000000000000,0.99999999334319533694,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1021.90657454718780172,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +65.0000000000000000000,0.00000000000000000000,0.20398661606217607933,0.00000000000000000000,0.18379431191067119311,1.00000000000000000000,0.00019230768756637849,0.99999996301775195828,0.00019230769112236383,100.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,995.730428072881977641,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +66.0000000000000000000,0.00000000000000000000,0.29639820069005051728,0.00000000000000000000,0.19152069766303314590,1.00000000000000000000,0.00026923076099984833,0.99999994526627311586,0.00019230769112236383,100.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1035.90763423280441202,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +67.0000000000000000000,0.00000000000000000000,0.35819319476662597745,0.00000000000000000000,0.17880391764590788938,1.00000000000000000000,0.00034615383284023691,0.99999992159763495536,0.00019230769112236383,100.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,969.780377736164155066,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +68.0000000000000000000,0.00000000000000000000,0.46857672985752818473,0.00000000000000000000,0.19279712342279192727,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,0.00019230769112236383,100.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1042.54504822446142497,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +69.0000000000000000000,0.00000000000000000000,0.50815569288434048189,0.00000000000000000000,0.17525219944882086675,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,0.00019230769112236383,100.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,951.311442997474614458,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +70.0000000000000000000,0.00000000000000000000,-0.5188878019378441175,0.00000000000000000000,0.10762795946827592719,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,0.00011538461512858444,100.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,972.775650883583807626,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +71.0000000000000000000,0.00000000000000000000,-0.4633235933051890742,0.00000000000000000000,0.11424559945033134489,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,0.00011538461512858444,100.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1030.12853085532651675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +72.0000000000000000000,0.00000000000000000000,-0.3857704025809524095,0.00000000000000000000,0.11647475253386861682,1.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,0.00011538461512858444,100.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1049.44785762218452873,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +73.0000000000000000000,0.00000000000000000000,-0.2782375831981779845,0.00000000000000000000,0.10712929574400131826,1.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,0.00011538461512858444,100.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,968.453898596947283294,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +74.0000000000000000000,0.00000000000000000000,-0.2008296688132032992,0.00000000000000000000,0.10838241787049238129,1.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,0.00011538461512858444,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,979.314290383968682363,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +75.0000000000000000000,0.00000000000000000000,-0.1202422255450762839,0.00000000000000000000,0.10812684168019466579,1.00000000000000000000,-0.0001153846143604915,0.99999998668639045185,0.00011538461512858444,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,977.099296729806724215,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +76.0000000000000000000,0.00000000000000000000,-0.0399181910094093400,0.00000000000000000000,0.10763918893869088566,1.00000000000000000000,-0.0000384615381960248,0.99999999260355021402,0.00011538461512858444,100.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,972.872972960729271107,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +77.0000000000000000000,0.00000000000000000000,0.04259982830523007663,0.00000000000000000000,0.11568410086383883184,1.00000000000000000000,0.00003846153819602484,0.99999999260355021402,0.00011538461512858444,100.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1042.59554313338821884,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +78.0000000000000000000,0.00000000000000000000,0.12451770369038070440,0.00000000000000000000,0.11240231985396009761,1.00000000000000000000,0.00011538461436049158,0.99999998668639045185,0.00011538461512858444,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1014.15344098466118794,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +79.0000000000000000000,0.00000000000000000000,0.21219482833484110129,0.00000000000000000000,0.11520151365576819513,1.00000000000000000000,0.00019230768984220914,0.99999997485207114955,0.00011538461512858444,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1038.41312065416195764,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +80.0000000000000000000,0.00000000000000000000,0.27695491416125889161,0.00000000000000000000,0.10657958043338394693,1.00000000000000000000,0.00026923076418601120,0.99999995710059208509,0.00011538461512858444,100.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,963.689699227692017302,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +81.0000000000000000000,0.00000000000000000000,0.36438584778103316752,0.00000000000000000000,0.10934656742657544725,1.00000000000000000000,0.00034615383693673202,0.99999993343195370254,0.00011538461512858444,100.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,987.670253221896473405,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +82.0000000000000000000,0.00000000000000000000,0.45773126309666223310,0.00000000000000000000,0.11272041843210119094,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,0.00011538461512858444,100.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1016.91029533466780776,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +83.0000000000000000000,0.00000000000000000000,0.55432212593365448594,0.00000000000000000000,0.11580511153662056966,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,0.00011538461512858444,100.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1043.64430229982349374,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +84.0000000000000000000,0.00000000000000000000,-0.5419509263578902169,0.00000000000000000000,0.03765007291047852561,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,0.00003846153845205580,100.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1018.90189592365118187,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +85.0000000000000000000,0.00000000000000000000,-0.4579730389630555786,0.00000000000000000000,0.03759545228129676508,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,0.00003846153845205580,100.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1017.48175956457532720,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +86.0000000000000000000,0.00000000000000000000,-0.3607059536193307214,0.00000000000000000000,0.03603997852156198139,1.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,0.00003846153845205580,100.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,977.039441801499947359,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +87.0000000000000000000,0.00000000000000000000,-0.2830273052709604830,0.00000000000000000000,0.03639401112006577371,1.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,0.00003846153845205580,100.000000000000000000,0.99999996375739685916,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,986.244289364867768199,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +88.0000000000000000000,0.00000000000000000000,-0.1973612956508831728,0.00000000000000000000,0.03543379783783217468,1.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,0.00003846153845205580,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,961.278744020639237533,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +89.0000000000000000000,0.00000000000000000000,-0.1232052129471131324,0.00000000000000000000,0.03702994288184152660,1.00000000000000000000,-0.0001153846150432407,0.99999999260355021402,0.00003846153845205580,100.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1002.77851517511396650,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +90.0000000000000000000,0.00000000000000000000,-0.0424246375594649408,0.00000000000000000000,0.03838617605053346037,1.00000000000000000000,-0.0000384615384236079,0.99999999852070997619,0.00003846153845205580,100.000000000000000000,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1038.04057756979818805,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +91.0000000000000000000,0.00000000000000000000,0.04014136623359557815,0.00000000000000000000,0.03610290472297528197,1.00000000000000000000,0.00003846153842360791,0.99999999852070997619,0.00003846153845205580,100.000000000000000000,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,978.675523038649089357,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +92.0000000000000000000,0.00000000000000000000,0.11987555769005356354,0.00000000000000000000,0.03592005779314496466,1.00000000000000000000,0.00011538461504324078,0.99999999260355021402,0.00003846153845205580,100.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,973.921502861888711777,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +93.0000000000000000000,0.00000000000000000000,0.20362928693761644938,0.00000000000000000000,0.03668739610352377694,1.00000000000000000000,0.00019230769098012445,0.99999998076923080070,0.00003846153845205580,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,993.872298936656648038,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +94.0000000000000000000,0.00000000000000000000,0.27943550518851684172,0.00000000000000000000,0.03588089681612195019,1.00000000000000000000,0.00026923076577909266,0.99999996301775162521,0.00003846153845205580,100.000000000000000000,0.99999996375739685916,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,972.903317459039271852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +95.0000000000000000000,0.00000000000000000000,0.36886862776434303778,0.00000000000000000000,0.03694694233401190491,1.00000000000000000000,0.00034615383898497955,0.99999993934911302062,0.00003846153845205580,100.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.62050093101174752,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +96.0000000000000000000,0.00000000000000000000,0.44961517485157920237,0.00000000000000000000,0.03683564642993927829,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,0.00003846153845205580,100.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,997.726807424410026214,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +97.0000000000000000000,0.00000000000000000000,0.53612299092400717004,0.00000000000000000000,0.03720177016589487628,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,0.00003846153845205580,100.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1007.24602456160266683,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +98.0000000000000000000,0.00000000000000000000,-0.5562290873654824885,0.00000000000000000000,-0.0387483930342905416,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,-0.0000384615384520558,100.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1047.45821914980410838,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +99.0000000000000000000,0.00000000000000000000,-0.4671661581117621531,0.00000000000000000000,-0.0384311904110687732,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,-0.0000384615384520558,100.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1039.21095094400448033,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +100.000000000000000000,0.00000000000000000000,-0.3848736195733291065,0.00000000000000000000,-0.0387252747936235111,1.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,-0.0000384615384520558,100.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1046.85714489231327206,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +101.000000000000000000,0.00000000000000000000,-0.2830581877053078843,0.00000000000000000000,-0.0363984228964566031,1.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,-0.0000384615384520558,100.000000000000000000,0.99999996375739685916,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,986.358995551057660122,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +102.000000000000000000,0.00000000000000000000,-0.2083777720035789038,0.00000000000000000000,-0.0376370931230382357,1.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,-0.0000384615384520558,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1018.56442145012022137,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +103.000000000000000000,0.00000000000000000000,-0.1227857232810207616,0.00000000000000000000,-0.0368901129927648591,1.00000000000000000000,-0.0001153846150432407,0.99999999260355021402,-0.0000384615384520558,100.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.142938058223990083,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +104.000000000000000000,0.00000000000000000000,-0.0393939750956869144,0.00000000000000000000,-0.0353555135845138243,1.00000000000000000000,-0.0000384615384236079,0.99999999852070997619,-0.0000384615384520558,100.000000000000000000,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,959.243353433859965662,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +105.000000000000000000,0.00000000000000000000,0.04192579913549480258,0.00000000000000000000,-0.0378873376261943603,1.00000000000000000000,0.00003846153842360791,0.99999999852070997619,-0.0000384615384520558,100.000000000000000000,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1025.07077853378359577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +106.000000000000000000,0.00000000000000000000,0.12391865911007758638,0.00000000000000000000,-0.0372677582701413170,1.00000000000000000000,0.00011538461504324078,0.99999999260355021402,-0.0000384615384520558,100.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1008.96171527243279797,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +107.000000000000000000,0.00000000000000000000,0.19989324962672178065,0.00000000000000000000,-0.0359401886363708358,1.00000000000000000000,0.00019230769098012445,0.99999998076923080070,-0.0000384615384520558,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,974.444904785890344101,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +108.000000000000000000,0.00000000000000000000,0.29403236393330939302,0.00000000000000000000,-0.0379661623773123735,1.00000000000000000000,0.00026923076577909266,0.99999996301775162521,-0.0000384615384520558,100.000000000000000000,0.99999996375739685916,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1027.12022206335723240,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +109.000000000000000000,0.00000000000000000000,0.38329686358966758019,0.00000000000000000000,-0.0385500796807426715,1.00000000000000000000,0.00034615383898497955,0.99999993934911302062,-0.0000384615384520558,100.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1042.30207195628804583,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +110.000000000000000000,0.00000000000000000000,0.45947207964870923069,0.00000000000000000000,-0.0377317287113979257,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,-0.0000384615384520558,100.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1021.02494674807883257,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +111.000000000000000000,0.00000000000000000000,0.54943897879719949539,0.00000000000000000000,-0.0382260769685557472,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,-0.0000384615384520558,100.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1033.87800143735125857,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +112.000000000000000000,0.00000000000000000000,-0.5110151574692605169,0.00000000000000000000,-0.1058111952763801655,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,-0.0001153846151285844,100.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,957.030361185549509173,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +113.000000000000000000,0.00000000000000000000,-0.4375410852965807007,0.00000000000000000000,-0.1072140061161002827,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,-0.0001153846151285844,100.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,969.188055156767518383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +114.000000000000000000,0.00000000000000000000,-0.3640360372830070967,0.00000000000000000000,-0.1092299639243873299,1.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,-0.0001153846151285844,100.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,986.659689534023868873,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +115.000000000000000000,0.00000000000000000000,-0.2767299135054704928,0.00000000000000000000,-0.1064831515793103339,1.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,-0.0001153846151285844,100.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,962.853982490533098825,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +116.000000000000000000,0.00000000000000000000,-0.1989678468804907118,0.00000000000000000000,-0.1072653246990218772,1.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,-0.0001153846151285844,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,969.632816209741690727,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +117.000000000000000000,0.00000000000000000000,-0.1265011152390264625,0.00000000000000000000,-0.1143857314158090304,1.00000000000000000000,-0.0001153846143604915,0.99999998668639045185,-0.0001153846151285844,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1031.34300789216081284,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +118.000000000000000000,0.00000000000000000000,-0.0394516961764171461,0.00000000000000000000,-0.1062397044331585271,1.00000000000000000000,-0.0000384615381960248,0.99999999260355021402,-0.0001153846151285844,100.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,960.744107219202419400,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +119.000000000000000000,0.00000000000000000000,0.04081022216522532664,0.00000000000000000000,-0.1103152824186747898,1.00000000000000000000,0.00003846153819602484,0.99999999260355021402,-0.0001153846151285844,100.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,996.065783172053102134,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +120.000000000000000000,0.00000000000000000000,0.11933722941635908909,0.00000000000000000000,-0.1072218455454530816,1.00000000000000000000,0.00011538461436049158,0.99999998668639045185,-0.0001153846151285844,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,969.255996877975803727,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +121.000000000000000000,0.00000000000000000000,0.19719055412745098432,0.00000000000000000000,-0.1061989490358927479,1.00000000000000000000,0.00019230768984220914,0.99999997485207114955,-0.0001153846151285844,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,960.390893775448489577,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +122.000000000000000000,0.00000000000000000000,0.29163068243960604819,0.00000000000000000000,-0.1128691955137149649,1.00000000000000000000,0.00026923076418601120,0.99999995710059208509,-0.0001153846151285844,100.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1018.19969671151500278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +123.000000000000000000,0.00000000000000000000,0.38215206320044836640,0.00000000000000000000,-0.1152686393775947809,1.00000000000000000000,0.00034615383693673202,0.99999993343195370254,-0.0001153846151285844,100.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1038.99487691128342703,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +124.000000000000000000,0.00000000000000000000,0.46208738440286967197,0.00000000000000000000,-0.1139084515563264649,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,-0.0001153846151285844,100.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1027.20658243413367927,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +125.000000000000000000,0.00000000000000000000,0.53614465219669282802,0.00000000000000000000,-0.1116103097116146469,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,-0.0001153846151285844,100.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1007.28935306910295821,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +126.000000000000000000,0.00000000000000000000,-0.5165993019461145863,0.00000000000000000000,-0.1784997415710051771,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,-0.0001923076911223638,100.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,968.198662136920688681,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +127.000000000000000000,0.00000000000000000000,-0.4353152688955023164,0.00000000000000000000,-0.1776782768935550593,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,-0.0001923076911223638,100.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,963.927045787850943270,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +128.000000000000000000,0.00000000000000000000,-0.3857209022907011619,0.00000000000000000000,-0.1940970889865526460,1.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,-0.0001923076911223638,100.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1049.30486919768236475,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +129.000000000000000000,0.00000000000000000000,-0.2864414253349025774,0.00000000000000000000,-0.1844087150929076823,1.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,-0.0001923076911223638,100.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,998.925324640203712078,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +130.000000000000000000,0.00000000000000000000,-0.2063959446691524535,0.00000000000000000000,-0.1862036405621988743,1.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,-0.0001923076911223638,100.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1008.25893713804759954,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +131.000000000000000000,0.00000000000000000000,-0.1260910642998142316,0.00000000000000000000,-0.1899594690158282195,1.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,-0.0001923076911223638,100.000000000000000000,0.99999999334319533694,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1027.78924521729913976,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +132.000000000000000000,0.00000000000000000000,-0.0424235947522043702,0.00000000000000000000,-0.1919256685787037453,1.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,-0.0001923076911223638,100.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1038.01348300727136120,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +133.000000000000000000,0.00000000000000000000,0.04158609551071744403,0.00000000000000000000,-0.1877381723186156703,1.00000000000000000000,0.00003846153774085871,0.99999998076923080070,-0.0001923076911223638,100.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1016.23850232059851350,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +134.000000000000000000,0.00000000000000000000,0.11777411926471503811,0.00000000000000000000,-0.1760978937556942069,1.00000000000000000000,0.00011538461299499319,0.99999997485207114955,-0.0001923076911223638,100.000000000000000000,0.99999999334319533694,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,955.709053420321197336,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +135.000000000000000000,0.00000000000000000000,0.20820763827111707366,0.00000000000000000000,-0.1880153341976636971,1.00000000000000000000,0.00019230768756637849,0.99999996301775195828,-0.0001923076911223638,100.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1017.67974410053170686,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +136.000000000000000000,0.00000000000000000000,0.28622487428337456405,0.00000000000000000000,-0.1842540357666122008,1.00000000000000000000,0.00026923076099984833,0.99999994526627311586,-0.0001923076911223638,100.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,998.120992138509564028,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +137.000000000000000000,0.00000000000000000000,0.36162628038646837946,0.00000000000000000000,-0.1807111874963099606,1.00000000000000000000,0.00034615383284023691,0.99999992159763495536,-0.0001923076911223638,100.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,979.698181019385174295,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +138.000000000000000000,0.00000000000000000000,0.45634646534559597519,0.00000000000000000000,-0.1872379120466295676,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,-0.0001923076911223638,100.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1013.63714889023697196,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +139.000000000000000000,0.00000000000000000000,0.50891093546187726737,0.00000000000000000000,-0.1755426773789422190,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,-0.0001923076911223638,100.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,952.821928243415527504,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +140.000000000000000000,0.00000000000000000000,-0.5093776748522762520,0.00000000000000000000,-0.2460110725931239916,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,-0.0002692307659782278,100.000000000000000000,0.99999987500000242501,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,953.755424010939691470,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +141.000000000000000000,0.00000000000000000000,-0.4610784671311338178,0.00000000000000000000,-0.2651443541210096177,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,-0.0002692307659782278,100.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1024.82189911591649433,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +142.000000000000000000,0.00000000000000000000,-0.3687491041817552162,0.00000000000000000000,-0.2585356399238037949,1.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,-0.0002692307659782278,100.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.27524608689304841,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +143.000000000000000000,0.00000000000000000000,-0.2920917443747614306,0.00000000000000000000,-0.2638225235574506721,1.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,-0.0002692307659782278,100.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1019.91224267767029232,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +144.000000000000000000,0.00000000000000000000,-0.2089453775998306173,0.00000000000000000000,-0.2642543062107429174,1.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,-0.0002692307659782278,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1021.51600683784499778,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +145.000000000000000000,0.00000000000000000000,-0.1282282280461522760,0.00000000000000000000,-0.2709299754365384615,1.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,-0.0002692307659782278,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1046.31134997606363867,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +146.000000000000000000,0.00000000000000000000,-0.0405401372088698835,0.00000000000000000000,-0.2555117361923200935,1.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,-0.0002692307659782278,100.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,989.043603519979683369,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +147.000000000000000000,0.00000000000000000000,0.04095123455543604046,0.00000000000000000000,-0.2583894176885224713,1.00000000000000000000,0.00003846153705810951,0.99999996301775162521,-0.0002692307659782278,100.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.732134920715338921,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +148.000000000000000000,0.00000000000000000000,0.12805986104381544832,0.00000000000000000000,-0.2705371190873887554,1.00000000000000000000,0.00011538461094674560,0.99999995710059208509,-0.0002692307659782278,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1044.85216923302232316,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +149.000000000000000000,0.00000000000000000000,0.20906449352578948541,0.00000000000000000000,-0.2644210685121423654,1.00000000000000000000,0.00019230768415263250,0.99999994526627311586,-0.0002692307659782278,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1022.13540967909727896,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +150.000000000000000000,0.00000000000000000000,0.27573900173887605502,0.00000000000000000000,-0.2474697803288993247,1.00000000000000000000,0.00026923075622060400,0.99999992751479460650,-0.0002692307659782278,100.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,959.173481380702696696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +151.000000000000000000,0.00000000000000000000,0.37766902569121280075,0.00000000000000000000,-0.2654733569595582598,1.00000000000000000000,0.00034615382669549426,0.99999990384615689009,-0.0002692307659782278,100.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1026.04390967386007105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +152.000000000000000000,0.00000000000000000000,0.46560062786059347450,0.00000000000000000000,-0.2680220929224101933,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,-0.0002692307659782278,100.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1035.51064336453396208,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +153.000000000000000000,0.00000000000000000000,0.53302740372979684480,0.00000000000000000000,-0.2587455428270017954,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,-0.0002692307659782278,100.000000000000000000,0.99999987500000242501,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1001.05488545104708464,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +154.000000000000000000,0.00000000000000000000,-0.5082175167712037477,0.00000000000000000000,-0.3154967692569144999,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,-0.0003461538392410105,100.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,951.435130187195454709,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +155.000000000000000000,0.00000000000000000000,-0.4614899950551638041,0.00000000000000000000,-0.3412365941560489002,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,-0.0003461538392410105,100.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1025.79462582524024583,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +156.000000000000000000,0.00000000000000000000,-0.3626953215533518237,0.00000000000000000000,-0.3263491880887234297,1.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,-0.0003461538392410105,100.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,982.786562994077712573,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +157.000000000000000000,0.00000000000000000000,-0.2796871705442759981,0.00000000000000000000,-0.3232516543900293415,1.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,-0.0003461538392410105,100.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822780,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,973.838132130257804419,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +158.000000000000000000,0.00000000000000000000,-0.2098531265040638749,0.00000000000000000000,-0.3413894902391358399,1.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,-0.0003461538392410105,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1026.23632562964576209,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +159.000000000000000000,0.00000000000000000000,-0.1202513503105780701,0.00000000000000000000,-0.3244079113462917662,1.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,-0.0003461538392410105,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,977.178430070611739211,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +160.000000000000000000,0.00000000000000000000,-0.0414700648859237658,0.00000000000000000000,-0.3368844442221031187,1.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,-0.0003461538392410105,100.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1013.22174798720004673,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +161.000000000000000000,0.00000000000000000000,0.04045266991164696290,0.00000000000000000000,-0.3277278890856339388,1.00000000000000000000,0.00003846153614777726,0.99999993934911302062,-0.0003461538392410105,100.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,986.769477064693205647,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +162.000000000000000000,0.00000000000000000000,0.12134388847713499515,0.00000000000000000000,-0.3276855259841459644,1.00000000000000000000,0.00011538460821574884,0.99999993343195370254,-0.0003461538392410105,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,986.647094769061595798,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +163.000000000000000000,0.00000000000000000000,0.20411972004592765506,0.00000000000000000000,-0.3310693581386857098,1.00000000000000000000,0.00019230767960097126,0.99999992159763495536,-0.0003461538392410105,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,996.422610077397393979,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +164.000000000000000000,0.00000000000000000000,0.29776143610491695445,0.00000000000000000000,-0.3464899970340372115,1.00000000000000000000,0.00026923074984827827,0.99999990384615689009,-0.0003461538392410105,100.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1040.97112333139853035,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +165.000000000000000000,0.00000000000000000000,0.35704723470075883096,0.00000000000000000000,-0.3207011008977465049,1.00000000000000000000,0.00034615381850250414,0.99999988017751961777,-0.0003461538392410105,100.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,966.469866338737688238,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +166.000000000000000000,0.00000000000000000000,0.45815933052972995787,0.00000000000000000000,-0.3385115048087375400,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,-0.0003461538392410105,100.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1017.92214533134608700,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +167.000000000000000000,0.00000000000000000000,0.54817411765168266857,0.00000000000000000000,-0.3431590336623864256,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,-0.0003461538392410105,100.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1031.34834006556957319,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +168.000000000000000000,0.00000000000000000000,-0.5554612864956957052,0.00000000000000000000,-0.4255826718745283065,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,-0.0004230769104555456,100.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1045.92271017848679548,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +169.000000000000000000,0.00000000000000000000,-0.4467314773266597982,0.00000000000000000000,-0.4023084379235625784,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,-0.0004230769104555456,100.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,990.910882835072129637,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +170.000000000000000000,0.00000000000000000000,-0.3625074008966603922,0.00000000000000000000,-0.3986415572663758455,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,-0.0004230769104555456,100.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,982.243710114068676375,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +171.000000000000000000,0.00000000000000000000,-0.2997457191473566484,0.00000000000000000000,-0.4266059421297224152,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,-0.0004230769104555456,100.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1048.34134903564472551,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +172.000000000000000000,0.00000000000000000000,-0.2045751359667724589,0.00000000000000000000,-0.4056422500206230408,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,-0.0004230769104555456,100.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,998.790802572291568139,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +173.000000000000000000,0.00000000000000000000,-0.1260404338701763549,0.00000000000000000000,-0.4177252074985165486,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,-0.0004230769104555456,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1027.35052109931598351,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +174.000000000000000000,0.00000000000000000000,-0.0404031815684558828,0.00000000000000000000,-0.4000119453090337784,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,-0.0004230769104555456,100.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,985.482809220617355094,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +175.000000000000000000,0.00000000000000000000,0.04221397530242154000,0.00000000000000000000,-0.4199306775760120458,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,-0.0004230769104555456,100.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1032.56345052891015257,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +176.000000000000000000,0.00000000000000000000,0.12068148817188631416,0.00000000000000000000,-0.3980757387221393606,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,-0.0004230769104555456,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,980.906320787794015814,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +177.000000000000000000,0.00000000000000000000,0.20698586105614699692,0.00000000000000000000,-0.4109458455663740905,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,-0.0004230769104555456,100.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1011.32657423622026726,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +178.000000000000000000,0.00000000000000000000,0.27497266042598372814,0.00000000000000000000,-0.3876768470602894312,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,-0.0004230769104555456,100.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,956.327121581075402900,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +179.000000000000000000,0.00000000000000000000,0.38120121258723305146,0.00000000000000000000,-0.4214895511521338233,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,-0.0004230769104555456,100.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1036.24806090966421834,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +180.000000000000000000,0.00000000000000000000,0.45730106460040564897,0.00000000000000000000,-0.4128780261432552500,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,-0.0004230769104555456,100.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1015.89354664509187387,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +181.000000000000000000,0.00000000000000000000,0.55182636701233600540,0.00000000000000000000,-0.4225069704615588839,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,-0.0004230769104555456,100.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1038.65287025822794930,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +182.000000000000000000,0.00000000000000000000,-0.5112653589180122803,0.00000000000000000000,-0.4587654187636883151,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,-0.0004999999791666669,100.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,957.530877424496225103,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +183.000000000000000000,0.00000000000000000000,-0.4346125900337609593,0.00000000000000000000,-0.4611331153967458962,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,-0.0004999999791666669,100.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,962.266270887919290544,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +184.000000000000000000,0.00000000000000000000,-0.3770328040109402478,0.00000000000000000000,-0.4921029920290715398,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,-0.0004999999791666669,100.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1024.20602673339385546,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +185.000000000000000000,0.00000000000000000000,-0.2824235127156454194,0.00000000000000000000,-0.4720008562729246515,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,-0.0004999999791666669,100.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,984.001753545921928889,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +186.000000000000000000,0.00000000000000000000,-0.1987072677013288490,0.00000000000000000000,-0.4641389393524580908,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,-0.0004999999791666669,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,968.277919049829165487,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +187.000000000000000000,0.00000000000000000000,-0.1222476834307649751,0.00000000000000000000,-0.4772400040733256187,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,-0.0004999999791666669,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,994.480049583319441808,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +188.000000000000000000,0.00000000000000000000,-0.0408474977772842889,0.00000000000000000000,-0.4785175127707315123,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,-0.0004999999791666669,100.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,997.035067084590309605,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +189.000000000000000000,0.00000000000000000000,0.04195441431265894277,0.00000000000000000000,-0.4929074289333094660,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,-0.0004999999791666669,100.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1025.81490060890610038,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +190.000000000000000000,0.00000000000000000000,0.12757958402373872908,0.00000000000000000000,-0.5003449086195556061,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,-0.0004999999791666669,100.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1040.68986060118800196,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +191.000000000000000000,0.00000000000000000000,0.19716893003488014657,0.00000000000000000000,-0.4601392610617319745,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,-0.0004999999791666669,100.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,960.278562135070387739,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +192.000000000000000000,0.00000000000000000000,0.27595028946731137153,0.00000000000000000000,-0.4599791548075489733,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,-0.0004999999791666669,100.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,959.958349613361974661,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +193.000000000000000000,0.00000000000000000000,0.36404650149313255713,0.00000000000000000000,-0.4733449975655781849,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,-0.0004999999791666669,100.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,986.690036243240797375,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +194.000000000000000000,0.00000000000000000000,0.45738722680279109145,0.00000000000000000000,-0.4880485982605993755,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,-0.0004999999791666669,100.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1016.09723885858329595,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +195.000000000000000000,0.00000000000000000000,0.54003956379788653485,0.00000000000000000000,-0.4875396272403385578,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,-0.0004999999791666669,100.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1015.07929677564743542,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +196.000000000000000000,0.00000000000000000000,-0.5387730364695781926,0.00000000000000000000,0.48627309975371429962,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,100.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1012.54624169685496326,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +197.000000000000000000,0.00000000000000000000,-0.4315082647603292742,0.00000000000000000000,0.45746436693115022364,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,100.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,954.928773650998891753,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +198.000000000000000000,0.00000000000000000000,-0.3606233002491213146,0.00000000000000000000,0.46840037303565262849,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,100.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,976.800786771337698155,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +199.000000000000000000,0.00000000000000000000,-0.2840745856529754420,0.00000000000000000000,0.47506713487767548986,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,100.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,990.134311010946817077,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 diff --git a/Intern/rayx-core/tests/input/PlaneMirror_refl_seeded.correct.csv b/Intern/rayx-core/tests/input/PlaneMirror_refl_seeded.correct.csv index d0b09dc7..22f2eaf6 100644 --- a/Intern/rayx-core/tests/input/PlaneMirror_refl_seeded.correct.csv +++ b/Intern/rayx-core/tests/input/PlaneMirror_refl_seeded.correct.csv @@ -1,254 +1,401 @@ -Ray-ID ,Event-ID ,X-position ,Y-position ,Z-position ,Event-type ,X-direction ,Y-direction ,Z-direction ,Energy ,Stokes0 ,Stokes1 ,Stokes2 ,Stokes3 ,pathLength ,order ,lastElement ,lightSourceIndex -0.00000000000000000000,0.00000000000000000000,-5.0466620698997637362,0.00000000000000000000,28.7602367256004072260,3.00000000000000000000,-0.0004999999166666708,0.17315573039890028161,0.98489433089550615374,100.000000000000000000,0.31759754053448729926,0.31759754053448729926,0.00000000000000001228,0.00000000000000000075,10028.3258111870818538,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -1.00000000000000000000,0.00000000000000000000,-4.2702524198358808860,0.00000000000000000000,28.7602356975221482571,3.00000000000000000000,-0.0004230768575709328,0.17315573656392332924,0.98489436585908929355,100.000000000000000000,0.31759752556571563264,0.31759752556571563264,0.00000000000000001228,0.00000000000000000075,10028.3254541393671388,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -2.00000000000000000000,0.00000000000000000000,-3.4938428201962703489,0.00000000000000000000,28.7602348407926911022,3.00000000000000000000,-0.0003461537959717815,0.17315574170144260035,0.98489439499540898381,100.000000000000000000,0.31759751309173933631,0.31759751309173933631,0.00000000000000001228,0.00000000000000000075,10028.3251565996233694,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -3.00000000000000000000,0.00000000000000000000,-2.7174332618128755889,0.00000000000000000000,28.7602341554065787931,1.00000000000000000000,-0.0002692307323243828,0.17315574581145806720,0.98489441830446500247,100.000000000000000000,0.31759750311255868782,0.31759750311255868782,0.00000000000000001228,0.00000000000000000075,10028.3249185678359935,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -3.00000000000000000000,1.00000000000000000000,-2.9790385330943736086,0.00000000000000000000,-5.4800006576671842495,1.00000000000000000000,-0.0002692307323243828,0.99999983875740361405,-0.0004999999791666653,100.000000000000000000,0.31759750311255868782,0.31759750311255868782,0.00000000000000001228,0.00000000000000000075,11000.0017736688459990,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -4.00000000000000000000,0.00000000000000000000,-1.9410237355176496176,0.00000000000000000000,28.7602336413692682981,1.00000000000000000000,-0.0001923076670839029,0.17315574889396967428,0.98489443578625712749,100.000000000000000000,0.31759749562817363166,0.31759749562817363166,0.00000000000000001228,0.00000000000000000075,10028.3247400440031924,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -4.00000000000000000000,1.00000000000000000000,-2.1278846414618421967,0.00000000000000000000,-5.4800005600348518086,1.00000000000000000000,-0.0001923076670839029,0.99999985650888068011,-0.0004999999791666653,100.000000000000000000,0.31759749562817363166,0.31759749562817363166,0.00000000000000001228,0.00000000000000000075,11000.0015784025363245,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -5.00000000000000000000,0.00000000000000000000,-1.1646142321425427823,0.00000000000000000000,28.7602332986753026489,3.00000000000000000000,-0.0001153846007055078,0.17315575094897742158,0.98489444744078502580,100.000000000000000000,0.31759749063858322415,0.31759749063858322415,0.00000000000000001228,0.00000000000000000075,10028.3246210281176900,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -6.00000000000000000000,0.00000000000000000000,-0.3882047425195060408,0.00000000000000000000,28.7602331273301388137,3.00000000000000000000,-0.0000384615336443635,0.17315575197648130911,0.98489445326804925251,100.000000000000000000,0.31759748814378807590,0.31759748814378807590,0.00000000000000001228,0.00000000000000000075,10028.3245615201758482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -7.00000000000000000000,0.00000000000000000000,0.38820474251950604083,0.00000000000000000000,28.7602331273301388137,3.00000000000000000000,0.00003846153364436359,0.17315575197648130911,0.98489445326804925251,100.000000000000000000,0.31759748814378807590,0.31759748814378807590,0.00000000000000001228,0.00000000000000000075,10028.3245615201758482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -8.00000000000000000000,0.00000000000000000000,1.16461423214254278235,0.00000000000000000000,28.7602332986753026489,3.00000000000000000000,0.00011538460070550785,0.17315575094897742158,0.98489444744078502580,100.000000000000000000,0.31759749063858322415,0.31759749063858322415,0.00000000000000001228,0.00000000000000000075,10028.3246210281176900,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -9.00000000000000000000,0.00000000000000000000,1.94102373551765006176,0.00000000000000000000,28.7602336413692682981,3.00000000000000000000,0.00019230766708390299,0.17315574889396967428,0.98489443578625712749,100.000000000000000000,0.31759749562817363166,0.31759749562817363166,0.00000000000000001228,0.00000000000000000075,10028.3247400440031924,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -10.0000000000000000000,0.00000000000000000000,2.71743326181287558895,0.00000000000000000000,28.7602341554065787931,3.00000000000000000000,0.00026923073232438285,0.17315574581145806720,0.98489441830446500247,100.000000000000000000,0.31759750311255868782,0.31759750311255868782,0.00000000000000001228,0.00000000000000000075,10028.3249185678359935,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -11.0000000000000000000,0.00000000000000000000,3.49384282019627034898,0.00000000000000000000,28.7602348407926911022,1.00000000000000000000,0.00034615379597178157,0.17315574170144260035,0.98489439499540898381,100.000000000000000000,0.31759751309173933631,0.31759751309173933631,0.00000000000000001228,0.00000000000000000075,10028.3251565996233694,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -11.0000000000000000000,1.00000000000000000000,3.83019245977470124131,0.00000000000000000000,-5.4800007878455039289,1.00000000000000000000,0.00034615379597178157,0.99999981508876789604,-0.0004999999791666098,100.000000000000000000,0.31759751309173933631,0.31759751309173933631,0.00000000000000001228,0.00000000000000000075,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -12.0000000000000000000,0.00000000000000000000,4.27025241983588177419,0.00000000000000000000,28.7602356975221482571,3.00000000000000000000,0.00042307685757093292,0.17315573656392332924,0.98489436585908929355,100.000000000000000000,0.31759752556571563264,0.31759752556571563264,0.00000000000000001228,0.00000000000000000075,10028.3254541393671388,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -13.0000000000000000000,0.00000000000000000000,5.04666206989976373620,0.00000000000000000000,28.7602367256004072260,3.00000000000000000000,0.00049999991666667084,0.17315573039890028161,0.98489433089550615374,100.000000000000000000,0.31759754053448729926,0.31759754053448729926,0.00000000000000001228,0.00000000000000000075,10028.3258111870818538,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -14.0000000000000000000,0.00000000000000000000,-5.0444781135724188203,0.00000000000000000000,24.3249423472407215740,1.00000000000000000000,-0.0004999999344181487,0.17323149099837553688,0.98488100830838709587,100.000000000000000000,0.31741362901571978927,0.31741362901571978927,0.00000000000000001228,0.00000000000000000075,10023.9575419242210045,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -14.0000000000000000000,1.00000000000000000000,-5.5325004583333798890,0.00000000000000000000,-4.6369239363243845986,1.00000000000000000000,-0.0004999999344181487,0.99999978550297363710,-0.0004230769104555109,100.000000000000000000,0.31741362901571978927,0.31741362901571978927,0.00000000000000001228,0.00000000000000000075,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -15.0000000000000000000,0.00000000000000000000,-4.2684044568996206692,0.00000000000000000000,24.3249414780875667929,3.00000000000000000000,-0.0004230768725914143,0.17323149716339880654,0.98488104327197145693,100.000000000000000000,0.31741361405287105146,0.31741361405287105146,0.00000000000000001228,0.00000000000000000075,10023.9571851881028123,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -16.0000000000000000000,0.00000000000000000000,-3.4923308505961156988,0.00000000000000000000,24.3249407537950901314,3.00000000000000000000,-0.0003461538082612664,0.17323150230091827195,0.98488107240829225741,100.000000000000000000,0.31741360158383002953,0.31741360158383002953,0.00000000000000001228,0.00000000000000000075,10023.9568879080234182,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -17.0000000000000000000,0.00000000000000000000,-2.7162572855038473740,0.00000000000000000000,24.3249401743596536107,3.00000000000000000000,-0.0002692307418828711,0.17323150641093387758,0.98488109571734905323,100.000000000000000000,0.31741359160859772270,0.31741359160859772270,0.00000000000000001228,0.00000000000000000075,10023.9566500839682703,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -18.0000000000000000000,0.00000000000000000000,-1.9401837524647629340,0.00000000000000000000,24.3249397397867141989,3.00000000000000000000,-0.0001923076739113946,0.17323150949344559568,0.98488111319914184438,100.000000000000000000,0.31741358412717290971,0.31741358412717290971,0.00000000000000001228,0.00000000000000000075,10023.9564717159373685,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -19.0000000000000000000,0.00000000000000000000,-1.1641102423208065097,0.00000000000000000000,24.3249394500653579598,3.00000000000000000000,-0.0001153846048020029,0.17323151154845342625,0.98488112485367018678,100.000000000000000000,0.31741357913955658975,0.31741357913955658975,0.00000000000000001228,0.00000000000000000075,10023.9563528039143420,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -20.0000000000000000000,0.00000000000000000000,-0.3880367459139265062,0.00000000000000000000,24.3249393052064988296,3.00000000000000000000,-0.0000384615350098619,0.17323151257595734153,0.98488113068093452451,100.000000000000000000,0.31741357664574854080,0.31741357664574854080,0.00000000000000001228,0.00000000000000000075,10023.9562933479046478,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -21.0000000000000000000,0.00000000000000000000,0.38803674591392650627,0.00000000000000000000,24.3249393052064988296,1.00000000000000000000,0.00003846153500986195,0.17323151257595734153,0.98488113068093452451,100.000000000000000000,0.31741357664574854080,0.31741357664574854080,0.00000000000000001228,0.00000000000000000075,10023.9562933479046478,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -21.0000000000000000000,1.00000000000000000000,0.42557692328554053151,0.00000000000000000000,-4.6369233580353697021,1.00000000000000000000,0.00003846153500986195,0.99999990976331476488,-0.0004230769104555109,100.000000000000000000,0.31741357664574854080,0.31741357664574854080,0.00000000000000001228,0.00000000000000000075,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -22.0000000000000000000,0.00000000000000000000,1.16411024232080650975,0.00000000000000000000,24.3249394500653579598,1.00000000000000000000,0.00011538460480200291,0.17323151154845342625,0.98488112485367018678,100.000000000000000000,0.31741357913955658975,0.31741357913955658975,0.00000000000000001228,0.00000000000000000075,10023.9563528039143420,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -22.0000000000000000000,1.00000000000000000000,1.27673077486345065700,0.00000000000000000000,-4.6369233855731017968,1.00000000000000000000,0.00011538460480200291,0.99999990384615544680,-0.0004230769104555109,100.000000000000000000,0.31741357913955658975,0.31741357913955658975,0.00000000000000001228,0.00000000000000000075,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -23.0000000000000000000,0.00000000000000000000,1.94018375246476337814,0.00000000000000000000,24.3249397397867141989,3.00000000000000000000,0.00019230767391139474,0.17323150949344559568,0.98488111319914184438,100.000000000000000000,0.31741358412717290971,0.31741358412717290971,0.00000000000000001228,0.00000000000000000075,10023.9564717159373685,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -24.0000000000000000000,0.00000000000000000000,2.71625728550384737403,0.00000000000000000000,24.3249401743596536107,3.00000000000000000000,0.00026923074188287118,0.17323150641093387758,0.98488109571734905323,100.000000000000000000,0.31741359160859772270,0.31741359160859772270,0.00000000000000001228,0.00000000000000000075,10023.9566500839682703,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -25.0000000000000000000,0.00000000000000000000,3.49233085059611569889,0.00000000000000000000,24.3249407537950901314,1.00000000000000000000,0.00034615380826126648,0.17323150230091827195,0.98488107240829225741,100.000000000000000000,0.31741360158383002953,0.31741360158383002953,0.00000000000000001228,0.00000000000000000075,10023.9568879080234182,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -25.0000000000000000000,1.00000000000000000000,3.83019245977470035313,0.00000000000000000000,-4.6369236334108618891,1.00000000000000000000,0.00034615380826126648,0.99999985059172313839,-0.0004230769104555109,100.000000000000000000,0.31741360158383002953,0.31741360158383002953,0.00000000000000001228,0.00000000000000000075,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -26.0000000000000000000,0.00000000000000000000,4.26840445689962155739,0.00000000000000000000,24.3249414780875667929,3.00000000000000000000,0.00042307687259141442,0.17323149716339880654,0.98488104327197145693,100.000000000000000000,0.31741361405287105146,0.31741361405287105146,0.00000000000000001228,0.00000000000000000075,10023.9571851881028123,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -27.0000000000000000000,0.00000000000000000000,5.04447811357241882035,0.00000000000000000000,24.3249423472407215740,1.00000000000000000000,0.00049999993441814875,0.17323149099837553688,0.98488100830838709587,100.000000000000000000,0.31741362901571978927,0.31741362901571978927,0.00000000000000001228,0.00000000000000000075,10023.9575419242210045,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -27.0000000000000000000,1.00000000000000000000,5.53250045833337988909,0.00000000000000000000,-4.6369239363243845986,1.00000000000000000000,0.00049999993441814875,0.99999978550297363710,-0.0004230769104555109,100.000000000000000000,0.31741362901571978927,0.31741362901571978927,0.00000000000000001228,0.00000000000000000075,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -28.0000000000000000000,0.00000000000000000000,-5.0422960666489791137,0.00000000000000000000,19.8935256876375206047,3.00000000000000000000,-0.0004999999492110472,0.17330725057281240464,0.98486767989356982511,100.000000000000000000,0.31722979275823870448,0.31722979275823870448,0.00000000000000001228,0.00000000000000000075,10019.5931510672453441,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -29.0000000000000000000,0.00000000000000000000,-4.2665581096126654614,0.00000000000000000000,19.8935249771348026115,3.00000000000000000000,-0.0004230768851084824,0.17330725673783586859,0.98486771485715529639,100.000000000000000000,0.31722977780131011993,0.31722977780131011993,0.00000000000000001228,0.00000000000000000075,10019.5927946423180401,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -30.0000000000000000000,0.00000000000000000000,-3.4908202028907440173,0.00000000000000000000,19.8935243850464757997,1.00000000000000000000,-0.0003461538185025041,0.17330726187535550053,0.98486774399347698505,100.000000000000000000,0.31722976533720359526,0.31722976533720359526,0.00000000000000001228,0.00000000000000000075,10019.5924976215574133,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -30.0000000000000000000,1.00000000000000000000,-3.8301924597746994649,0.00000000000000000000,-3.7938465340528182423,1.00000000000000000000,-0.0003461538185025041,0.99999988017751939572,-0.0003461538392409702,100.000000000000000000,0.31722976533720359526,0.31722976533720359526,0.00000000000000001228,0.00000000000000000075,11000.0013180474416003,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -31.0000000000000000000,0.00000000000000000000,-2.7150823373351404832,0.00000000000000000000,19.8935239113779971376,3.00000000000000000000,-0.0002692307498482782,0.17330726598537121718,0.98486776730253444700,100.000000000000000000,0.31722975536591824230,0.31722975536591824230,0.00000000000000001228,0.00000000000000000075,10019.5922600049616448,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -32.0000000000000000000,0.00000000000000000000,-1.9393445037977836697,0.00000000000000000000,19.8935235561257286462,3.00000000000000000000,-0.0001923076796009712,0.17330726906788304630,0.98486778478432768224,100.000000000000000000,0.31722974788745389451,0.31722974788745389451,0.00000000000000001228,0.00000000000000000075,10019.5920817925198207,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -33.0000000000000000000,0.00000000000000000000,-1.1636066931306008331,0.00000000000000000000,19.8935233192896703258,3.00000000000000000000,-0.0001153846082157488,0.17330727112289093239,0.98486779643885657975,100.000000000000000000,0.31722974290181160661,0.31722974290181160661,0.00000000000000001228,0.00000000000000000075,10019.5919629842264839,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -34.0000000000000000000,0.00000000000000000000,-0.3878688961855217276,0.00000000000000000000,19.8935232008734601549,3.00000000000000000000,-0.0000384615361477772,0.17330727215039484767,0.98486780226612091748,100.000000000000000000,0.31722974040898999081,0.31722974040898999081,0.00000000000000001228,0.00000000000000000075,10019.5919035800852725,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -35.0000000000000000000,0.00000000000000000000,0.38786889618552172764,0.00000000000000000000,19.8935232008734601549,3.00000000000000000000,0.00003846153614777726,0.17330727215039484767,0.98486780226612091748,100.000000000000000000,0.31722974040898999081,0.31722974040898999081,0.00000000000000001228,0.00000000000000000075,10019.5919035800852725,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -36.0000000000000000000,0.00000000000000000000,1.16360669313060083318,0.00000000000000000000,19.8935233192896703258,1.00000000000000000000,0.00011538460821574884,0.17330727112289093239,0.98486779643885657975,100.000000000000000000,0.31722974290181160661,0.31722974290181160661,0.00000000000000001228,0.00000000000000000075,10019.5919629842264839,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -36.0000000000000000000,1.00000000000000000000,1.27673077486345021291,0.00000000000000000000,-3.7938463312762600310,1.00000000000000000000,0.00011538460821574884,0.99999993343195359152,-0.0003461538392409146,100.000000000000000000,0.31722974290181160661,0.31722974290181160661,0.00000000000000001228,0.00000000000000000075,11000.0007322485580516,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -37.0000000000000000000,0.00000000000000000000,1.93934450379778411388,0.00000000000000000000,19.8935235561257286462,3.00000000000000000000,0.00019230767960097126,0.17330726906788304630,0.98486778478432768224,100.000000000000000000,0.31722974788745389451,0.31722974788745389451,0.00000000000000001228,0.00000000000000000075,10019.5920817925198207,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -38.0000000000000000000,0.00000000000000000000,2.71508233733514048324,0.00000000000000000000,19.8935239113779971376,3.00000000000000000000,0.00026923074984827827,0.17330726598537121718,0.98486776730253444700,100.000000000000000000,0.31722975536591824230,0.31722975536591824230,0.00000000000000001228,0.00000000000000000075,10019.5922600049616448,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -39.0000000000000000000,0.00000000000000000000,3.49082020289074401731,0.00000000000000000000,19.8935243850464757997,3.00000000000000000000,0.00034615381850250414,0.17330726187535550053,0.98486774399347698505,100.000000000000000000,0.31722976533720359526,0.31722976533720359526,0.00000000000000001228,0.00000000000000000075,10019.5924976215574133,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -40.0000000000000000000,0.00000000000000000000,4.26655810961266546144,0.00000000000000000000,19.8935249771348026115,3.00000000000000000000,0.00042307688510848247,0.17330725673783586859,0.98486771485715529639,100.000000000000000000,0.31722977780131011993,0.31722977780131011993,0.00000000000000001228,0.00000000000000000075,10019.5927946423180401,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -41.0000000000000000000,0.00000000000000000000,5.04229606664897911372,0.00000000000000000000,19.8935256876375206047,1.00000000000000000000,0.00049999994921104721,0.17330725057281240464,0.98486767989356982511,100.000000000000000000,0.31722979275823870448,0.31722979275823870448,0.00000000000000001228,0.00000000000000000075,10019.5931510672453441,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -41.0000000000000000000,1.00000000000000000000,5.53250045833338077727,0.00000000000000000000,-3.7938467818895524885,1.00000000000000000000,0.00049999994921104721,0.99999981508876789604,-0.0003461538392409146,100.000000000000000000,0.31722979275823870448,0.31722979275823870448,0.00000000000000001228,0.00000000000000000075,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -42.0000000000000000000,0.00000000000000000000,-5.0401159266005981507,0.00000000000000000000,15.4659816110743122408,3.00000000000000000000,-0.0004999999610453660,0.17338300912176257684,0.98485434565113327831,100.000000000000000000,0.31704603174005918653,0.31704603174005918653,0.00000000000000001227,0.00000000000000000075,10015.2326334806402883,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -43.0000000000000000000,0.00000000000000000000,-4.2647133758352211430,0.00000000000000000000,15.4659810589419066673,1.00000000000000000000,-0.0004230768951221369,0.17338301528678617957,0.98485438061471952675,100.000000000000000000,0.31704601678904942296,0.31704601678904942296,0.00000000000000001227,0.00000000000000000075,10015.2322773664891428,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -43.0000000000000000000,1.00000000000000000000,-4.6813464315164798890,0.00000000000000000000,-2.9507695673749601006,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,-0.0002692307659781789,100.000000000000000000,0.31704601678904942296,0.31704601678904942296,0.00000000000000001227,0.00000000000000000075,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -44.0000000000000000000,0.00000000000000000000,-3.4893108753294135304,0.00000000000000000000,15.4659805988285370403,3.00000000000000000000,-0.0003461538266954942,0.17338302042430592253,0.98485440975104188154,100.000000000000000000,0.31704600432987484204,0.31704600432987484204,0.00000000000000001227,0.00000000000000000075,10015.2319806047071324,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -45.0000000000000000000,0.00000000000000000000,-2.7139084159450681532,0.00000000000000000000,15.4659802307414793176,1.00000000000000000000,-0.0002692307562206040,0.17338302453432172245,0.98485443306009978758,100.000000000000000000,0.31704599436253599886,0.31704599436253599886,0.00000000000000001227,0.00000000000000000075,10015.2317431952978949,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -45.0000000000000000000,1.00000000000000000000,-2.9790385330943731645,0.00000000000000000000,-2.9507694096595944444,1.00000000000000000000,-0.0002692307562206040,0.99999992751479449548,-0.0002692307659781789,100.000000000000000000,0.31704599436253599886,0.31704599436253599886,0.00000000000000001227,0.00000000000000000075,11000.0007973373176355,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -46.0000000000000000000,0.00000000000000000000,-1.9385059885440800719,0.00000000000000000000,15.4659799546752765309,1.00000000000000000000,-0.0001923076841526324,0.17338302761683363484,0.98485445054189346691,100.000000000000000000,0.31704598688703156117,0.31704598688703156117,0.00000000000000001227,0.00000000000000000075,10015.2315651382450596,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -46.0000000000000000000,1.00000000000000000000,-2.1278846414618417526,0.00000000000000000000,-2.9507693570878577027,1.00000000000000000000,-0.0001923076841526324,0.99999994526627300484,-0.0002692307659781789,100.000000000000000000,0.31704598688703156117,0.31704598688703156117,0.00000000000000001227,0.00000000000000000075,11000.0006020710279699,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -47.0000000000000000000,0.00000000000000000000,-1.1631035839883467897,0.00000000000000000000,15.4659797706299286801,1.00000000000000000000,-0.0001153846109467456,0.17338302967184154868,0.98485446219642258647,100.000000000000000000,0.31704598190336208407,0.31704598190336208407,0.00000000000000001227,0.00000000000000000075,10015.2314464335449883,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -47.0000000000000000000,1.00000000000000000000,-1.2767307748634502129,0.00000000000000000000,-2.9507693220401352007,1.00000000000000000000,-0.0001153846109467456,0.99999995710059197406,-0.0002692307659782344,100.000000000000000000,0.31704598190336208407,0.31704598190336208407,0.00000000000000001227,0.00000000000000000075,11000.0004718935069831,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -48.0000000000000000000,0.00000000000000000000,-0.3877011931397650323,0.00000000000000000000,15.4659796786090737441,3.00000000000000000000,-0.0000384615370581095,0.17338303069934551947,0.98485446802368714624,100.000000000000000000,0.31704597941152712348,0.31704597941152712348,0.00000000000000001227,0.00000000000000000075,10015.2313870811976812,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -49.0000000000000000000,0.00000000000000000000,0.38770119313976503239,0.00000000000000000000,15.4659796786090737441,3.00000000000000000000,0.00003846153705810951,0.17338303069934551947,0.98485446802368714624,100.000000000000000000,0.31704597941152712348,0.31704597941152712348,0.00000000000000001227,0.00000000000000000075,10015.2313870811976812,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -50.0000000000000000000,0.00000000000000000000,1.16310358398834678972,0.00000000000000000000,15.4659797706299286801,3.00000000000000000000,0.00011538461094674560,0.17338302967184154868,0.98485446219642258647,100.000000000000000000,0.31704598190336208407,0.31704598190336208407,0.00000000000000001227,0.00000000000000000075,10015.2314464335449883,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -51.0000000000000000000,0.00000000000000000000,1.93850598854408051607,0.00000000000000000000,15.4659799546752765309,1.00000000000000000000,0.00019230768415263250,0.17338302761683363484,0.98485445054189346691,100.000000000000000000,0.31704598688703156117,0.31704598688703156117,0.00000000000000001227,0.00000000000000000075,10015.2315651382450596,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -51.0000000000000000000,1.00000000000000000000,2.12788464146184219671,0.00000000000000000000,-2.9507693570878577027,1.00000000000000000000,0.00019230768415263250,0.99999994526627300484,-0.0002692307659781789,100.000000000000000000,0.31704598688703156117,0.31704598688703156117,0.00000000000000001227,0.00000000000000000075,11000.0006020710279699,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -52.0000000000000000000,0.00000000000000000000,2.71390841594506815326,0.00000000000000000000,15.4659802307414793176,3.00000000000000000000,0.00026923075622060400,0.17338302453432172245,0.98485443306009978758,100.000000000000000000,0.31704599436253599886,0.31704599436253599886,0.00000000000000001227,0.00000000000000000075,10015.2317431952978949,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -53.0000000000000000000,0.00000000000000000000,3.48931087532941353046,0.00000000000000000000,15.4659805988285370403,3.00000000000000000000,0.00034615382669549426,0.17338302042430592253,0.98485440975104188154,100.000000000000000000,0.31704600432987484204,0.31704600432987484204,0.00000000000000001227,0.00000000000000000075,10015.2319806047071324,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -54.0000000000000000000,0.00000000000000000000,4.26471337583522203118,0.00000000000000000000,15.4659810589419066673,3.00000000000000000000,0.00042307689512213698,0.17338301528678617957,0.98485438061471952675,100.000000000000000000,0.31704601678904942296,0.31704601678904942296,0.00000000000000001227,0.00000000000000000075,10015.2322773664891428,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -55.0000000000000000000,0.00000000000000000000,5.04011592660059815074,0.00000000000000000000,15.4659816110743122408,3.00000000000000000000,0.00049999996104536600,0.17338300912176257684,0.98485434565113327831,100.000000000000000000,0.31704603174005918653,0.31704603174005918653,0.00000000000000001227,0.00000000000000000075,10015.2326334806402883,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -56.0000000000000000000,0.00000000000000000000,-5.0379376909028907860,0.00000000000000000000,11.0423049908895336557,3.00000000000000000000,-0.0004999999699211052,0.17345876664477777318,0.98484100558115605927,100.000000000000000000,0.31686234593921425162,0.31686234593921425162,0.00000000000000001227,0.00000000000000000075,10010.8759840379534580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -57.0000000000000000000,0.00000000000000000000,-4.2628702534312719052,0.00000000000000000000,11.0423045968527731020,3.00000000000000000000,-0.0004230769026323778,0.17345877280980148693,0.98484104054474297385,100.000000000000000000,0.31686233099412175473,0.31686233099412175473,0.00000000000000001227,0.00000000000000000075,10010.8756282341673795,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -58.0000000000000000000,0.00000000000000000000,-3.4878028661644737695,0.00000000000000000000,11.0423042684888059739,3.00000000000000000000,-0.0003461538328402369,0.17345877794732134091,0.98484106968106577273,100.000000000000000000,0.31686231853987911755,0.31686231853987911755,0.00000000000000001227,0.00000000000000000075,10010.8753317310292914,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -59.0000000000000000000,0.00000000000000000000,-2.7127355199743448110,0.00000000000000000000,11.0423040057958132820,3.00000000000000000000,-0.0002692307609998483,0.17345878205733722410,0.98484109299012412286,100.000000000000000000,0.31686230857648456371,0.31686230857648456371,0.00000000000000001227,0.00000000000000000075,10010.8750945285282796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -60.0000000000000000000,0.00000000000000000000,-1.9376682057327345720,0.00000000000000000000,11.0423038087774330051,3.00000000000000000000,-0.0001923076875663784,0.17345878513984916424,0.98484111047191813526,100.000000000000000000,0.31686230110393920345,0.31686230110393920345,0.00000000000000001227,0.00000000000000000075,10010.8749166266588872,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -61.0000000000000000000,0.00000000000000000000,-1.1626009143114937050,0.00000000000000000000,11.0423036774336651433,3.00000000000000000000,-0.0001153846129949931,0.17345878719485713359,0.98484112212644736583,100.000000000000000000,0.31686229612224192653,0.31686229612224192653,0.00000000000000001227,0.00000000000000000075,10010.8747980254174763,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -62.0000000000000000000,0.00000000000000000000,-0.3875336365824728623,0.00000000000000000000,11.0423036117590527283,1.00000000000000000000,-0.0000384615377408587,0.17345878822236113214,0.98484112795371214765,100.000000000000000000,0.31686229363139306602,0.31686229363139306602,0.00000000000000001227,0.00000000000000000075,10010.8747387247949518,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -62.0000000000000000000,1.00000000000000000000,-0.4255769232855404760,0.00000000000000000000,-2.1076923353344878542,1.00000000000000000000,-0.0000384615377408587,0.99999998076923068968,-0.0001923076911223842,100.000000000000000000,0.31686229363139306602,0.31686229363139306602,0.00000000000000001227,0.00000000000000000075,11000.0002115384631906,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -63.0000000000000000000,0.00000000000000000000,0.38753363658247286238,0.00000000000000000000,11.0423036117590527283,3.00000000000000000000,0.00003846153774085871,0.17345878822236113214,0.98484112795371214765,100.000000000000000000,0.31686229363139306602,0.31686229363139306602,0.00000000000000001227,0.00000000000000000075,10010.8747387247949518,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -64.0000000000000000000,0.00000000000000000000,1.16260091431149370500,0.00000000000000000000,11.0423036774336651433,3.00000000000000000000,0.00011538461299499319,0.17345878719485713359,0.98484112212644736583,100.000000000000000000,0.31686229612224192653,0.31686229612224192653,0.00000000000000001227,0.00000000000000000075,10010.8747980254174763,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -65.0000000000000000000,0.00000000000000000000,1.93766820573273523820,0.00000000000000000000,11.0423038087774330051,3.00000000000000000000,0.00019230768756637849,0.17345878513984916424,0.98484111047191813526,100.000000000000000000,0.31686230110393920345,0.31686230110393920345,0.00000000000000001227,0.00000000000000000075,10010.8749166266588872,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -66.0000000000000000000,0.00000000000000000000,2.71273551997434481108,0.00000000000000000000,11.0423040057958132820,1.00000000000000000000,0.00026923076099984833,0.17345878205733722410,0.98484109299012412286,100.000000000000000000,0.31686230857648456371,0.31686230857648456371,0.00000000000000001227,0.00000000000000000075,10010.8750945285282796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -66.0000000000000000000,1.00000000000000000000,2.97903853309437360863,0.00000000000000000000,-2.1076924104369556545,1.00000000000000000000,0.00026923076099984833,0.99999994526627289381,-0.0001923076911223287,100.000000000000000000,0.31686230857648456371,0.31686230857648456371,0.00000000000000001227,0.00000000000000000075,11000.0006020710297889,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -67.0000000000000000000,0.00000000000000000000,3.48780286616447376957,0.00000000000000000000,11.0423042684888059739,1.00000000000000000000,0.00034615383284023691,0.17345877794732134091,0.98484106968106577273,100.000000000000000000,0.31686231853987911755,0.31686231853987911755,0.00000000000000001227,0.00000000000000000075,10010.8753317310292914,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -67.0000000000000000000,1.00000000000000000000,3.83019245977469990904,0.00000000000000000000,-2.1076924605053104500,1.00000000000000000000,0.00034615383284023691,0.99999992159763473331,-0.0001923076911223287,100.000000000000000000,0.31686231853987911755,0.31686231853987911755,0.00000000000000001227,0.00000000000000000075,11000.0008624260844953,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -68.0000000000000000000,0.00000000000000000000,4.26287025343127279342,0.00000000000000000000,11.0423045968527731020,3.00000000000000000000,0.00042307690263237795,0.17345877280980148693,0.98484104054474297385,100.000000000000000000,0.31686233099412175473,0.31686233099412175473,0.00000000000000001227,0.00000000000000000075,10010.8756282341673795,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -69.0000000000000000000,0.00000000000000000000,5.03793769090289078604,0.00000000000000000000,11.0423049908895336557,1.00000000000000000000,0.00049999996992110523,0.17345876664477777318,0.98484100558115605927,100.000000000000000000,0.31686234593921425162,0.31686234593921425162,0.00000000000000001227,0.00000000000000000075,10010.8759840379534580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -69.0000000000000000000,1.00000000000000000000,5.53250045833337988909,0.00000000000000000000,-2.1076925981927949749,1.00000000000000000000,0.00049999996992110523,0.99999985650888068011,-0.0001923076911223842,100.000000000000000000,0.31686234593921425162,0.31686234593921425162,0.00000000000000001227,0.00000000000000000075,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -70.0000000000000000000,0.00000000000000000000,-5.0357613570359269772,0.00000000000000000000,6.62249070948018925264,3.00000000000000000000,-0.0004999999758382646,0.17353452314140974110,0.98482765968371710485,100.000000000000000000,0.31667873533375567873,0.31667873533375567873,0.00000000000000001227,0.00000000000000000075,10006.5231976217837654,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -71.0000000000000000000,0.00000000000000000000,-4.2610287402685669277,0.00000000000000000000,6.62249047326440631877,3.00000000000000000000,-0.0004230769076392051,0.17353452930643353813,0.98482769464730446351,100.000000000000000000,0.31667872039457944932,0.31667872039457944932,0.00000000000000001227,0.00000000000000000075,10006.5228421279589383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -72.0000000000000000000,0.00000000000000000000,-3.4862961736513575772,0.00000000000000000000,6.62249027641701104585,1.00000000000000000000,-0.0003461538369367320,0.17353453444395344762,0.98482772378362781751,100.000000000000000000,0.31667870794526631339,0.31667870794526631339,0.00000000000000001227,0.00000000000000000075,10006.5225458831209834,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -72.0000000000000000000,1.00000000000000000000,-3.8301924597747003531,0.00000000000000000000,-1.2646154662890023434,1.00000000000000000000,-0.0003461538369367320,0.99999993343195359152,-0.0001153846151286108,100.000000000000000000,0.31667870794526631339,0.31667870794526631339,0.00000000000000001227,0.00000000000000000075,11000.0007322485616896,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -73.0000000000000000000,0.00000000000000000000,-2.7115636480660865181,0.00000000000000000000,6.62249011893982242327,3.00000000000000000000,-0.0002692307641860112,0.17353453855396935856,0.98482774709268638968,100.000000000000000000,0.31667869798581627094,0.31667869798581627094,0.00000000000000001227,0.00000000000000000075,10006.5223088872608059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -74.0000000000000000000,0.00000000000000000000,-1.9368311543945435637,0.00000000000000000000,6.62249000083102146163,3.00000000000000000000,-0.0001923076898422090,0.17353454163648135422,0.98482776457448051310,100.000000000000000000,0.31667869051622810072,0.31667869051622810072,0.00000000000000001227,0.00000000000000000075,10006.5221311403711297,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -75.0000000000000000000,0.00000000000000000000,-1.1620986835185191932,0.00000000000000000000,6.62248992209424613974,3.00000000000000000000,-0.0001153846143604915,0.17353454369148932356,0.98482777622900996572,100.000000000000000000,0.31667868553650313501,0.31667868553650313501,0.00000000000000001227,0.00000000000000000075,10006.5220126424501358,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -76.0000000000000000000,0.00000000000000000000,-0.3873662263198047739,0.00000000000000000000,6.62248988272403948940,3.00000000000000000000,-0.0000384615381960248,0.17353454471899334987,0.98482778205627474754,100.000000000000000000,0.31667868304663993050,0.31667868304663993050,0.00000000000000001227,0.00000000000000000075,10006.5219533934887294,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -77.0000000000000000000,0.00000000000000000000,0.38736622631980477393,0.00000000000000000000,6.62248988272403948940,3.00000000000000000000,0.00003846153819602484,0.17353454471899334987,0.98482778205627474754,100.000000000000000000,0.31667868304663993050,0.31667868304663993050,0.00000000000000001227,0.00000000000000000075,10006.5219533934887294,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -78.0000000000000000000,0.00000000000000000000,1.16209868351851919321,0.00000000000000000000,6.62248992209424613974,3.00000000000000000000,0.00011538461436049158,0.17353454369148932356,0.98482777622900996572,100.000000000000000000,0.31667868553650313501,0.31667868553650313501,0.00000000000000001227,0.00000000000000000075,10006.5220126424501358,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -79.0000000000000000000,0.00000000000000000000,1.93683115439454400785,0.00000000000000000000,6.62249000083102146163,3.00000000000000000000,0.00019230768984220914,0.17353454163648135422,0.98482776457448051310,100.000000000000000000,0.31667869051622810072,0.31667869051622810072,0.00000000000000001227,0.00000000000000000075,10006.5221311403711297,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -80.0000000000000000000,0.00000000000000000000,2.71156364806608651818,0.00000000000000000000,6.62249011893982242327,3.00000000000000000000,0.00026923076418601120,0.17353453855396935856,0.98482774709268638968,100.000000000000000000,0.31667869798581627094,0.31667869798581627094,0.00000000000000001227,0.00000000000000000075,10006.5223088872608059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -81.0000000000000000000,0.00000000000000000000,3.48629617365135757722,0.00000000000000000000,6.62249027641701104585,1.00000000000000000000,0.00034615383693673202,0.17353453444395344762,0.98482772378362781751,100.000000000000000000,0.31667870794526631339,0.31667870794526631339,0.00000000000000001227,0.00000000000000000075,10006.5225458831209834,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -81.0000000000000000000,1.00000000000000000000,3.83019245977470035313,0.00000000000000000000,-1.2646154662890023434,1.00000000000000000000,0.00034615383693673202,0.99999993343195359152,-0.0001153846151286108,100.000000000000000000,0.31667870794526631339,0.31667870794526631339,0.00000000000000001227,0.00000000000000000075,11000.0007322485616896,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -82.0000000000000000000,0.00000000000000000000,4.26102874026856692779,0.00000000000000000000,6.62249047326440631877,3.00000000000000000000,0.00042307690763920520,0.17353452930643353813,0.98482769464730446351,100.000000000000000000,0.31667872039457944932,0.31667872039457944932,0.00000000000000001227,0.00000000000000000075,10006.5228421279589383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -83.0000000000000000000,0.00000000000000000000,5.03576135703592697723,0.00000000000000000000,6.62249070948018925264,1.00000000000000000000,0.00049999997583826468,0.17353452314140974110,0.98482765968371710485,100.000000000000000000,0.31667873533375567873,0.31667873533375567873,0.00000000000000001227,0.00000000000000000075,10006.5231976217837654,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -83.0000000000000000000,1.00000000000000000000,5.53250045833337988909,0.00000000000000000000,-1.2646155489016108752,1.00000000000000000000,0.00049999997583826468,0.99999986834319842810,-0.0001153846151284998,100.000000000000000000,0.31667873533375567873,0.31667873533375567873,0.00000000000000001227,0.00000000000000000075,11000.0014482250062428,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -84.0000000000000000000,0.00000000000000000000,-5.0335869224842184621,0.00000000000000000000,2.20653365826001390814,3.00000000000000000000,-0.0004999999787968444,0.17361027861121022808,0.98481430795889590701,100.000000000000000000,0.31649519990175478678,0.31649519990175478678,0.00000000000000001226,0.00000000000000000075,10002.1742691237504914,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -85.0000000000000000000,0.00000000000000000000,-4.2591888342186194904,0.00000000000000000000,2.20653357959054119419,3.00000000000000000000,-0.0004230769101426188,0.17361028477623405286,0.98481434292248337669,100.000000000000000000,0.31649518496849238236,0.31649518496849238236,0.00000000000000001226,0.00000000000000000075,10002.1739139394794619,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -86.0000000000000000000,0.00000000000000000000,-3.4847907960485748901,0.00000000000000000000,2.20653351403234410099,3.00000000000000000000,-0.0003461538389849795,0.17361028991375396235,0.98481437205880673069,100.000000000000000000,0.31649517252410763745,0.31649517252410763745,0.00000000000000001226,0.00000000000000000075,10002.1736179526014893,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -87.0000000000000000000,0.00000000000000000000,-2.7103927988658003123,0.00000000000000000000,2.20653346158360363915,3.00000000000000000000,-0.0002692307657790926,0.17361029402376992880,0.98481439536786552491,100.000000000000000000,0.31649516256860021901,0.31649516256860021901,0.00000000000000001226,0.00000000000000000075,10002.1733811631074786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -88.0000000000000000000,0.00000000000000000000,-1.9359948335620118520,0.00000000000000000000,2.20653342224977677688,3.00000000000000000000,-0.0001923076909801243,0.17361029710628195221,0.98481441284965987037,100.000000000000000000,0.31649515510196923884,0.31649515510196923884,0.00000000000000001226,0.00000000000000000075,10002.1732035709956107,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -89.0000000000000000000,0.00000000000000000000,-1.1615968910289264925,0.00000000000000000000,2.20653339602540654595,3.00000000000000000000,-0.0001153846150432407,0.17361029916128994932,0.98481442450418932299,100.000000000000000000,0.31649515012421558513,0.31649515012421558513,0.00000000000000001226,0.00000000000000000075,10002.1730851762549718,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -90.0000000000000000000,0.00000000000000000000,-0.3871989621582616614,0.00000000000000000000,2.20653338291413092520,1.00000000000000000000,-0.0000384615384236079,0.17361030018879394787,0.98481443033145410481,100.000000000000000000,0.31649514763533836969,0.31649514763533836969,0.00000000000000001226,0.00000000000000000075,10002.1730259788873809,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -90.0000000000000000000,1.00000000000000000000,-0.4255769232855404760,0.00000000000000000000,-0.4215384620603072063,1.00000000000000000000,-0.0000384615384236079,0.99999999852070975414,-0.0000384615384519948,100.000000000000000000,0.31649514763533836969,0.31649514763533836969,0.00000000000000001226,0.00000000000000000075,11000.0000162721898959,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -91.0000000000000000000,0.00000000000000000000,0.38719896215826166141,0.00000000000000000000,2.20653338291413092520,1.00000000000000000000,0.00003846153842360791,0.17361030018879394787,0.98481443033145410481,100.000000000000000000,0.31649514763533836969,0.31649514763533836969,0.00000000000000001226,0.00000000000000000075,10002.1730259788873809,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -91.0000000000000000000,1.00000000000000000000,0.42557692328554047600,0.00000000000000000000,-0.4215384620603072063,1.00000000000000000000,0.00003846153842360791,0.99999999852070975414,-0.0000384615384519948,100.000000000000000000,0.31649514763533836969,0.31649514763533836969,0.00000000000000001226,0.00000000000000000075,11000.0000162721898959,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -92.0000000000000000000,0.00000000000000000000,1.16159689102892649259,0.00000000000000000000,2.20653339602540654595,3.00000000000000000000,0.00011538461504324078,0.17361029916128994932,0.98481442450418932299,100.000000000000000000,0.31649515012421558513,0.31649515012421558513,0.00000000000000001226,0.00000000000000000075,10002.1730851762549718,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -93.0000000000000000000,0.00000000000000000000,1.93599483356201229611,0.00000000000000000000,2.20653342224977677688,3.00000000000000000000,0.00019230769098012445,0.17361029710628195221,0.98481441284965987037,100.000000000000000000,0.31649515510196923884,0.31649515510196923884,0.00000000000000001226,0.00000000000000000075,10002.1732035709956107,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -94.0000000000000000000,0.00000000000000000000,2.71039279886580031231,0.00000000000000000000,2.20653346158360363915,3.00000000000000000000,0.00026923076577909266,0.17361029402376992880,0.98481439536786552491,100.000000000000000000,0.31649516256860021901,0.31649516256860021901,0.00000000000000001226,0.00000000000000000075,10002.1733811631074786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -95.0000000000000000000,0.00000000000000000000,3.48479079604857489016,0.00000000000000000000,2.20653351403234410099,1.00000000000000000000,0.00034615383898497955,0.17361028991375396235,0.98481437205880673069,100.000000000000000000,0.31649517252410763745,0.31649517252410763745,0.00000000000000001226,0.00000000000000000075,10002.1736179526014893,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -95.0000000000000000000,1.00000000000000000000,3.83019245977469946495,0.00000000000000000000,-0.4215384870951199292,1.00000000000000000000,0.00034615383898497955,0.99999993934911268755,-0.0000384615384520503,100.000000000000000000,0.31649517252410763745,0.31649517252410763745,0.00000000000000001226,0.00000000000000000075,11000.0006671597966487,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -96.0000000000000000000,0.00000000000000000000,4.25918883421861949045,0.00000000000000000000,2.20653357959054119419,3.00000000000000000000,0.00042307691014261891,0.17361028477623405286,0.98481434292248337669,100.000000000000000000,0.31649518496849238236,0.31649518496849238236,0.00000000000000001226,0.00000000000000000075,10002.1739139394794619,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -97.0000000000000000000,0.00000000000000000000,5.03358692248421846215,0.00000000000000000000,2.20653365826001390814,1.00000000000000000000,0.00049999997879684445,0.17361027861121022808,0.98481430795889590701,100.000000000000000000,0.31649519990175478678,0.31649519990175478678,0.00000000000000001226,0.00000000000000000075,10002.1742691237504914,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -97.0000000000000000000,1.00000000000000000000,5.53250045833337900091,0.00000000000000000000,-0.4215385146319557407,1.00000000000000000000,0.00049999997879684445,0.99999987426035752413,-0.0000384615384519948,100.000000000000000000,0.31649519990175478678,0.31649519990175478678,0.00000000000000001226,0.00000000000000000075,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -98.0000000000000000000,0.00000000000000000000,-5.0314143847367125417,0.00000000000000000000,-2.2055712623514409642,3.00000000000000000000,-0.0004999999787968444,0.17368603305373095380,0.98480095040677106954,100.000000000000000000,0.31631173962129921495,0.31631173962129921495,0.00000000000000001226,0.00000000000000000075,9997.82919344448055198,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -99.0000000000000000000,0.00000000000000000000,-4.2573505331566892095,0.00000000000000000000,-2.2055711837510898476,3.00000000000000000000,-0.0004230769101426188,0.17368603921875477857,0.98480098537035853922,100.000000000000000000,0.31631172469394974733,0.31631172469394974733,0.00000000000000001226,0.00000000000000000075,9997.82883856935222866,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -100.000000000000000000,0.00000000000000000000,-3.4832867316177038574,0.00000000000000000000,-2.2055711182492814259,3.00000000000000000000,-0.0003461538389849795,0.17368604435627468807,0.98480101450668189322,100.000000000000000000,0.31631171225449228323,0.31631171225449228323,0.00000000000000001226,0.00000000000000000075,9997.82854284009590628,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -101.000000000000000000,0.00000000000000000000,-2.7092229710213810989,0.00000000000000000000,-2.2055710658478346886,3.00000000000000000000,-0.0002692307657790926,0.17368604846629065452,0.98480103781574068744,100.000000000000000000,0.31631170230292604550,0.31631170230292604550,0.00000000000000001226,0.00000000000000000075,9997.82830625670248991,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -102.000000000000000000,0.00000000000000000000,-1.9351592422693504325,0.00000000000000000000,-2.2055710265485686250,1.00000000000000000000,-0.0001923076909801243,0.17368605154880267793,0.98480105529753503290,100.000000000000000000,0.31631169483925170027,0.31631169483925170027,0.00000000000000001226,0.00000000000000000075,9997.82812881915924663,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -102.000000000000000000,1.00000000000000000000,-2.1278846414618421967,0.00000000000000000000,0.42153846956995033590,1.00000000000000000000,-0.0001923076909801243,0.99999998076923068968,0.00003846153845210587,100.000000000000000000,0.31631169483925170027,0.31631169483925170027,0.00000000000000001226,0.00000000000000000075,11000.0002115384650096,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -103.000000000000000000,0.00000000000000000000,-1.1610955362632422449,0.00000000000000000000,-2.2055710003478452563,3.00000000000000000000,-0.0001153846150432407,0.17368605360381067503,0.98480106695206448552,100.000000000000000000,0.31631168986346896998,0.31631168986346896998,0.00000000000000001226,0.00000000000000000075,9997.82801052746981440,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -104.000000000000000000,0.00000000000000000000,-0.3870318439046855907,0.00000000000000000000,-2.2055709872474835719,3.00000000000000000000,-0.0000384615384236079,0.17368605463131467359,0.98480107277932926734,100.000000000000000000,0.31631168737557746606,0.31631168737557746606,0.00000000000000001226,0.00000000000000000075,9997.82795138162509829,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -105.000000000000000000,0.00000000000000000000,0.38703184390468559072,0.00000000000000000000,-2.2055709872474835719,3.00000000000000000000,0.00003846153842360791,0.17368605463131467359,0.98480107277932926734,100.000000000000000000,0.31631168737557746606,0.31631168737557746606,0.00000000000000001226,0.00000000000000000075,9997.82795138162509829,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -106.000000000000000000,0.00000000000000000000,1.16109553626324224495,0.00000000000000000000,-2.2055710003478452563,3.00000000000000000000,0.00011538461504324078,0.17368605360381067503,0.98480106695206448552,100.000000000000000000,0.31631168986346896998,0.31631168986346896998,0.00000000000000001226,0.00000000000000000075,9997.82801052746981440,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -107.000000000000000000,0.00000000000000000000,1.93515924226935109864,0.00000000000000000000,-2.2055710265485686250,3.00000000000000000000,0.00019230769098012445,0.17368605154880267793,0.98480105529753503290,100.000000000000000000,0.31631169483925170027,0.31631169483925170027,0.00000000000000001226,0.00000000000000000075,9997.82812881915924663,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -108.000000000000000000,0.00000000000000000000,2.70922297102138109892,0.00000000000000000000,-2.2055710658478346886,3.00000000000000000000,0.00026923076577909266,0.17368604846629065452,0.98480103781574068744,100.000000000000000000,0.31631170230292604550,0.31631170230292604550,0.00000000000000001226,0.00000000000000000075,9997.82830625670248991,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -109.000000000000000000,0.00000000000000000000,3.48328673161770385746,0.00000000000000000000,-2.2055711182492814259,3.00000000000000000000,0.00034615383898497955,0.17368604435627468807,0.98480101450668189322,100.000000000000000000,0.31631171225449228323,0.31631171225449228323,0.00000000000000001226,0.00000000000000000075,9997.82854284009590628,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -110.000000000000000000,0.00000000000000000000,4.25735053315669009776,0.00000000000000000000,-2.2055711837510898476,3.00000000000000000000,0.00042307691014261891,0.17368603921875477857,0.98480098537035853922,100.000000000000000000,0.31631172469394974733,0.31631172469394974733,0.00000000000000001226,0.00000000000000000075,9997.82883856935222866,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -111.000000000000000000,0.00000000000000000000,5.03141438473671254172,0.00000000000000000000,-2.2055712623514409642,3.00000000000000000000,0.00049999997879684445,0.17368603305373095380,0.98480095040677106954,100.000000000000000000,0.31631173962129921495,0.31631173962129921495,0.00000000000000001226,0.00000000000000000075,9997.82919344448055198,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -112.000000000000000000,0.00000000000000000000,-5.0292437412867760926,0.00000000000000000000,-6.6138291429597302339,3.00000000000000000000,-0.0004999999758382646,0.17376178646852366571,0.98478758702742141828,100.000000000000000000,0.31612835447049753012,0.31612835447049753012,0.00000000000000001225,0.00000000000000000075,9993.48796549357393814,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -113.000000000000000000,0.00000000000000000000,-4.2555138349617820381,0.00000000000000000000,-6.6138289073605847079,3.00000000000000000000,-0.0004230769076392051,0.17376179263354746273,0.98478762199100877694,100.000000000000000000,0.31612833954905894540,0.31612833954905894540,0.00000000000000001225,0.00000000000000000075,9993.48761092718450527,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -114.000000000000000000,0.00000000000000000000,-3.4817839786233837351,0.00000000000000000000,-6.6138287110261444468,1.00000000000000000000,-0.0003461538369367320,0.17376179777106737223,0.98478765112733213094,100.000000000000000000,0.31612832711452720779,0.31612832711452720779,0.00000000000000001225,0.00000000000000000075,9993.48731545521150110,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -114.000000000000000000,1.00000000000000000000,-3.8301924597747003531,0.00000000000000000000,1.26461546628947685277,1.00000000000000000000,-0.0003461538369367320,0.99999993343195348050,0.00011538461512861086,100.000000000000000000,0.31612832711452720779,0.31612832711452720779,0.00000000000000001225,0.00000000000000000075,11000.0007322485580516,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -115.000000000000000000,0.00000000000000000000,-2.7080541631831041016,0.00000000000000000000,-6.6138285539582284400,3.00000000000000000000,-0.0002692307641860112,0.17376180188108328317,0.98478767443639070311,100.000000000000000000,0.31612831716690215078,0.31612831716690215078,0.00000000000000001225,0.00000000000000000075,9993.48707907764583069,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -116.000000000000000000,0.00000000000000000000,-1.9343243795524711625,0.00000000000000000000,-6.6138284361586556769,3.00000000000000000000,-0.0001923076898422090,0.17376180496359527882,0.98478769191818482653,100.000000000000000000,0.31612830970618266412,0.31612830970618266412,0.00000000000000001225,0.00000000000000000075,9993.48690179447476111,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -117.000000000000000000,0.00000000000000000000,-1.1605946186430131650,0.00000000000000000000,-6.6138283576256071683,3.00000000000000000000,-0.0001153846143604915,0.17376180701860324817,0.98478770357271427915,100.000000000000000000,0.31612830473237019113,0.31612830473237019113,0.00000000000000001225,0.00000000000000000075,9993.48678360569647338,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -118.000000000000000000,0.00000000000000000000,-0.3868648713662589666,0.00000000000000000000,-6.6138283183590829139,1.00000000000000000000,-0.0000384615381960248,0.17376180804610727448,0.98478770939997906097,100.000000000000000000,0.31612830224546339952,0.31612830224546339952,0.00000000000000001225,0.00000000000000000075,9993.48672451130914851,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -118.000000000000000000,1.00000000000000000000,-0.4255769232855404204,0.00000000000000000000,1.26461539118663601755,1.00000000000000000000,-0.0000384615381960248,0.99999999260354999197,0.00011538461512861086,100.000000000000000000,0.31612830224546339952,0.31612830224546339952,0.00000000000000001225,0.00000000000000000075,11000.0000813609476608,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -119.000000000000000000,0.00000000000000000000,0.38686487136625896665,0.00000000000000000000,-6.6138283183590829139,1.00000000000000000000,0.00003846153819602484,0.17376180804610727448,0.98478770939997906097,100.000000000000000000,0.31612830224546339952,0.31612830224546339952,0.00000000000000001225,0.00000000000000000075,9993.48672451130914851,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -119.000000000000000000,1.00000000000000000000,0.42557692328554042049,0.00000000000000000000,1.26461539118663601755,1.00000000000000000000,0.00003846153819602484,0.99999999260354999197,0.00011538461512861086,100.000000000000000000,0.31612830224546339952,0.31612830224546339952,0.00000000000000001225,0.00000000000000000075,11000.0000813609476608,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -120.000000000000000000,0.00000000000000000000,1.16059461864301316502,0.00000000000000000000,-6.6138283576256071683,1.00000000000000000000,0.00011538461436049158,0.17376180701860324817,0.98478770357271427915,100.000000000000000000,0.31612830473237019113,0.31612830473237019113,0.00000000000000001225,0.00000000000000000075,9993.48678360569647338,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -120.000000000000000000,1.00000000000000000000,1.27673077486345043496,0.00000000000000000000,1.26461539869681338643,1.00000000000000000000,0.00011538461436049158,0.99999998668639034082,0.00011538461512861086,100.000000000000000000,0.31612830473237019113,0.31612830473237019113,0.00000000000000001225,0.00000000000000000075,11000.0001464497036067,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -121.000000000000000000,0.00000000000000000000,1.93432437955247160665,0.00000000000000000000,-6.6138284361586556769,3.00000000000000000000,0.00019230768984220914,0.17376180496359527882,0.98478769191818482653,100.000000000000000000,0.31612830970618266412,0.31612830970618266412,0.00000000000000001225,0.00000000000000000075,9993.48690179447476111,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -122.000000000000000000,0.00000000000000000000,2.70805416318310410161,0.00000000000000000000,-6.6138285539582284400,3.00000000000000000000,0.00026923076418601120,0.17376180188108328317,0.98478767443639070311,100.000000000000000000,0.31612831716690215078,0.31612831716690215078,0.00000000000000001225,0.00000000000000000075,9993.48707907764583069,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -123.000000000000000000,0.00000000000000000000,3.48178397862338373514,0.00000000000000000000,-6.6138287110261444468,3.00000000000000000000,0.00034615383693673202,0.17376179777106737223,0.98478765112733213094,100.000000000000000000,0.31612832711452720779,0.31612832711452720779,0.00000000000000001225,0.00000000000000000075,9993.48731545521150110,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -124.000000000000000000,0.00000000000000000000,4.25551383496178292631,0.00000000000000000000,-6.6138289073605847079,3.00000000000000000000,0.00042307690763920520,0.17376179263354746273,0.98478762199100877694,100.000000000000000000,0.31612833954905894540,0.31612833954905894540,0.00000000000000001225,0.00000000000000000075,9993.48761092718450527,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -125.000000000000000000,0.00000000000000000000,5.02924374128677609263,0.00000000000000000000,-6.6138291429597302339,3.00000000000000000000,0.00049999997583826468,0.17376178646852366571,0.98478758702742141828,100.000000000000000000,0.31612835447049753012,0.31612835447049753012,0.00000000000000001225,0.00000000000000000075,9993.48796549357393814,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -126.000000000000000000,0.00000000000000000000,-5.0270749896321964556,0.00000000000000000000,-11.018245065186420106,3.00000000000000000000,-0.0004999999699211052,0.17383753885514013903,0.98477421782092666724,100.000000000000000000,0.31594504442747428640,0.31594504442747428640,0.00000000000000001225,0.00000000000000000074,9989.15058018961281049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -127.000000000000000000,0.00000000000000000000,-4.2536787375166413838,0.00000000000000000000,-11.018244672861328581,3.00000000000000000000,-0.0004230769026323778,0.17383754502016385279,0.98477425278451358181,100.000000000000000000,0.31594502951194536333,0.31594502951194536333,0.00000000000000001225,0.00000000000000000074,9989.15022593156027141,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -128.000000000000000000,0.00000000000000000000,-3.4802825353333131097,0.00000000000000000000,-11.018244345925268135,1.00000000000000000000,-0.0003461538328402369,0.17383755015768370677,0.98477428192083638069,100.000000000000000000,0.31594501708233724279,0.31594501708233724279,0.00000000000000001225,0.00000000000000000074,9989.14993071652861544,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -128.000000000000000000,1.00000000000000000000,-3.8301924597746999090,0.00000000000000000000,2.10769246050474201581,1.00000000000000000000,-0.0003461538328402369,0.99999992159763484433,0.00019230769112232870,100.000000000000000000,0.31594501708233724279,0.31594501708233724279,0.00000000000000001225,0.00000000000000000074,11000.0008624260826763,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -129.000000000000000000,0.00000000000000000000,-2.7068863740036230858,0.00000000000000000000,-11.018244084374600788,3.00000000000000000000,-0.0002692307609998483,0.17383755426769958996,0.98477430522989473082,100.000000000000000000,0.31594500713865192320,0.31594500713865192320,0.00000000000000001225,0.00000000000000000074,9989.14969454451784258,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -130.000000000000000000,0.00000000000000000000,-1.9334902444489825423,0.00000000000000000000,-11.018243888212964520,3.00000000000000000000,-0.0001923076875663784,0.17383755735021153010,0.98477432271168874322,100.000000000000000000,0.31594499968088762820,0.31594499968088762820,0.00000000000000001225,0.00000000000000000074,9989.14951741551340091,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -131.000000000000000000,0.00000000000000000000,-1.1600941375908047081,0.00000000000000000000,-11.018243757436721352,3.00000000000000000000,-0.0001153846129949931,0.17383755940521949945,0.98477433436621797380,100.000000000000000000,0.31594499470904435778,0.31594499470904435778,0.00000000000000001225,0.00000000000000000074,9989.14939932951529044,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -132.000000000000000000,0.00000000000000000000,-0.3866980443505037556,0.00000000000000000000,-11.018243692049509263,3.00000000000000000000,-0.0000384615377408587,0.17383756043272349800,0.98477434019348275562,100.000000000000000000,0.31594499222312311115,0.31594499222312311115,0.00000000000000001225,0.00000000000000000074,9989.14934028651623521,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -133.000000000000000000,0.00000000000000000000,0.38669804435050375568,0.00000000000000000000,-11.018243692049509263,1.00000000000000000000,0.00003846153774085871,0.17383756043272349800,0.98477434019348275562,100.000000000000000000,0.31594499222312311115,0.31594499222312311115,0.00000000000000001225,0.00000000000000000074,9989.14934028651623521,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -133.000000000000000000,1.00000000000000000000,0.42557692328554053151,0.00000000000000000000,2.10769233533416411319,1.00000000000000000000,0.00003846153774085871,0.99999998076923068968,0.00019230769112238421,100.000000000000000000,0.31594499222312311115,0.31594499222312311115,0.00000000000000001225,0.00000000000000000074,11000.0002115384650096,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -134.000000000000000000,0.00000000000000000000,1.16009413759080470818,0.00000000000000000000,-11.018243757436721352,3.00000000000000000000,0.00011538461299499319,0.17383755940521949945,0.98477433436621797380,100.000000000000000000,0.31594499470904435778,0.31594499470904435778,0.00000000000000001225,0.00000000000000000074,9989.14939932951529044,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -135.000000000000000000,0.00000000000000000000,1.93349024444898298646,0.00000000000000000000,-11.018243888212964520,3.00000000000000000000,0.00019230768756637849,0.17383755735021153010,0.98477432271168874322,100.000000000000000000,0.31594499968088762820,0.31594499968088762820,0.00000000000000001225,0.00000000000000000074,9989.14951741551340091,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -136.000000000000000000,0.00000000000000000000,2.70688637400362308582,0.00000000000000000000,-11.018244084374600788,3.00000000000000000000,0.00026923076099984833,0.17383755426769958996,0.98477430522989473082,100.000000000000000000,0.31594500713865192320,0.31594500713865192320,0.00000000000000001225,0.00000000000000000074,9989.14969454451784258,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -137.000000000000000000,0.00000000000000000000,3.48028253533331310975,0.00000000000000000000,-11.018244345925268135,3.00000000000000000000,0.00034615383284023691,0.17383755015768370677,0.98477428192083638069,100.000000000000000000,0.31594501708233724279,0.31594501708233724279,0.00000000000000001225,0.00000000000000000074,9989.14993071652861544,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -138.000000000000000000,0.00000000000000000000,4.25367873751664138382,0.00000000000000000000,-11.018244672861328581,1.00000000000000000000,0.00042307690263237795,0.17383754502016385279,0.98477425278451358181,100.000000000000000000,0.31594502951194536333,0.31594502951194536333,0.00000000000000001225,0.00000000000000000074,9989.15022593156027141,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -138.000000000000000000,1.00000000000000000000,4.68134643151648166536,0.00000000000000000000,2.10769252309018462199,1.00000000000000000000,0.00042307690263237795,0.99999989201183725473,0.00019230769112238421,100.000000000000000000,0.31594502951194536333,0.31594502951194536333,0.00000000000000001225,0.00000000000000000074,11000.0011878699187946,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -139.000000000000000000,0.00000000000000000000,5.02707498963219645560,0.00000000000000000000,-11.018245065186420106,3.00000000000000000000,0.00049999996992110523,0.17383753885514013903,0.98477421782092666724,100.000000000000000000,0.31594504442747428640,0.31594504442747428640,0.00000000000000001225,0.00000000000000000074,9989.15058018961281049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -140.000000000000000000,0.00000000000000000000,-5.0249081272751592308,0.00000000000000000000,-15.418824101730933762,1.00000000000000000000,-0.0004999999610453660,0.17391329021313212122,0.98476084278736519816,100.000000000000000000,0.31576180947037413293,0.31576180947037413293,0.00000000000000001225,0.00000000000000000074,9984.81703246010329166,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -140.000000000000000000,1.00000000000000000000,-5.5325004583333781127,0.00000000000000000000,2.95076967251699784355,1.00000000000000000000,-0.0004999999610453660,0.99999983875740372507,0.00026923076597823447,100.000000000000000000,0.31576180947037413293,0.31576180947037413293,0.00000000000000001225,0.00000000000000000074,11000.0017736688423610,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -141.000000000000000000,0.00000000000000000000,-4.2518452387077312337,0.00000000000000000000,-15.418823552952744648,3.00000000000000000000,-0.0004230768951221369,0.17391329637815572395,0.98476087775095144660,100.000000000000000000,0.31576179456075248452,0.31576179456075248452,0.00000000000000001225,0.00000000000000000074,9984.81667850998019275,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -142.000000000000000000,0.00000000000000000000,-3.4787824000182383521,0.00000000000000000000,-15.418823095638799713,1.00000000000000000000,-0.0003461538266954942,0.17391330151567546691,0.98476090688727380140,100.000000000000000000,0.31576178213606864719,0.31576178213606864719,0.00000000000000001225,0.00000000000000000074,9984.81638355155882891,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -142.000000000000000000,1.00000000000000000000,-3.8301924597747003531,0.00000000000000000000,2.95076947975442127614,1.00000000000000000000,-0.0003461538266954942,0.99999990384615666805,0.00026923076597828998,100.000000000000000000,0.31576178213606864719,0.31576178213606864719,0.00000000000000001225,0.00000000000000000074,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -143.000000000000000000,0.00000000000000000000,-2.7057196021379632533,0.00000000000000000000,-15.418822729787279968,1.00000000000000000000,-0.0002692307562206040,0.17391330562569126683,0.98476093019633170744,100.000000000000000000,0.31576177219632062254,0.31576177219632062254,0.00000000000000001225,0.00000000000000000074,9984.81614758483192417,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -143.000000000000000000,1.00000000000000000000,-2.9790385330943736086,0.00000000000000000000,2.95076940965900114122,1.00000000000000000000,-0.0002692307562206040,0.99999992751479427344,0.00026923076597823447,100.000000000000000000,0.31576177219632062254,0.31576177219632062254,0.00000000000000001225,0.00000000000000000074,11000.0007973373158165,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -144.000000000000000000,0.00000000000000000000,-1.9326568359981888267,0.00000000000000000000,-15.418822455398185411,1.00000000000000000000,-0.0001923076841526324,0.17391330870820317922,0.98476094767812538677,100.000000000000000000,0.31576176474151051998,0.31576176474151051998,0.00000000000000001225,0.00000000000000000074,9984.81597060979402158,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -144.000000000000000000,1.00000000000000000000,-2.1278846414618426408,0.00000000000000000000,2.95076935708755261345,1.00000000000000000000,-0.0001923076841526324,0.99999994526627300484,0.00026923076597823447,100.000000000000000000,0.31576176474151051998,0.31576176474151051998,0.00000000000000001225,0.00000000000000000074,11000.0006020710279699,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -145.000000000000000000,0.00000000000000000000,-1.1595940925301999602,0.00000000000000000000,-15.418822272471516043,1.00000000000000000000,-0.0001153846109467456,0.17391331076321109305,0.98476095933265450632,100.000000000000000000,0.31576175977163678521,0.31576175977163678521,0.00000000000000001225,0.00000000000000000074,9984.81585262643966416,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -145.000000000000000000,1.00000000000000000000,-1.2767307748634504349,0.00000000000000000000,2.95076932203910846652,1.00000000000000000000,-0.0001153846109467456,0.99999995710059197406,0.00026923076597823447,100.000000000000000000,0.31576175977163678521,0.31576175977163678521,0.00000000000000001225,0.00000000000000000074,11000.0004718935051641,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -146.000000000000000000,0.00000000000000000000,-0.3865313626652805978,0.00000000000000000000,-15.418822181009090854,3.00000000000000000000,-0.0000384615370581095,0.17391331179071506385,0.98476096515991906610,100.000000000000000000,0.31576175728669997333,0.31576175728669997333,0.00000000000000001225,0.00000000000000000074,9984.81579363476157595,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -147.000000000000000000,0.00000000000000000000,0.38653136266528059783,0.00000000000000000000,-15.418822181009090854,1.00000000000000000000,0.00003846153705810951,0.17391331179071506385,0.98476096515991906610,100.000000000000000000,0.31576175728669997333,0.31576175728669997333,0.00000000000000001225,0.00000000000000000074,9984.81579363476157595,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -147.000000000000000000,1.00000000000000000000,0.42557692328554047600,0.00000000000000000000,2.95076930451525054621,1.00000000000000000000,0.00003846153705810951,0.99999996301775140317,0.00026923076597828998,100.000000000000000000,0.31576175728669997333,0.31576175728669997333,0.00000000000000001225,0.00000000000000000074,11000.0004068047455803,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -148.000000000000000000,0.00000000000000000000,1.15959409253019996022,0.00000000000000000000,-15.418822272471516043,3.00000000000000000000,0.00011538461094674560,0.17391331076321109305,0.98476095933265450632,100.000000000000000000,0.31576175977163678521,0.31576175977163678521,0.00000000000000001225,0.00000000000000000074,9984.81585262643966416,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -149.000000000000000000,0.00000000000000000000,1.93265683599818927085,0.00000000000000000000,-15.418822455398185411,3.00000000000000000000,0.00019230768415263250,0.17391330870820317922,0.98476094767812538677,100.000000000000000000,0.31576176474151051998,0.31576176474151051998,0.00000000000000001225,0.00000000000000000074,9984.81597060979402158,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -150.000000000000000000,0.00000000000000000000,2.70571960213796325334,0.00000000000000000000,-15.418822729787279968,1.00000000000000000000,0.00026923075622060400,0.17391330562569126683,0.98476093019633170744,100.000000000000000000,0.31576177219632062254,0.31576177219632062254,0.00000000000000001225,0.00000000000000000074,9984.81614758483192417,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -150.000000000000000000,1.00000000000000000000,2.97903853309437360863,0.00000000000000000000,2.95076940965900114122,1.00000000000000000000,0.00026923075622060400,0.99999992751479427344,0.00026923076597823447,100.000000000000000000,0.31576177219632062254,0.31576177219632062254,0.00000000000000001225,0.00000000000000000074,11000.0007973373158165,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -151.000000000000000000,0.00000000000000000000,3.47878240001823835214,0.00000000000000000000,-15.418823095638799713,3.00000000000000000000,0.00034615382669549426,0.17391330151567546691,0.98476090688727380140,100.000000000000000000,0.31576178213606864719,0.31576178213606864719,0.00000000000000001225,0.00000000000000000074,9984.81638355155882891,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -152.000000000000000000,0.00000000000000000000,4.25184523870773123377,0.00000000000000000000,-15.418823552952744648,3.00000000000000000000,0.00042307689512213698,0.17391329637815572395,0.98476087775095144660,100.000000000000000000,0.31576179456075248452,0.31576179456075248452,0.00000000000000001225,0.00000000000000000074,9984.81667850998019275,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -153.000000000000000000,0.00000000000000000000,5.02490812727515923086,0.00000000000000000000,-15.418824101730933762,1.00000000000000000000,0.00049999996104536600,0.17391329021313212122,0.98476084278736519816,100.000000000000000000,0.31576180947037413293,0.31576180947037413293,0.00000000000000001225,0.00000000000000000074,9984.81703246010329166,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -153.000000000000000000,1.00000000000000000000,5.53250045833337811274,0.00000000000000000000,2.95076967251699784355,1.00000000000000000000,0.00049999996104536600,0.99999983875740372507,0.00026923076597823447,100.000000000000000000,0.31576180947037413293,0.31576180947037413293,0.00000000000000001225,0.00000000000000000074,11000.0017736688423610,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -154.000000000000000000,0.00000000000000000000,-5.0227431517222500545,0.00000000000000000000,-19.815571316348723485,3.00000000000000000000,-0.0004999999492110472,0.17398904054205135971,0.98474746192681661405,100.000000000000000000,0.31557864957735926036,0.31557864957735926036,0.00000000000000001224,0.00000000000000000074,9980.48731724149729416,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -155.000000000000000000,0.00000000000000000000,-4.2500133364252379308,0.00000000000000000000,-19.815570611392104183,3.00000000000000000000,-0.0004230768851084824,0.17398904670707482367,0.98474749689040208533,100.000000000000000000,0.31557863467364410947,0.31557863467364410947,0.00000000000000001224,0.00000000000000000074,9980.48696359889618179,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -156.000000000000000000,0.00000000000000000000,-3.4772835709519478442,0.00000000000000000000,-19.815570023925829445,1.00000000000000000000,-0.0003461538185025041,0.17398905184459445560,0.98474752602672377399,100.000000000000000000,0.31557862225388105814,0.31557862225388105814,0.00000000000000001224,0.00000000000000000074,9980.48666889674859703,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -156.000000000000000000,1.00000000000000000000,-3.8301924597747012413,0.00000000000000000000,3.79384653405199445685,1.00000000000000000000,-0.0003461538185025041,0.99999988017751950675,0.00034615383924102571,100.000000000000000000,0.31557862225388105814,0.31557862225388105814,0.00000000000000001224,0.00000000000000000074,11000.0013180474416003,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -157.000000000000000000,0.00000000000000000000,-2.7045538462435154691,0.00000000000000000000,-19.815569553953537251,1.00000000000000000000,-0.0002692307498482782,0.17398905595461017226,0.98474754933578123594,100.000000000000000000,0.31557861231807105006,0.31557861231807105006,0.00000000000000001224,0.00000000000000000074,9980.48643313503998797,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -157.000000000000000000,1.00000000000000000000,-2.9790385330943731645,0.00000000000000000000,3.79384644392900982623,1.00000000000000000000,-0.0002692307498482782,0.99999990384615677907,0.00034615383924097020,100.000000000000000000,0.31557861231807105006,0.31557861231807105006,0.00000000000000001224,0.00000000000000000074,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -158.000000000000000000,0.00000000000000000000,-1.9318241532410840299,0.00000000000000000000,-19.815569201475227600,3.00000000000000000000,-0.0001923076796009712,0.17398905903712200138,0.98474756681757447118,100.000000000000000000,0.31557860486621369666,0.31557860486621369666,0.00000000000000001224,0.00000000000000000074,9980.48625631376307865,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -159.000000000000000000,0.00000000000000000000,-1.1590944828857943083,0.00000000000000000000,-19.815568966487262514,1.00000000000000000000,-0.0001153846082157488,0.17398906109212988746,0.98474757847210336869,100.000000000000000000,0.31557859989830894242,0.31557859989830894242,0.00000000000000001224,0.00000000000000000074,9980.48613843291786906,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -159.000000000000000000,1.00000000000000000000,-1.2767307748634502129,0.00000000000000000000,3.79384633127566939236,1.00000000000000000000,-0.0001153846082157488,0.99999993343195359152,0.00034615383924102571,100.000000000000000000,0.31557859989830894242,0.31557859989830894242,0.00000000000000001224,0.00000000000000000074,11000.0007322485580516,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -160.000000000000000000,0.00000000000000000000,-0.3863648261187884180,0.00000000000000000000,-19.815568848993279971,3.00000000000000000000,-0.0000384615361477772,0.17398906211963380274,0.98474758429936770642,100.000000000000000000,0.31557859741435623224,0.31557859741435623224,0.00000000000000001224,0.00000000000000000074,9980.48607949249526427,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -161.000000000000000000,0.00000000000000000000,0.38636482611878841808,0.00000000000000000000,-19.815568848993279971,3.00000000000000000000,0.00003846153614777726,0.17398906211963380274,0.98474758429936770642,100.000000000000000000,0.31557859741435623224,0.31557859741435623224,0.00000000000000001224,0.00000000000000000074,9980.48607949249526427,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -162.000000000000000000,0.00000000000000000000,1.15909448288579430830,0.00000000000000000000,-19.815568966487262514,3.00000000000000000000,0.00011538460821574884,0.17398906109212988746,0.98474757847210336869,100.000000000000000000,0.31557859989830894242,0.31557859989830894242,0.00000000000000001224,0.00000000000000000074,9980.48613843291786906,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -163.000000000000000000,0.00000000000000000000,1.93182415324108469611,0.00000000000000000000,-19.815569201475227600,3.00000000000000000000,0.00019230767960097126,0.17398905903712200138,0.98474756681757447118,100.000000000000000000,0.31557860486621369666,0.31557860486621369666,0.00000000000000001224,0.00000000000000000074,9980.48625631376307865,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -164.000000000000000000,0.00000000000000000000,2.70455384624351546918,0.00000000000000000000,-19.815569553953537251,1.00000000000000000000,0.00026923074984827827,0.17398905595461017226,0.98474754933578123594,100.000000000000000000,0.31557861231807105006,0.31557861231807105006,0.00000000000000001224,0.00000000000000000074,9980.48643313503998797,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -164.000000000000000000,1.00000000000000000000,2.97903853309437316454,0.00000000000000000000,3.79384644392900982623,1.00000000000000000000,0.00026923074984827827,0.99999990384615677907,0.00034615383924097020,100.000000000000000000,0.31557861231807105006,0.31557861231807105006,0.00000000000000001224,0.00000000000000000074,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -165.000000000000000000,0.00000000000000000000,3.47728357095194784420,0.00000000000000000000,-19.815570023925829445,3.00000000000000000000,0.00034615381850250414,0.17398905184459445560,0.98474752602672377399,100.000000000000000000,0.31557862225388105814,0.31557862225388105814,0.00000000000000001224,0.00000000000000000074,9980.48666889674859703,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -166.000000000000000000,0.00000000000000000000,4.25001333642523881906,0.00000000000000000000,-19.815570611392104183,3.00000000000000000000,0.00042307688510848247,0.17398904670707482367,0.98474749689040208533,100.000000000000000000,0.31557863467364410947,0.31557863467364410947,0.00000000000000001224,0.00000000000000000074,9980.48696359889618179,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -167.000000000000000000,0.00000000000000000000,5.02274315172225005454,0.00000000000000000000,-19.815571316348723485,3.00000000000000000000,0.00049999994921104721,0.17398904054205135971,0.98474746192681661405,100.000000000000000000,0.31557864957735926036,0.31557864957735926036,0.00000000000000001224,0.00000000000000000074,9980.48731724149729416,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -168.000000000000000000,0.00000000000000000000,-5.0205800604844332823,0.00000000000000000000,-24.208491763902202364,3.00000000000000000000,-0.0004999999344181487,0.17406478984144968524,0.98473407523935996277,100.000000000000000000,0.31539556472661051111,0.31539556472661051111,0.00000000000000001224,0.00000000000000000074,9976.16142947913795069,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -169.000000000000000000,0.00000000000000000000,-4.2481830285630586274,0.00000000000000000000,-24.208490903036363306,1.00000000000000000000,-0.0004230768725914143,0.17406479600647295491,0.98473411020294432383,100.000000000000000000,0.31539554982879958178,0.31539554982879958178,0.00000000000000001224,0.00000000000000000074,9976.16107614366046618,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -169.000000000000000000,1.00000000000000000000,-4.6813464315164825535,0.00000000000000000000,4.63692377109861553208,1.00000000000000000000,-0.0004230768725914143,0.99999982100592754719,0.00042307691045556650,100.000000000000000000,0.31539554982879958178,0.31539554982879958178,0.00000000000000001224,0.00000000000000000074,11000.0019689351483975,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -170.000000000000000000,0.00000000000000000000,-3.4757860464112639853,0.00000000000000000000,-24.208490185645132442,3.00000000000000000000,-0.0003461538082612664,0.17406480114399242031,0.98473413933926512431,100.000000000000000000,0.31539553741395665031,0.31539553741395665031,0.00000000000000001224,0.00000000000000000074,9976.16078169744650949,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -171.000000000000000000,0.00000000000000000000,-2.7033891049800322647,0.00000000000000000000,-24.208489611733966739,1.00000000000000000000,-0.0002692307418828711,0.17406480525400802594,0.98473416264832192013,100.000000000000000000,0.31539552748208343757,0.31539552748208343757,0.00000000000000001224,0.00000000000000000074,9976.16054614048698567,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -171.000000000000000000,1.00000000000000000000,-2.9790385330943722763,0.00000000000000000000,4.63692352326049839206,1.00000000000000000000,-0.0002692307418828711,0.99999987426035952253,0.00042307691045562201,100.000000000000000000,0.31539552748208343757,0.31539552748208343757,0.00000000000000001224,0.00000000000000000074,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -172.000000000000000000,0.00000000000000000000,-1.9309921952203483730,0.00000000000000000000,-24.208489181299228221,3.00000000000000000000,-0.0001923076739113946,0.17406480833651974404,0.98473418013011471128,100.000000000000000000,0.31539552003317850026,0.31539552003317850026,0.00000000000000001224,0.00000000000000000074,9976.16036947277279978,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -173.000000000000000000,0.00000000000000000000,-1.1585953080831965511,0.00000000000000000000,-24.208488894344554864,3.00000000000000000000,-0.0001153846048020029,0.17406481039152757461,0.98473419178464305367,100.000000000000000000,0.31539551506724172735,0.31539551506724172735,0.00000000000000001224,0.00000000000000000074,9976.16025169429849484,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -174.000000000000000000,0.00000000000000000000,-0.3861984345195630385,0.00000000000000000000,-24.208488750866308691,3.00000000000000000000,-0.0000384615350098619,0.17406481141903148990,0.98473419761190739141,100.000000000000000000,0.31539551258427300783,0.31539551258427300783,0.00000000000000001224,0.00000000000000000074,9976.16019280506225186,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -175.000000000000000000,0.00000000000000000000,0.38619843451956303859,0.00000000000000000000,-24.208488750866308691,3.00000000000000000000,0.00003846153500986195,0.17406481141903148990,0.98473419761190739141,100.000000000000000000,0.31539551258427300783,0.31539551258427300783,0.00000000000000001224,0.00000000000000000074,9976.16019280506225186,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -176.000000000000000000,0.00000000000000000000,1.15859530808319655115,0.00000000000000000000,-24.208488894344554864,1.00000000000000000000,0.00011538460480200291,0.17406481039152757461,0.98473419178464305367,100.000000000000000000,0.31539551506724172735,0.31539551506724172735,0.00000000000000001224,0.00000000000000000074,9976.16025169429849484,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -176.000000000000000000,1.00000000000000000000,1.27673077486345043496,0.00000000000000000000,4.63692338557309469138,1.00000000000000000000,0.00011538460480200291,0.99999990384615555782,0.00042307691045556650,100.000000000000000000,0.31539551506724172735,0.31539551506724172735,0.00000000000000001224,0.00000000000000000074,11000.0010576923905318,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -177.000000000000000000,0.00000000000000000000,1.93099219522034881713,0.00000000000000000000,-24.208489181299228221,1.00000000000000000000,0.00019230767391139474,0.17406480833651974404,0.98473418013011471128,100.000000000000000000,0.31539552003317850026,0.31539552003317850026,0.00000000000000001224,0.00000000000000000074,9976.16036947277279978,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -177.000000000000000000,1.00000000000000000000,2.12788464146184219671,0.00000000000000000000,4.63692344064766448497,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,0.00042307691045556650,100.000000000000000000,0.31539552003317850026,0.31539552003317850026,0.00000000000000001224,0.00000000000000000074,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -178.000000000000000000,0.00000000000000000000,2.70338910498003226479,0.00000000000000000000,-24.208489611733966739,3.00000000000000000000,0.00026923074188287118,0.17406480525400802594,0.98473416264832192013,100.000000000000000000,0.31539552748208343757,0.31539552748208343757,0.00000000000000001224,0.00000000000000000074,9976.16054614048698567,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -179.000000000000000000,0.00000000000000000000,3.47578604641126398533,0.00000000000000000000,-24.208490185645132442,3.00000000000000000000,0.00034615380826126648,0.17406480114399242031,0.98473413933926512431,100.000000000000000000,0.31539553741395665031,0.31539553741395665031,0.00000000000000001224,0.00000000000000000074,9976.16078169744650949,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -180.000000000000000000,0.00000000000000000000,4.24818302856305862746,0.00000000000000000000,-24.208490903036363306,3.00000000000000000000,0.00042307687259141442,0.17406479600647295491,0.98473411020294432383,100.000000000000000000,0.31539554982879958178,0.31539554982879958178,0.00000000000000001224,0.00000000000000000074,9976.16107614366046618,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -181.000000000000000000,0.00000000000000000000,5.02058006048443328239,0.00000000000000000000,-24.208491763902202364,3.00000000000000000000,0.00049999993441814875,0.17406478984144968524,0.98473407523935996277,100.000000000000000000,0.31539556472661051111,0.31539556472661051111,0.00000000000000001224,0.00000000000000000074,9976.16142947913795069,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -182.000000000000000000,0.00000000000000000000,-5.0184188510770537661,0.00000000000000000000,-28.597590490364382276,3.00000000000000000000,-0.0004999999166666708,0.17414053811087884526,0.98472068272507462527,100.000000000000000000,0.31521255489632660218,0.31521255489632660218,0.00000000000000001224,0.00000000000000000074,9971.83936412725233822,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -183.000000000000000000,0.00000000000000000000,-4.2463543130187906271,0.00000000000000000000,-28.597589473860352882,3.00000000000000000000,-0.0004230768575709328,0.17414054427590189288,0.98472071768865776508,100.000000000000000000,0.31521254000441883968,0.31521254000441883968,0.00000000000000001224,0.00000000000000000074,9971.83901109849648491,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -184.000000000000000000,0.00000000000000000000,-3.4742898246760431923,0.00000000000000000000,-28.597588626771539566,3.00000000000000000000,-0.0003461537959717815,0.17414054941342116400,0.98472074682497745534,100.000000000000000000,0.31521252759449547298,0.31521252759449547298,0.00000000000000001224,0.00000000000000000074,9971.83871690788328123,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -185.000000000000000000,0.00000000000000000000,-2.7022253770096229530,0.00000000000000000000,-28.597587949099761317,3.00000000000000000000,-0.0002692307323243828,0.17414055352343663085,0.98472077013403347400,100.000000000000000000,0.31521251766655700166,0.31521251766655700166,0.00000000000000001224,0.00000000000000000074,9971.83848155540363222,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -186.000000000000000000,0.00000000000000000000,-1.9301609609803449529,0.00000000000000000000,-28.597587440846837125,3.00000000000000000000,-0.0001923076670839029,0.17414055660594823793,0.98472078761582559902,100.000000000000000000,0.31521251022060348123,0.31521251022060348123,0.00000000000000001224,0.00000000000000000074,9971.83830504104844294,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -187.000000000000000000,0.00000000000000000000,-1.1580965675490242361,0.00000000000000000000,-28.597587102014585980,3.00000000000000000000,-0.0001153846007055078,0.17414055866095598523,0.98472079927035349733,100.000000000000000000,0.31521250525663463415,0.31521250525663463415,0.00000000000000001224,0.00000000000000000074,9971.83818736481225641,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -188.000000000000000000,0.00000000000000000000,-0.3860321876764773452,0.00000000000000000000,-28.597586932593912933,3.00000000000000000000,-0.0000384615336443635,0.17414055968845987276,0.98472080509761772404,100.000000000000000000,0.31521250277464962774,0.31521250277464962774,0.00000000000000001224,0.00000000000000000074,9971.83812852669871062,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -189.000000000000000000,0.00000000000000000000,0.38603218767647734521,0.00000000000000000000,-28.597586932593912933,3.00000000000000000000,0.00003846153364436359,0.17414055968845987276,0.98472080509761772404,100.000000000000000000,0.31521250277464962774,0.31521250277464962774,0.00000000000000001224,0.00000000000000000074,9971.83812852669871062,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -190.000000000000000000,0.00000000000000000000,1.15809656754902423614,0.00000000000000000000,-28.597587102014585980,1.00000000000000000000,0.00011538460070550785,0.17414055866095598523,0.98472079927035349733,100.000000000000000000,0.31521250525663463415,0.31521250525663463415,0.00000000000000001224,0.00000000000000000074,9971.83818736481225641,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -190.000000000000000000,1.00000000000000000000,1.27673077486345065700,0.00000000000000000000,5.48000049494640517622,1.00000000000000000000,0.00011538460070550785,0.99999986834319842810,0.00049999997916666538,100.000000000000000000,0.31521250525663463415,0.31521250525663463415,0.00000000000000001224,0.00000000000000000074,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -191.000000000000000000,0.00000000000000000000,1.93016096098034539707,0.00000000000000000000,-28.597587440846837125,3.00000000000000000000,0.00019230766708390299,0.17414055660594823793,0.98472078761582559902,100.000000000000000000,0.31521251022060348123,0.31521251022060348123,0.00000000000000001224,0.00000000000000000074,9971.83830504104844294,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -192.000000000000000000,0.00000000000000000000,2.70222537700962295303,0.00000000000000000000,-28.597587949099761317,3.00000000000000000000,0.00026923073232438285,0.17414055352343663085,0.98472077013403347400,100.000000000000000000,0.31521251766655700166,0.31521251766655700166,0.00000000000000001224,0.00000000000000000074,9971.83848155540363222,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -193.000000000000000000,0.00000000000000000000,3.47428982467604319239,0.00000000000000000000,-28.597588626771539566,3.00000000000000000000,0.00034615379597178157,0.17414054941342116400,0.98472074682497745534,100.000000000000000000,0.31521252759449547298,0.31521252759449547298,0.00000000000000001224,0.00000000000000000074,9971.83871690788328123,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -194.000000000000000000,0.00000000000000000000,4.24635431301879062715,0.00000000000000000000,-28.597589473860352882,3.00000000000000000000,0.00042307685757093292,0.17414054427590189288,0.98472071768865776508,100.000000000000000000,0.31521254000441883968,0.31521254000441883968,0.00000000000000001224,0.00000000000000000074,9971.83901109849648491,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -195.000000000000000000,0.00000000000000000000,5.01841885107705376611,0.00000000000000000000,-28.597590490364382276,3.00000000000000000000,0.00049999991666667084,0.17414053811087884526,0.98472068272507462527,100.000000000000000000,0.31521255489632660218,0.31521255489632660218,0.00000000000000001224,0.00000000000000000074,9971.83936412725233822,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -196.000000000000000000,0.00000000000000000000,-5.0466620698997637362,0.00000000000000000000,28.7602367256004072260,3.00000000000000000000,-0.0004999999166666708,0.17315573039890028161,0.98489433089550615374,100.000000000000000000,0.31759754053448729926,0.31759754053448729926,0.00000000000000001228,0.00000000000000000075,10028.3258111870818538,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -197.000000000000000000,0.00000000000000000000,-4.2702524198358808860,0.00000000000000000000,28.7602356975221482571,3.00000000000000000000,-0.0004230768575709328,0.17315573656392332924,0.98489436585908929355,100.000000000000000000,0.31759752556571563264,0.31759752556571563264,0.00000000000000001228,0.00000000000000000075,10028.3254541393671388,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -198.000000000000000000,0.00000000000000000000,-3.4938428201962703489,0.00000000000000000000,28.7602348407926911022,1.00000000000000000000,-0.0003461537959717815,0.17315574170144260035,0.98489439499540898381,100.000000000000000000,0.31759751309173933631,0.31759751309173933631,0.00000000000000001228,0.00000000000000000075,10028.3251565996233694,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -198.000000000000000000,1.00000000000000000000,-3.8301924597747012413,0.00000000000000000000,-5.4800007878455039289,1.00000000000000000000,-0.0003461537959717815,0.99999981508876789604,-0.0004999999791666098,100.000000000000000000,0.31759751309173933631,0.31759751309173933631,0.00000000000000001228,0.00000000000000000075,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -199.000000000000000000,0.00000000000000000000,-2.7174332618128755889,0.00000000000000000000,28.7602341554065787931,3.00000000000000000000,-0.0002692307323243828,0.17315574581145806720,0.98489441830446500247,100.000000000000000000,0.31759750311255868782,0.31759750311255868782,0.00000000000000001228,0.00000000000000000075,10028.3249185678359935,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +Ray-ID ,Event-ID ,X-position ,Y-position ,Z-position ,Event-type ,X-direction ,Y-direction ,Z-direction ,Energy ,ElectricField-x-real ,ElectricField-x-imag ,ElectricField-y-real ,ElectricField-y-imag ,ElectricField-z-real ,ElectricField-z-imag ,pathLength ,order ,lastElement ,lightSourceIndex +0.00000000000000000000,0.00000000000000000000,-5.0466620698997637362,0.00000000000000000000,28.7602367256004072260,1.00000000000000000000,-0.0004999999166666708,0.17315573039890028161,0.98489433089550615374,100.000000000000000000,-0.4328730222075060085,-0.4278468919645758150,0.00003820993979154383,0.00003056443547525051,-0.0002264737830923415,-0.0002225780072040917,10028.3258111870818538,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +0.00000000000000000000,1.00000000000000000000,-5.5325004583333790009,0.00000000000000000000,-5.4800011458330635250,1.00000000000000000000,-0.0004999999166666708,0.99999975000002072622,-0.0004999999791666098,100.000000000000000000,-0.4328730222075060085,-0.4278468919645758150,-0.0002163980510297783,-0.0002138890886229009,0.00007695620467216277,0.00006875035836219549,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +1.00000000000000000000,0.00000000000000000000,-4.2702524198358808860,0.00000000000000000000,28.7602356975221482571,1.00000000000000000000,-0.0004230768575709328,0.17315573656392332924,0.98489436585908929355,100.000000000000000000,-0.4328730191609597155,-0.4278469120886494447,0.00003233148651289173,0.00002586221510927040,-0.0001916316567316117,-0.0001883352412443913,10028.3254541393671388,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +1.00000000000000000000,1.00000000000000000000,-4.6813464315164816653,0.00000000000000000000,-5.4800009505671178899,1.00000000000000000000,-0.0004230768575709328,0.99999978550297341506,-0.0004999999791665543,100.000000000000000000,-0.4328730191609597155,-0.4278469120886494447,-0.0001831060375576387,-0.0001809830792187461,0.00006511678655904454,0.00005817338138222919,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +2.00000000000000000000,0.00000000000000000000,-3.4938428201962703489,0.00000000000000000000,28.7602348407926911022,1.00000000000000000000,-0.0003461537959717815,0.17315574170144260035,0.98489439499540898381,100.000000000000000000,-0.4328730166221709807,-0.4278469288587109509,0.00002645303373575461,0.00002115999450510721,-0.0001567895333133745,-0.0001540924730949954,10028.3251565996233694,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +2.00000000000000000000,1.00000000000000000000,-3.8301924597747012413,0.00000000000000000000,-5.4800007878455039289,1.00000000000000000000,-0.0003461537959717815,0.99999981508876789604,-0.0004999999791666098,100.000000000000000000,-0.4328730166221709807,-0.4278469288587109509,-0.0001498140268962015,-0.0001480770676995224,0.00005327736945078058,0.00004759640378746175,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +3.00000000000000000000,0.00000000000000000000,-2.7174332618128755889,0.00000000000000000000,28.7602341554065787931,1.00000000000000000000,-0.0002692307323243828,0.17315574581145806720,0.98489441830446500247,100.000000000000000000,-0.4328730145911391380,-0.4278469422747606110,0.00002057458136894794,0.00001645777370606699,-0.0001219474123026308,-0.0001198497031540308,10028.3249185678359935,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +3.00000000000000000000,1.00000000000000000000,-2.9790385330943736086,0.00000000000000000000,-5.4800006576671842495,1.00000000000000000000,-0.0002692307323243828,0.99999983875740361405,-0.0004999999791666653,100.000000000000000000,-0.4328730145911391380,-0.4278469422747606110,-0.0001165220185344293,-0.0001151710544497879,0.00004143795316467010,0.00003701942568967524,11000.0017736688459990,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +4.00000000000000000000,0.00000000000000000000,-1.9410237355176496176,0.00000000000000000000,28.7602336413692682981,1.00000000000000000000,-0.0001923076670839029,0.17315574889396967428,0.98489443578625712749,100.000000000000000000,-0.4328730130678640208,-0.4278469523367973703,0.00001469612932128713,0.00001175555275545571,-0.0000871052931643823,-0.0000856069318196236,10028.3247400440031924,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +4.00000000000000000000,1.00000000000000000000,-2.1278846414618421967,0.00000000000000000000,-5.4800005600348518086,1.00000000000000000000,-0.0001923076670839029,0.99999985650888068011,-0.0004999999791666653,100.000000000000000000,-0.4328730130678640208,-0.4278469523367973703,-0.0000832300119612859,-0.0000822650398541005,0.00002959853751801232,0.00002644244720065160,11000.0015784025363245,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +5.00000000000000000000,0.00000000000000000000,-1.1646142321425427823,0.00000000000000000000,28.7602332986753026489,1.00000000000000000000,-0.0001153846007055078,0.17315575094897742158,0.98489444744078502580,100.000000000000000000,-0.4328730120523475721,-0.4278469590448218395,0.00000881767750158772,0.00000705333169657943,-0.0000522631753636307,-0.0000513641594899005,10028.3246210281176900,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +5.00000000000000000000,1.00000000000000000000,-1.2767307748634506570,0.00000000000000000000,-5.4800004949458136493,1.00000000000000000000,-0.0001153846007055078,0.99999986834319842810,-0.0004999999791666653,100.000000000000000000,-0.4328730120523475721,-0.4278469590448218395,-0.0000499380066657348,-0.0000493590242970182,0.00001775912232810659,0.00001586546843217296,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +6.00000000000000000000,0.00000000000000000000,-0.3882047425195060408,0.00000000000000000000,28.7602331273301388137,1.00000000000000000000,-0.0000384615336443635,0.17315575197648130911,0.98489445326804925251,100.000000000000000000,-0.4328730115445898474,-0.4278469623988338521,0.00000293922581866515,0.00000235111057274414,-0.0000174210583653771,-0.0000171213865629878,10028.3245615201758482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +6.00000000000000000000,1.00000000000000000000,-0.4255769232855405315,0.00000000000000000000,-5.4800004624015059562,1.00000000000000000000,-0.0000384615336443635,0.99999987426035763515,-0.0004999999791667208,100.000000000000000000,-0.4328730115445898474,-0.4278469623988338521,-0.0000166460021367387,-0.0000164530081630990,0.00000591970741225206,0.00000528848949602131,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +7.00000000000000000000,0.00000000000000000000,0.38820474251950604083,0.00000000000000000000,28.7602331273301388137,1.00000000000000000000,0.00003846153364436359,0.17315575197648130911,0.98489445326804925251,100.000000000000000000,-0.4328730115445898474,-0.4278469623988338521,-0.0000029392258186651,-0.0000023511105727441,0.00001742105836537714,0.00001712138656298788,10028.3245615201758482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +7.00000000000000000000,1.00000000000000000000,0.42557692328554053151,0.00000000000000000000,-5.4800004624015059562,1.00000000000000000000,0.00003846153364436359,0.99999987426035763515,-0.0004999999791667208,100.000000000000000000,-0.4328730115445898474,-0.4278469623988338521,0.00001664600213673879,0.00001645300816309904,-0.0000059197074122520,-0.0000052884894960213,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +8.00000000000000000000,0.00000000000000000000,1.16461423214254278235,0.00000000000000000000,28.7602332986753026489,1.00000000000000000000,0.00011538460070550785,0.17315575094897742158,0.98489444744078502580,100.000000000000000000,-0.4328730120523475721,-0.4278469590448218395,-0.0000088176775015877,-0.0000070533316965794,0.00005226317536363077,0.00005136415948990056,10028.3246210281176900,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +8.00000000000000000000,1.00000000000000000000,1.27673077486345065700,0.00000000000000000000,-5.4800004949458136493,1.00000000000000000000,0.00011538460070550785,0.99999986834319842810,-0.0004999999791666653,100.000000000000000000,-0.4328730120523475721,-0.4278469590448218395,0.00004993800666573480,0.00004935902429701824,-0.0000177591223281065,-0.0000158654684321729,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +9.00000000000000000000,0.00000000000000000000,1.94102373551765006176,0.00000000000000000000,28.7602336413692682981,1.00000000000000000000,0.00019230766708390299,0.17315574889396967428,0.98489443578625712749,100.000000000000000000,-0.4328730130678640208,-0.4278469523367973703,-0.0000146961293212871,-0.0000117555527554557,0.00008710529316438241,0.00008560693181962369,10028.3247400440031924,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +9.00000000000000000000,1.00000000000000000000,2.12788464146184264080,0.00000000000000000000,-5.4800005600348518086,1.00000000000000000000,0.00019230766708390299,0.99999985650888068011,-0.0004999999791666653,100.000000000000000000,-0.4328730130678640208,-0.4278469523367973703,0.00008323001196128603,0.00008226503985410054,-0.0000295985375180123,-0.0000264424472006516,11000.0015784025363245,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +10.0000000000000000000,0.00000000000000000000,2.71743326181287558895,0.00000000000000000000,28.7602341554065787931,1.00000000000000000000,0.00026923073232438285,0.17315574581145806720,0.98489441830446500247,100.000000000000000000,-0.4328730145911391380,-0.4278469422747606110,-0.0000205745813689479,-0.0000164577737060669,0.00012194741230263085,0.00011984970315403082,10028.3249185678359935,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +10.0000000000000000000,1.00000000000000000000,2.97903853309437360863,0.00000000000000000000,-5.4800006576671842495,1.00000000000000000000,0.00026923073232438285,0.99999983875740361405,-0.0004999999791666653,100.000000000000000000,-0.4328730145911391380,-0.4278469422747606110,0.00011652201853442936,0.00011517105444978797,-0.0000414379531646701,-0.0000370194256896752,11000.0017736688459990,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +11.0000000000000000000,0.00000000000000000000,3.49384282019627034898,0.00000000000000000000,28.7602348407926911022,1.00000000000000000000,0.00034615379597178157,0.17315574170144260035,0.98489439499540898381,100.000000000000000000,-0.4328730166221709807,-0.4278469288587109509,-0.0000264530337357546,-0.0000211599945051072,0.00015678953331337458,0.00015409247309499545,10028.3251565996233694,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +11.0000000000000000000,1.00000000000000000000,3.83019245977470124131,0.00000000000000000000,-5.4800007878455039289,1.00000000000000000000,0.00034615379597178157,0.99999981508876789604,-0.0004999999791666098,100.000000000000000000,-0.4328730166221709807,-0.4278469288587109509,0.00014981402689620153,0.00014807706769952245,-0.0000532773694507805,-0.0000475964037874617,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +12.0000000000000000000,0.00000000000000000000,4.27025241983588177419,0.00000000000000000000,28.7602356975221482571,1.00000000000000000000,0.00042307685757093292,0.17315573656392332924,0.98489436585908929355,100.000000000000000000,-0.4328730191609597155,-0.4278469120886494447,-0.0000323314865128917,-0.0000258622151092704,0.00019163165673161179,0.00018833524124439133,10028.3254541393671388,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +12.0000000000000000000,1.00000000000000000000,4.68134643151648255354,0.00000000000000000000,-5.4800009505671178899,1.00000000000000000000,0.00042307685757093292,0.99999978550297341506,-0.0004999999791665543,100.000000000000000000,-0.4328730191609597155,-0.4278469120886494447,0.00018310603755763879,0.00018098307921874615,-0.0000651167865590445,-0.0000581733813822292,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +13.0000000000000000000,0.00000000000000000000,5.04666206989976373620,0.00000000000000000000,28.7602367256004072260,1.00000000000000000000,0.00049999991666667084,0.17315573039890028161,0.98489433089550615374,100.000000000000000000,-0.4328730222075060085,-0.4278468919645758150,-0.0000382099397915438,-0.0000305644354752505,0.00022647378309234155,0.00022257800720409178,10028.3258111870818538,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +13.0000000000000000000,1.00000000000000000000,5.53250045833337900091,0.00000000000000000000,-5.4800011458330635250,1.00000000000000000000,0.00049999991666667084,0.99999975000002072622,-0.0004999999791666098,100.000000000000000000,-0.4328730222075060085,-0.4278468919645758150,0.00021639805102977832,0.00021388908862290091,-0.0000769562046721627,-0.0000687503583621954,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +14.0000000000000000000,0.00000000000000000000,-5.0444781135724188203,0.00000000000000000000,24.3249423472407215740,1.00000000000000000000,-0.0004999999344181487,0.17323149099837553688,0.98488100830838709587,100.000000000000000000,-0.4326231336855982378,-0.4278863760403321947,0.00003818981743007619,0.00003056690460046814,-0.0002263493920629423,-0.0002226038562712151,10023.9575419242210045,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +14.0000000000000000000,1.00000000000000000000,-5.5325004583333798890,0.00000000000000000000,-4.6369239363243845986,1.00000000000000000000,-0.0004999999344181487,0.99999978550297363710,-0.0004230769104555109,100.000000000000000000,-0.4326231336855982378,-0.4278863760403321947,-0.0002162790439910199,-0.0002139141162255176,0.00007691478773900725,0.00006875727861925333,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +15.0000000000000000000,0.00000000000000000000,-4.2684044568996206692,0.00000000000000000000,24.3249414780875667929,1.00000000000000000000,-0.0004230768725914143,0.17323149716339880654,0.98488104327197145693,100.000000000000000000,-0.4326231306330454717,-0.4278863961573318719,0.00003231445989935965,0.00002586430436851310,-0.0001915264027832840,-0.0001883571135283538,10023.9571851881028123,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +15.0000000000000000000,1.00000000000000000000,-4.6813464315164825535,0.00000000000000000000,-4.6369237710984512190,1.00000000000000000000,-0.0004230768725914143,0.99999982100592754719,-0.0004230769104555109,100.000000000000000000,-0.4326231306330454717,-0.4278863961573318719,-0.0001830053392937021,-0.0001810042564175083,0.00006508174146171123,0.00005817923698318096,11000.0019689351447595,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +16.0000000000000000000,0.00000000000000000000,-3.4923308505961156988,0.00000000000000000000,24.3249407537950901314,1.00000000000000000000,-0.0003461538082612664,0.17323150230091827195,0.98488107240829225741,100.000000000000000000,-0.4326231280892504083,-0.4278864129214977052,0.00002643910287014935,0.00002116170389865338,-0.0001567034164463052,-0.0001541103685975986,10023.9568879080234182,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +16.0000000000000000000,1.00000000000000000000,-3.8301924597747003531,0.00000000000000000000,-4.6369236334108618891,1.00000000000000000000,-0.0003461538082612664,0.99999985059172313839,-0.0004230769104555109,100.000000000000000000,-0.4326231280892504083,-0.4278864129214977052,-0.0001497316374072722,-0.0001480943944961559,0.00005324869618929339,0.00004760119473289443,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +17.0000000000000000000,0.00000000000000000000,-2.7162572855038473740,0.00000000000000000000,24.3249401743596536107,1.00000000000000000000,-0.0002692307418828711,0.17323150641093387758,0.98488109571734905323,100.000000000000000000,-0.4326231260542143242,-0.4278864263328311379,0.00002056374625126235,0.00001645910323414443,-0.0001218804325169736,-0.0001198636218767490,10023.9566500839682703,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +17.0000000000000000000,1.00000000000000000000,-2.9790385330943727204,0.00000000000000000000,-4.6369235232609007368,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,-0.0004230769104555665,100.000000000000000000,-0.4326231260542143242,-0.4278864263328311379,-0.0001164579378206599,-0.0001151845308457050,0.00004141565173904864,0.00003702315198006920,11000.0013831362139171,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +18.0000000000000000000,0.00000000000000000000,-1.9401837524647629340,0.00000000000000000000,24.3249397397867141989,1.00000000000000000000,-0.0001923076739113946,0.17323150949344559568,0.98488111319914184438,100.000000000000000000,-0.4326231245279358872,-0.4278864363913299495,0.00001468838995151569,0.00001175650241824159,-0.0000870574504602563,-0.0000856168737636032,10023.9564717159373685,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +18.0000000000000000000,1.00000000000000000000,-2.1278846414618426408,0.00000000000000000000,-4.6369234406484238775,1.00000000000000000000,-0.0001923076739113946,0.99999989201183714371,-0.0004230769104555109,100.000000000000000000,-0.4326231245279358872,-0.4278864363913299495,-0.0000831842400227947,-0.0000822746658503994,0.00002958260792827184,0.00002644510883638041,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +19.0000000000000000000,0.00000000000000000000,-1.1641102423208065097,0.00000000000000000000,24.3249394500653579598,1.00000000000000000000,-0.0001153846048020029,0.17323151154845342625,0.98488112485367018678,100.000000000000000000,-0.4326231235104178174,-0.4278864430969966381,0.00000881303387972646,0.00000705390149420034,-0.0000522344697411211,-0.0000513701246559607,10023.9563528039143420,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +19.0000000000000000000,1.00000000000000000000,-1.2767307748634506570,0.00000000000000000000,-4.6369233855731017968,1.00000000000000000000,-0.0001153846048020029,0.99999990384615544680,-0.0004230769104555109,100.000000000000000000,-0.4326231235104178174,-0.4278864430969966381,-0.0000499105435026062,-0.0000493647998944838,0.00001774956457425797,0.00001586706541350353,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +20.0000000000000000000,0.00000000000000000000,-0.3880367459139265062,0.00000000000000000000,24.3249393052064988296,1.00000000000000000000,-0.0000384615350098619,0.17323151257595734153,0.98488113068093452451,100.000000000000000000,-0.4326231230016588935,-0.4278864464498304820,0.00000293767794471165,0.00000235130050527601,-0.0000174114898245349,-0.0000171233749516200,10023.9562933479046478,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +20.0000000000000000000,1.00000000000000000000,-0.4255769232855405315,0.00000000000000000000,-4.6369233580353697021,1.00000000000000000000,-0.0000384615350098619,0.99999990976331476488,-0.0004230769104555109,100.000000000000000000,-0.4326231230016588935,-0.4278864464498304820,-0.0000166368477490236,-0.0000164549333622019,0.00000591652149430180,0.00000528902182311372,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +21.0000000000000000000,0.00000000000000000000,0.38803674591392650627,0.00000000000000000000,24.3249393052064988296,1.00000000000000000000,0.00003846153500986195,0.17323151257595734153,0.98488113068093452451,100.000000000000000000,-0.4326231230016588935,-0.4278864464498304820,-0.0000029376779447116,-0.0000023513005052760,0.00001741148982453492,0.00001712337495162005,10023.9562933479046478,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +21.0000000000000000000,1.00000000000000000000,0.42557692328554053151,0.00000000000000000000,-4.6369233580353697021,1.00000000000000000000,0.00003846153500986195,0.99999990976331476488,-0.0004230769104555109,100.000000000000000000,-0.4326231230016588935,-0.4278864464498304820,0.00001663684774902365,0.00001645493336220195,-0.0000059165214943018,-0.0000052890218231137,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +22.0000000000000000000,0.00000000000000000000,1.16411024232080650975,0.00000000000000000000,24.3249394500653579598,1.00000000000000000000,0.00011538460480200291,0.17323151154845342625,0.98488112485367018678,100.000000000000000000,-0.4326231235104178174,-0.4278864430969966381,-0.0000088130338797264,-0.0000070539014942003,0.00005223446974112116,0.00005137012465596076,10023.9563528039143420,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +22.0000000000000000000,1.00000000000000000000,1.27673077486345065700,0.00000000000000000000,-4.6369233855731017968,1.00000000000000000000,0.00011538460480200291,0.99999990384615544680,-0.0004230769104555109,100.000000000000000000,-0.4326231235104178174,-0.4278864430969966381,0.00004991054350260628,0.00004936479989448382,-0.0000177495645742579,-0.0000158670654135035,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +23.0000000000000000000,0.00000000000000000000,1.94018375246476337814,0.00000000000000000000,24.3249397397867141989,1.00000000000000000000,0.00019230767391139474,0.17323150949344559568,0.98488111319914184438,100.000000000000000000,-0.4326231245279358872,-0.4278864363913299495,-0.0000146883899515156,-0.0000117565024182416,0.00008705745046025636,0.00008561687376360323,10023.9564717159373685,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +23.0000000000000000000,1.00000000000000000000,2.12788464146184308489,0.00000000000000000000,-4.6369234406484238775,1.00000000000000000000,0.00019230767391139474,0.99999989201183714371,-0.0004230769104555109,100.000000000000000000,-0.4326231245279358872,-0.4278864363913299495,0.00008318424002279473,0.00008227466585039944,-0.0000295826079282718,-0.0000264451088363804,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +24.0000000000000000000,0.00000000000000000000,2.71625728550384737403,0.00000000000000000000,24.3249401743596536107,1.00000000000000000000,0.00026923074188287118,0.17323150641093387758,0.98488109571734905323,100.000000000000000000,-0.4326231260542143242,-0.4278864263328311379,-0.0000205637462512623,-0.0000164591032341444,0.00012188043251697361,0.00011986362187674900,10023.9566500839682703,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +24.0000000000000000000,1.00000000000000000000,2.97903853309437272045,0.00000000000000000000,-4.6369235232609007368,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,-0.0004230769104555665,100.000000000000000000,-0.4326231260542143242,-0.4278864263328311379,0.00011645793782065996,0.00011518453084570505,-0.0000414156517390486,-0.0000370231519800692,11000.0013831362139171,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +25.0000000000000000000,0.00000000000000000000,3.49233085059611569889,0.00000000000000000000,24.3249407537950901314,1.00000000000000000000,0.00034615380826126648,0.17323150230091827195,0.98488107240829225741,100.000000000000000000,-0.4326231280892504083,-0.4278864129214977052,-0.0000264391028701493,-0.0000211617038986533,0.00015670341644630529,0.00015411036859759865,10023.9568879080234182,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +25.0000000000000000000,1.00000000000000000000,3.83019245977470035313,0.00000000000000000000,-4.6369236334108618891,1.00000000000000000000,0.00034615380826126648,0.99999985059172313839,-0.0004230769104555109,100.000000000000000000,-0.4326231280892504083,-0.4278864129214977052,0.00014973163740727223,0.00014809439449615591,-0.0000532486961892933,-0.0000476011947328944,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +26.0000000000000000000,0.00000000000000000000,4.26840445689962155739,0.00000000000000000000,24.3249414780875667929,1.00000000000000000000,0.00042307687259141442,0.17323149716339880654,0.98488104327197145693,100.000000000000000000,-0.4326231306330454717,-0.4278863961573318719,-0.0000323144598993596,-0.0000258643043685131,0.00019152640278328396,0.00018835711352835387,10023.9571851881028123,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +26.0000000000000000000,1.00000000000000000000,4.68134643151648344172,0.00000000000000000000,-4.6369237710984512190,1.00000000000000000000,0.00042307687259141442,0.99999982100592754719,-0.0004230769104555109,100.000000000000000000,-0.4326231306330454717,-0.4278863961573318719,0.00018300533929370204,0.00018100425641750841,-0.0000650817414617112,-0.0000581792369831809,11000.0019689351447595,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +27.0000000000000000000,0.00000000000000000000,5.04447811357241882035,0.00000000000000000000,24.3249423472407215740,1.00000000000000000000,0.00049999993441814875,0.17323149099837553688,0.98488100830838709587,100.000000000000000000,-0.4326231336855982378,-0.4278863760403321947,-0.0000381898174300761,-0.0000305669046004681,0.00022634939206294231,0.00022260385627121515,10023.9575419242210045,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +27.0000000000000000000,1.00000000000000000000,5.53250045833337988909,0.00000000000000000000,-4.6369239363243845986,1.00000000000000000000,0.00049999993441814875,0.99999978550297363710,-0.0004230769104555109,100.000000000000000000,-0.4326231336855982378,-0.4278863760403321947,0.00021627904399101999,0.00021391411622551767,-0.0000769147877390072,-0.0000687572786192533,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +28.0000000000000000000,0.00000000000000000000,-5.0422960666489791137,0.00000000000000000000,19.8935256876375206047,1.00000000000000000000,-0.0004999999492110472,0.17330725057281240464,0.98486767989356982511,100.000000000000000000,-0.4323732858497814635,-0.4279257437939170127,0.00003816969852325644,0.00003056936524683207,-0.0002262250158269384,-0.0002226296458722629,10019.5931510672453441,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +28.0000000000000000000,1.00000000000000000000,-5.5325004583333807772,0.00000000000000000000,-3.7938467818895524885,1.00000000000000000000,-0.0004999999492110472,0.99999981508876789604,-0.0003461538392409146,100.000000000000000000,-0.4323732858497814635,-0.4279257437939170127,-0.0002161600509210187,-0.0002139390867378196,0.00007687337677686190,0.00006876418020009466,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +29.0000000000000000000,0.00000000000000000000,-4.2665581096126654614,0.00000000000000000000,19.8935249771348026115,1.00000000000000000000,-0.0004230768851084824,0.17330725673783586859,0.98486771485715529639,100.000000000000000000,-0.4323732827912268317,-0.4279257639038397398,0.00003229743620899143,0.00002586638645334113,-0.0001914211613524464,-0.0001883789354948675,10019.5927946423180401,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +29.0000000000000000000,1.00000000000000000000,-4.6813464315164816653,0.00000000000000000000,-3.7938466467060321107,1.00000000000000000000,-0.0004230768851084824,0.99999985059172302737,-0.0003461538392409702,100.000000000000000000,-0.4323732827912268317,-0.4279257639038397398,-0.0001829046528494848,-0.0001810253853090808,0.00006504670141677172,0.00005818507678118024,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +30.0000000000000000000,0.00000000000000000000,-3.4908202028907440173,0.00000000000000000000,19.8935243850464757997,1.00000000000000000000,-0.0003461538185025041,0.17330726187535550053,0.98486774399347698505,100.000000000000000000,-0.4323732802424304355,-0.4279257806621092341,0.00002642517439622381,0.00002116340742222399,-0.0001566173098208205,-0.0001541282229313804,10019.5924976215574133,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +30.0000000000000000000,1.00000000000000000000,-3.8301924597746994649,0.00000000000000000000,-3.7938465340528182423,1.00000000000000000000,-0.0003461538185025041,0.99999988017751939572,-0.0003461538392409702,100.000000000000000000,-0.4323732802424304355,-0.4279257806621092341,-0.0001496492575890239,-0.0001481116817687254,0.00005322002706158341,0.00004760597274863888,11000.0013180474416003,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +31.0000000000000000000,0.00000000000000000000,-2.7150823373351404832,0.00000000000000000000,19.8935239113779971376,1.00000000000000000000,-0.0002692307498482782,0.17330726598537121718,0.98486776730253444700,100.000000000000000000,-0.4323732782033923860,-0.4279257940687239414,0.00002055291299377220,0.00001646042819668530,-0.0001218134606969939,-0.0001198775085792724,10019.5922600049616448,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +31.0000000000000000000,1.00000000000000000000,-2.9790385330943722763,0.00000000000000000000,-3.7938464439300361163,1.00000000000000000000,-0.0002692307498482782,0.99999990384615666805,-0.0003461538392410257,100.000000000000000000,-0.4323732782033923860,-0.4279257940687239414,-0.0001163938646285320,-0.0001151979765006832,0.00004139335352858745,0.00003702686821403890,11000.0010576923777989,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +32.0000000000000000000,0.00000000000000000000,-1.9393445037977836697,0.00000000000000000000,19.8935235561257286462,1.00000000000000000000,-0.0001923076796009712,0.17330726906788304630,0.98486778478432768224,100.000000000000000000,-0.4323732766741141264,-0.4279258041236855270,0.00001468065191045536,0.00001175744881992998,-0.0000870096134459006,-0.0000856267928360155,10019.5920817925198207,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +32.0000000000000000000,1.00000000000000000000,-2.1278846414618417526,0.00000000000000000000,-3.7938463763376071291,1.00000000000000000000,-0.0001923076796009712,0.99999992159763473331,-0.0003461538392409146,100.000000000000000000,-0.4323732766741141264,-0.4279258041236855270,-0.0000831384734569051,-0.0000822842698888852,0.00002956668063507461,0.00002644776328894914,11000.0008624260844953,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +33.0000000000000000000,0.00000000000000000000,-1.1636066931306008331,0.00000000000000000000,19.8935233192896703258,1.00000000000000000000,-0.0001153846082157488,0.17330727112289093239,0.98486779643885657975,100.000000000000000000,-0.4323732756545943245,-0.4279258108269927141,0.00000880839105509186,0.00000705446933516274,-0.0000522057675324737,-0.0000513760760990804,10019.5919629842264839,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +33.0000000000000000000,1.00000000000000000000,-1.2767307748634502129,0.00000000000000000000,-3.7938463312762600310,1.00000000000000000000,-0.0001153846082157488,0.99999993343195359152,-0.0003461538392409146,100.000000000000000000,-0.4323732756545943245,-0.4279258108269927141,-0.0000498830835630387,-0.0000493705623172613,0.00001774000819833530,0.00001586865808493800,11000.0007322485580516,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +34.0000000000000000000,0.00000000000000000000,-0.3878688961855217276,0.00000000000000000000,19.8935232008734601549,1.00000000000000000000,-0.0000384615361477772,0.17330727215039484767,0.98486780226612091748,100.000000000000000000,-0.4323732751448357003,-0.4279258141786463909,0.00000293613033650039,0.00000235148978558837,-0.0000174019224216468,-0.0000171253587659386,10019.5919035800852725,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +34.0000000000000000000,1.00000000000000000000,-0.4255769232855404204,0.00000000000000000000,-3.7938463087457967581,1.00000000000000000000,-0.0000384615361477772,0.99999993934911279858,-0.0003461538392409702,100.000000000000000000,-0.4323732751448357003,-0.4279258141786463909,-0.0000166276944358288,-0.0000164568541697421,0.00000591333603566020,0.00000528955271357408,11000.0006671597984677,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +35.0000000000000000000,0.00000000000000000000,0.38786889618552172764,0.00000000000000000000,19.8935232008734601549,1.00000000000000000000,0.00003846153614777726,0.17330727215039484767,0.98486780226612091748,100.000000000000000000,-0.4323732751448357003,-0.4279258141786463909,-0.0000029361303365003,-0.0000023514897855883,0.00001740192242164683,0.00001712535876593866,10019.5919035800852725,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +35.0000000000000000000,1.00000000000000000000,0.42557692328554042049,0.00000000000000000000,-3.7938463087457967581,1.00000000000000000000,0.00003846153614777726,0.99999993934911279858,-0.0003461538392409702,100.000000000000000000,-0.4323732751448357003,-0.4279258141786463909,0.00001662769443582889,0.00001645685416974215,-0.0000059133360356602,-0.0000052895527135740,11000.0006671597984677,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +36.0000000000000000000,0.00000000000000000000,1.16360669313060083318,0.00000000000000000000,19.8935233192896703258,1.00000000000000000000,0.00011538460821574884,0.17330727112289093239,0.98486779643885657975,100.000000000000000000,-0.4323732756545943245,-0.4279258108269927141,-0.0000088083910550918,-0.0000070544693351627,0.00005220576753247372,0.00005137607609908047,10019.5919629842264839,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +36.0000000000000000000,1.00000000000000000000,1.27673077486345021291,0.00000000000000000000,-3.7938463312762600310,1.00000000000000000000,0.00011538460821574884,0.99999993343195359152,-0.0003461538392409146,100.000000000000000000,-0.4323732756545943245,-0.4279258108269927141,0.00004988308356303874,0.00004937056231726138,-0.0000177400081983353,-0.0000158686580849380,11000.0007322485580516,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +37.0000000000000000000,0.00000000000000000000,1.93934450379778411388,0.00000000000000000000,19.8935235561257286462,1.00000000000000000000,0.00019230767960097126,0.17330726906788304630,0.98486778478432768224,100.000000000000000000,-0.4323732766741141264,-0.4279258041236855270,-0.0000146806519104553,-0.0000117574488199299,0.00008700961344590066,0.00008562679283601554,10019.5920817925198207,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +37.0000000000000000000,1.00000000000000000000,2.12788464146184219671,0.00000000000000000000,-3.7938463763376071291,1.00000000000000000000,0.00019230767960097126,0.99999992159763473331,-0.0003461538392409146,100.000000000000000000,-0.4323732766741141264,-0.4279258041236855270,0.00008313847345690512,0.00008228426988888524,-0.0000295666806350746,-0.0000264477632889491,11000.0008624260844953,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +38.0000000000000000000,0.00000000000000000000,2.71508233733514048324,0.00000000000000000000,19.8935239113779971376,1.00000000000000000000,0.00026923074984827827,0.17330726598537121718,0.98486776730253444700,100.000000000000000000,-0.4323732782033923860,-0.4279257940687239414,-0.0000205529129937722,-0.0000164604281966853,0.00012181346069699397,0.00011987750857927246,10019.5922600049616448,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +38.0000000000000000000,1.00000000000000000000,2.97903853309437227636,0.00000000000000000000,-3.7938464439300361163,1.00000000000000000000,0.00026923074984827827,0.99999990384615666805,-0.0003461538392410257,100.000000000000000000,-0.4323732782033923860,-0.4279257940687239414,0.00011639386462853202,0.00011519797650068324,-0.0000413933535285874,-0.0000370268682140389,11000.0010576923777989,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +39.0000000000000000000,0.00000000000000000000,3.49082020289074401731,0.00000000000000000000,19.8935243850464757997,1.00000000000000000000,0.00034615381850250414,0.17330726187535550053,0.98486774399347698505,100.000000000000000000,-0.4323732802424304355,-0.4279257806621092341,-0.0000264251743962238,-0.0000211634074222239,0.00015661730982082053,0.00015412822293138045,10019.5924976215574133,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +39.0000000000000000000,1.00000000000000000000,3.83019245977469946495,0.00000000000000000000,-3.7938465340528182423,1.00000000000000000000,0.00034615381850250414,0.99999988017751939572,-0.0003461538392409702,100.000000000000000000,-0.4323732802424304355,-0.4279257806621092341,0.00014964925758902396,0.00014811168176872546,-0.0000532200270615834,-0.0000476059727486388,11000.0013180474416003,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +40.0000000000000000000,0.00000000000000000000,4.26655810961266546144,0.00000000000000000000,19.8935249771348026115,1.00000000000000000000,0.00042307688510848247,0.17330725673783586859,0.98486771485715529639,100.000000000000000000,-0.4323732827912268317,-0.4279257639038397398,-0.0000322974362089914,-0.0000258663864533411,0.00019142116135244653,0.00018837893549486752,10019.5927946423180401,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +40.0000000000000000000,1.00000000000000000000,4.68134643151648166536,0.00000000000000000000,-3.7938466467060321107,1.00000000000000000000,0.00042307688510848247,0.99999985059172302737,-0.0003461538392409702,100.000000000000000000,-0.4323732827912268317,-0.4279257639038397398,0.00018290465284948490,0.00018102538530908088,-0.0000650467014167717,-0.0000581850767811802,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +41.0000000000000000000,0.00000000000000000000,5.04229606664897911372,0.00000000000000000000,19.8935256876375206047,1.00000000000000000000,0.00049999994921104721,0.17330725057281240464,0.98486767989356982511,100.000000000000000000,-0.4323732858497814635,-0.4279257437939170127,-0.0000381696985232564,-0.0000305693652468320,0.00022622501582693842,0.00022262964587226293,10019.5931510672453441,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +41.0000000000000000000,1.00000000000000000000,5.53250045833338077727,0.00000000000000000000,-3.7938467818895524885,1.00000000000000000000,0.00049999994921104721,0.99999981508876789604,-0.0003461538392409146,100.000000000000000000,-0.4323732858497814635,-0.4279257437939170127,0.00021616005092101877,0.00021393908673781965,-0.0000768733767768619,-0.0000687641802000946,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +42.0000000000000000000,0.00000000000000000000,-5.0401159266005981507,0.00000000000000000000,15.4659816110743122408,1.00000000000000000000,-0.0004999999610453660,0.17338300912176257684,0.98485434565113327831,100.000000000000000000,-0.4321234787505787711,-0.4279649952595606654,0.00003814958307422695,0.00003057181741657803,-0.0002261006544120044,-0.0002226553760206943,10015.2326334806402883,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +42.0000000000000000000,1.00000000000000000000,-5.5325004583333790009,0.00000000000000000000,-2.9507696725179792807,1.00000000000000000000,-0.0004999999610453660,0.99999983875740372507,-0.0002692307659781789,100.000000000000000000,-0.4321234787505787711,-0.4279649952595606654,-0.0002160410718464831,-0.0002139640001726733,0.00007683197179362697,0.00006877106310925840,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +43.0000000000000000000,0.00000000000000000000,-4.2647133758352211430,0.00000000000000000000,15.4659810589419066673,1.00000000000000000000,-0.0004230768951221369,0.17338301528678617957,0.98485438061471952675,100.000000000000000000,-0.4321234756860282688,-0.4279650153624057207,0.00003228041544444605,0.00002586846136564638,-0.0001913159324625164,-0.0001884007071553219,10015.2322773664891428,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +43.0000000000000000000,1.00000000000000000000,-4.6813464315164798890,0.00000000000000000000,-2.9507695673749601006,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,-0.0002692307659781789,100.000000000000000000,-0.4321234756860282688,-0.4279650153624057207,-0.0001828039782475866,-0.0001810464659043517,0.00006501166643091097,0.00005819090078006799,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +44.0000000000000000000,0.00000000000000000000,-3.4893108753294135304,0.00000000000000000000,15.4659805988285370403,1.00000000000000000000,-0.0003461538266954942,0.17338302042430592253,0.98485440975104188154,100.000000000000000000,-0.4321234731322334265,-0.4279650321147762670,0.00002641124831615345,0.00002116510507736683,-0.0001565312134560792,-0.0001541460361056589,10015.2319806047071324,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +44.0000000000000000000,1.00000000000000000000,-3.8301924597746999090,0.00000000000000000000,-2.9507694797548889020,1.00000000000000000000,-0.0003461538266954942,0.99999990384615677907,-0.0002692307659782344,100.000000000000000000,-0.4321234731322334265,-0.4279650321147762670,-0.0001495668874599468,-0.0001481289295261387,0.00005319136207311997,0.00004761073783783741,11000.0010576923741609,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +45.0000000000000000000,0.00000000000000000000,-2.7139084159450681532,0.00000000000000000000,15.4659802307414793176,1.00000000000000000000,-0.0002692307562206040,0.17338302453432172245,0.98485443306009978758,100.000000000000000000,-0.4321234710891982966,-0.4279650455166717493,0.00002054208159816959,0.00001646174859489353,-0.0001217464968575937,-0.0001198913632688492,10015.2317431952978949,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +45.0000000000000000000,1.00000000000000000000,-2.9790385330943731645,0.00000000000000000000,-2.9507694096595944444,1.00000000000000000000,-0.0002692307562206040,0.99999992751479449548,-0.0002692307659781789,100.000000000000000000,-0.4321234710891982966,-0.4279650455166717493,-0.0001163297989724271,-0.0001152113914216514,0.00004137105853754063,0.00003703057439402860,11000.0007973373176355,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +46.0000000000000000000,0.00000000000000000000,-1.9385059885440800719,0.00000000000000000000,15.4659799546752765309,1.00000000000000000000,-0.0001923076841526324,0.17338302761683363484,0.98485445054189346691,100.000000000000000000,-0.4321234695569216022,-0.4279650555680942214,0.00001467291519931472,0.00001175839196138076,-0.0000869617821319591,-0.0000856366890420371,10015.2315651382450596,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +46.0000000000000000000,1.00000000000000000000,-2.1278846414618417526,0.00000000000000000000,-2.9507693570878577027,1.00000000000000000000,-0.0001923076841526324,0.99999994526627300484,-0.0002692307659781789,100.000000000000000000,-0.4321234695569216022,-0.4279650555680942214,-0.0000830927122738894,-0.0000822938519745065,0.00002955075564145912,0.00002645041056010352,11000.0006020710279699,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +47.0000000000000000000,0.00000000000000000000,-1.1631035839883467897,0.00000000000000000000,15.4659797706299286801,1.00000000000000000000,-0.0001153846109467456,0.17338302967184154868,0.98485446219642258647,100.000000000000000000,-0.4321234685354028437,-0.4279650622690422956,0.00000880374902840911,0.00000705503521998260,-0.0000521770687440750,-0.0000513820138223659,10015.2314464335449883,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +47.0000000000000000000,1.00000000000000000000,-1.2767307748634502129,0.00000000000000000000,-2.9507693220401352007,1.00000000000000000000,-0.0001153846109467456,0.99999995710059197406,-0.0002692307659782344,100.000000000000000000,-0.4321234685354028437,-0.4279650622690422956,-0.0000498556268531958,-0.0000493763115683203,0.00001773045320216177,0.00001587024644752392,11000.0004718935069831,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +48.0000000000000000000,0.00000000000000000000,-0.3877011931397650323,0.00000000000000000000,15.4659796786090737441,1.00000000000000000000,-0.0000384615370581095,0.17338303069934551947,0.98485446802368714624,100.000000000000000000,-0.4321234680246436310,-0.4279650656195157498,0.00000293458299427308,0.00000235167841385321,-0.0000173923561588416,-0.0000171273380069791,10015.2313870811976812,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +48.0000000000000000000,1.00000000000000000000,-0.4255769232855405315,0.00000000000000000000,-2.9507693045161227374,1.00000000000000000000,-0.0000384615370581095,0.99999996301775140317,-0.0002692307659781789,100.000000000000000000,-0.4321234680246436310,-0.4279650656195157498,-0.0000166185421992089,-0.0000164587705867095,0.00000591015103693497,0.00000529008216775159,11000.0004068047473992,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +49.0000000000000000000,0.00000000000000000000,0.38770119313976503239,0.00000000000000000000,15.4659796786090737441,1.00000000000000000000,0.00003846153705810951,0.17338303069934551947,0.98485446802368714624,100.000000000000000000,-0.4321234680246436310,-0.4279650656195157498,-0.0000029345829942730,-0.0000023516784138532,0.00001739235615884162,0.00001712733800697919,10015.2313870811976812,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +49.0000000000000000000,1.00000000000000000000,0.42557692328554053151,0.00000000000000000000,-2.9507693045161227374,1.00000000000000000000,0.00003846153705810951,0.99999996301775140317,-0.0002692307659781789,100.000000000000000000,-0.4321234680246436310,-0.4279650656195157498,0.00001661854219920897,0.00001645877058670950,-0.0000059101510369349,-0.0000052900821677515,11000.0004068047473992,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +50.0000000000000000000,0.00000000000000000000,1.16310358398834678972,0.00000000000000000000,15.4659797706299286801,1.00000000000000000000,0.00011538461094674560,0.17338302967184154868,0.98485446219642258647,100.000000000000000000,-0.4321234685354028437,-0.4279650622690422956,-0.0000088037490284091,-0.0000070550352199826,0.00005217706874407506,0.00005138201382236591,10015.2314464335449883,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +50.0000000000000000000,1.00000000000000000000,1.27673077486345021291,0.00000000000000000000,-2.9507693220401352007,1.00000000000000000000,0.00011538461094674560,0.99999995710059197406,-0.0002692307659782344,100.000000000000000000,-0.4321234685354028437,-0.4279650622690422956,0.00004985562685319581,0.00004937631156832039,-0.0000177304532021617,-0.0000158702464475239,11000.0004718935069831,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +51.0000000000000000000,0.00000000000000000000,1.93850598854408051607,0.00000000000000000000,15.4659799546752765309,1.00000000000000000000,0.00019230768415263250,0.17338302761683363484,0.98485445054189346691,100.000000000000000000,-0.4321234695569216022,-0.4279650555680942214,-0.0000146729151993147,-0.0000117583919613807,0.00008696178213195919,0.00008563668904203720,10015.2315651382450596,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +51.0000000000000000000,1.00000000000000000000,2.12788464146184219671,0.00000000000000000000,-2.9507693570878577027,1.00000000000000000000,0.00019230768415263250,0.99999994526627300484,-0.0002692307659781789,100.000000000000000000,-0.4321234695569216022,-0.4279650555680942214,0.00008309271227388951,0.00008229385197450658,-0.0000295507556414591,-0.0000264504105601035,11000.0006020710279699,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +52.0000000000000000000,0.00000000000000000000,2.71390841594506815326,0.00000000000000000000,15.4659802307414793176,1.00000000000000000000,0.00026923075622060400,0.17338302453432172245,0.98485443306009978758,100.000000000000000000,-0.4321234710891982966,-0.4279650455166717493,-0.0000205420815981695,-0.0000164617485948935,0.00012174649685759374,0.00011989136326884928,10015.2317431952978949,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +52.0000000000000000000,1.00000000000000000000,2.97903853309437316454,0.00000000000000000000,-2.9507694096595944444,1.00000000000000000000,0.00026923075622060400,0.99999992751479449548,-0.0002692307659781789,100.000000000000000000,-0.4321234710891982966,-0.4279650455166717493,0.00011632979897242718,0.00011521139142165141,-0.0000413710585375406,-0.0000370305743940286,11000.0007973373176355,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +53.0000000000000000000,0.00000000000000000000,3.48931087532941353046,0.00000000000000000000,15.4659805988285370403,1.00000000000000000000,0.00034615382669549426,0.17338302042430592253,0.98485440975104188154,100.000000000000000000,-0.4321234731322334265,-0.4279650321147762670,-0.0000264112483161534,-0.0000211651050773668,0.00015653121345607926,0.00015414603610565893,10015.2319806047071324,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +53.0000000000000000000,1.00000000000000000000,3.83019245977469990904,0.00000000000000000000,-2.9507694797548889020,1.00000000000000000000,0.00034615382669549426,0.99999990384615677907,-0.0002692307659782344,100.000000000000000000,-0.4321234731322334265,-0.4279650321147762670,0.00014956688745994687,0.00014812892952613878,-0.0000531913620731199,-0.0000476107378378374,11000.0010576923741609,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +54.0000000000000000000,0.00000000000000000000,4.26471337583522203118,0.00000000000000000000,15.4659810589419066673,1.00000000000000000000,0.00042307689512213698,0.17338301528678617957,0.98485438061471952675,100.000000000000000000,-0.4321234756860282688,-0.4279650153624057207,-0.0000322804154444460,-0.0000258684613656464,0.00019131593246251649,0.00018840070715532198,10015.2322773664891428,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +54.0000000000000000000,1.00000000000000000000,4.68134643151648077719,0.00000000000000000000,-2.9507695673749601006,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,-0.0002692307659781789,100.000000000000000000,-0.4321234756860282688,-0.4279650153624057207,0.00018280397824758671,0.00018104646590435174,-0.0000650116664309110,-0.0000581909007800680,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +55.0000000000000000000,0.00000000000000000000,5.04011592660059815074,0.00000000000000000000,15.4659816110743122408,1.00000000000000000000,0.00049999996104536600,0.17338300912176257684,0.98485434565113327831,100.000000000000000000,-0.4321234787505787711,-0.4279649952595606654,-0.0000381495830742269,-0.0000305718174165780,0.00022610065441200442,0.00022265537602069436,10015.2326334806402883,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +55.0000000000000000000,1.00000000000000000000,5.53250045833337900091,0.00000000000000000000,-2.9507696725179792807,1.00000000000000000000,0.00049999996104536600,0.99999983875740372507,-0.0002692307659781789,100.000000000000000000,-0.4321234787505787711,-0.4279649952595606654,0.00021604107184648317,0.00021396400017267337,-0.0000768319717936269,-0.0000687710631092584,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +56.0000000000000000000,0.00000000000000000000,-5.0379376909028907860,0.00000000000000000000,11.0423049908895336557,1.00000000000000000000,-0.0004999999699211052,0.17345876664477777318,0.98484100558115605927,100.000000000000000000,-0.4318737124385033099,-0.4280041304715263006,0.00003812947108613011,0.00003057426111194370,-0.0002259763078458112,-0.0002226810467299873,10010.8759840379534580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +56.0000000000000000000,1.00000000000000000000,-5.5325004583333798890,0.00000000000000000000,-2.1076925981927949749,1.00000000000000000000,-0.0004999999699211052,0.99999985650888068011,-0.0001923076911223842,100.000000000000000000,-0.4318737124385033099,-0.4280041304715263006,-0.0002159221067941179,-0.0002139888565429634,0.00007679057279720211,0.00006877792735128866,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +57.0000000000000000000,0.00000000000000000000,-4.2628702534312719052,0.00000000000000000000,11.0423045968527731020,1.00000000000000000000,-0.0004230769026323778,0.17345877280980148693,0.98484104054474297385,100.000000000000000000,-0.4318737093679603233,-0.4280041505672902424,0.00003226339760838236,0.00002587052910732211,-0.0001912107161369070,-0.0001884224285211200,10010.8756282341673795,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +57.0000000000000000000,1.00000000000000000000,-4.6813464315164816653,0.00000000000000000000,-2.1076925230902161523,1.00000000000000000000,-0.0004230769026323778,0.99999989201183725473,-0.0001923076911223287,100.000000000000000000,-0.4318737093679603233,-0.4280041505672902424,-0.0001827033155106033,-0.0001810674982142218,0.00006497663651081308,0.00005819670898368875,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +58.0000000000000000000,0.00000000000000000000,-3.4878028661644737695,0.00000000000000000000,11.0423042684888059739,1.00000000000000000000,-0.0003461538328402369,0.17345877794732134091,0.98484106968106577273,100.000000000000000000,-0.4318737068091731967,-0.4280041673137604529,0.00002639732463211382,0.00002116679686563103,-0.0001564451273712386,-0.0001541638081297644,10010.8753317310292914,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +58.0000000000000000000,1.00000000000000000000,-3.8301924597746999090,0.00000000000000000000,-2.1076924605053104500,1.00000000000000000000,-0.0003461538328402369,0.99999992159763473331,-0.0001923076911223287,100.000000000000000000,-0.4318737068091731967,-0.4280041673137604529,-0.0001494845270385292,-0.0001481461377773155,0.00005316270122937220,0.00004761549000363584,11000.0008624260844953,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +59.0000000000000000000,0.00000000000000000000,-2.7127355199743448110,0.00000000000000000000,11.0423040057958132820,1.00000000000000000000,-0.0002692307609998483,0.17345878205733722410,0.98484109299012412286,100.000000000000000000,-0.4318737047621426516,-0.4280041807109364881,0.00002053125206614648,0.00001646306442997399,-0.0001216795410136720,-0.0001199051859527362,10010.8750945285282796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +59.0000000000000000000,1.00000000000000000000,-2.9790385330943736086,0.00000000000000000000,-2.1076924104369556545,1.00000000000000000000,-0.0002692307609998483,0.99999994526627289381,-0.0001923076911223287,100.000000000000000000,-0.4318737047621426516,-0.4280041807109364881,-0.0001162657408667244,-0.0001152247756155468,0.00004134876677016163,0.00003703427052248494,11000.0006020710297889,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +60.0000000000000000000,0.00000000000000000000,-1.9376682057327345720,0.00000000000000000000,11.0423038087774330051,1.00000000000000000000,-0.0001923076875663784,0.17345878513984916424,0.98484111047191813526,100.000000000000000000,-0.4318737032268696318,-0.4280041907588182370,0.00001466517981930236,0.00001175933184345455,-0.0000869139565290740,-0.0000856465623868516,10010.8749166266588872,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +60.0000000000000000000,1.00000000000000000000,-2.1278846414618426408,0.00000000000000000000,-2.1076923728854666251,1.00000000000000000000,-0.0001923076875663784,0.99999996301775173623,-0.0001923076911223287,100.000000000000000000,-0.4318737032268696318,-0.4280041907588182370,-0.0000830469564840184,-0.0000823034121122186,0.00002953483295046364,0.00002645305065159123,11000.0004068047455803,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +61.0000000000000000000,0.00000000000000000000,-1.1626009143114937050,0.00000000000000000000,11.0423036774336651433,1.00000000000000000000,-0.0001153846129949931,0.17345878719485713359,0.98484112212644736583,100.000000000000000000,-0.4318737022033538597,-0.4280041974574061991,0.00000879910780040334,0.00000705559914917626,-0.0000521483733823105,-0.0000513879378289270,10010.8747980254174763,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +61.0000000000000000000,1.00000000000000000000,-1.2767307748634504349,0.00000000000000000000,-2.1076923478513536203,1.00000000000000000000,-0.0001153846129949931,0.99999997485207092751,-0.0001923076911223842,100.000000000000000000,-0.4318737022033538597,-0.4280041974574061991,-0.0000498281733792400,-0.0000493820476506338,0.00001772089958756030,0.00001587183050230981,11000.0002766272227745,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +62.0000000000000000000,0.00000000000000000000,-0.3875336365824728623,0.00000000000000000000,11.0423036117590527283,1.00000000000000000000,-0.0000384615377408587,0.17345878822236113214,0.98484112795371214765,100.000000000000000000,-0.4318737016915966120,-0.4280042008067003744,0.00000293303591827144,0.00000235186639024267,-0.0000173827910382478,-0.0000171293126757783,10010.8747387247949518,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +62.0000000000000000000,1.00000000000000000000,-0.4255769232855404760,0.00000000000000000000,-2.1076923353344878542,1.00000000000000000000,-0.0000384615377408587,0.99999998076923068968,-0.0001923076911223842,100.000000000000000000,-0.4318737016915966120,-0.4280042008067003744,-0.0000166093910412181,-0.0000164606826140950,0.00000590696649873379,0.00000529061018599578,11000.0002115384631906,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +63.0000000000000000000,0.00000000000000000000,0.38753363658247286238,0.00000000000000000000,11.0423036117590527283,1.00000000000000000000,0.00003846153774085871,0.17345878822236113214,0.98484112795371214765,100.000000000000000000,-0.4318737016915966120,-0.4280042008067003744,-0.0000029330359182714,-0.0000023518663902426,0.00001738279103824789,0.00001712931267577834,10010.8747387247949518,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +63.0000000000000000000,1.00000000000000000000,0.42557692328554047600,0.00000000000000000000,-2.1076923353344878542,1.00000000000000000000,0.00003846153774085871,0.99999998076923068968,-0.0001923076911223842,100.000000000000000000,-0.4318737016915966120,-0.4280042008067003744,0.00001660939104121817,0.00001646068261409506,-0.0000059069664987337,-0.0000052906101859957,11000.0002115384631906,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +64.0000000000000000000,0.00000000000000000000,1.16260091431149370500,0.00000000000000000000,11.0423036774336651433,1.00000000000000000000,0.00011538461299499319,0.17345878719485713359,0.98484112212644736583,100.000000000000000000,-0.4318737022033538597,-0.4280041974574061991,-0.0000087991078004033,-0.0000070555991491762,0.00005214837338231058,0.00005138793782892705,10010.8747980254174763,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +64.0000000000000000000,1.00000000000000000000,1.27673077486345043496,0.00000000000000000000,-2.1076923478513536203,1.00000000000000000000,0.00011538461299499319,0.99999997485207092751,-0.0001923076911223842,100.000000000000000000,-0.4318737022033538597,-0.4280041974574061991,0.00004982817337924001,0.00004938204765063389,-0.0000177208995875603,-0.0000158718305023098,11000.0002766272227745,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +65.0000000000000000000,0.00000000000000000000,1.93766820573273523820,0.00000000000000000000,11.0423038087774330051,1.00000000000000000000,0.00019230768756637849,0.17345878513984916424,0.98484111047191813526,100.000000000000000000,-0.4318737032268696318,-0.4280041907588182370,-0.0000146651798193023,-0.0000117593318434545,0.00008691395652907411,0.00008564656238685171,10010.8749166266588872,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +65.0000000000000000000,1.00000000000000000000,2.12788464146184352898,0.00000000000000000000,-2.1076923728854666251,1.00000000000000000000,0.00019230768756637849,0.99999996301775173623,-0.0001923076911223287,100.000000000000000000,-0.4318737032268696318,-0.4280041907588182370,0.00008304695648401849,0.00008230341211221872,-0.0000295348329504636,-0.0000264530506515912,11000.0004068047455803,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +66.0000000000000000000,0.00000000000000000000,2.71273551997434481108,0.00000000000000000000,11.0423040057958132820,1.00000000000000000000,0.00026923076099984833,0.17345878205733722410,0.98484109299012412286,100.000000000000000000,-0.4318737047621426516,-0.4280041807109364881,-0.0000205312520661464,-0.0000164630644299739,0.00012167954101367209,0.00011990518595273621,10010.8750945285282796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +66.0000000000000000000,1.00000000000000000000,2.97903853309437360863,0.00000000000000000000,-2.1076924104369556545,1.00000000000000000000,0.00026923076099984833,0.99999994526627289381,-0.0001923076911223287,100.000000000000000000,-0.4318737047621426516,-0.4280041807109364881,0.00011626574086672446,0.00011522477561554686,-0.0000413487667701616,-0.0000370342705224849,11000.0006020710297889,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +67.0000000000000000000,0.00000000000000000000,3.48780286616447376957,0.00000000000000000000,11.0423042684888059739,1.00000000000000000000,0.00034615383284023691,0.17345877794732134091,0.98484106968106577273,100.000000000000000000,-0.4318737068091731967,-0.4280041673137604529,-0.0000263973246321138,-0.0000211667968656310,0.00015644512737123862,0.00015416380812976443,10010.8753317310292914,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +67.0000000000000000000,1.00000000000000000000,3.83019245977469990904,0.00000000000000000000,-2.1076924605053104500,1.00000000000000000000,0.00034615383284023691,0.99999992159763473331,-0.0001923076911223287,100.000000000000000000,-0.4318737068091731967,-0.4280041673137604529,0.00014948452703852924,0.00014814613777731555,-0.0000531627012293722,-0.0000476154900036358,11000.0008624260844953,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +68.0000000000000000000,0.00000000000000000000,4.26287025343127279342,0.00000000000000000000,11.0423045968527731020,1.00000000000000000000,0.00042307690263237795,0.17345877280980148693,0.98484104054474297385,100.000000000000000000,-0.4318737093679603233,-0.4280041505672902424,-0.0000322633976083823,-0.0000258705291073221,0.00019121071613690707,0.00018842242852112008,10010.8756282341673795,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +68.0000000000000000000,1.00000000000000000000,4.68134643151648255354,0.00000000000000000000,-2.1076925230902161523,1.00000000000000000000,0.00042307690263237795,0.99999989201183725473,-0.0001923076911223287,100.000000000000000000,-0.4318737093679603233,-0.4280041505672902424,0.00018270331551060339,0.00018106749821422189,-0.0000649766365108130,-0.0000581967089836887,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +69.0000000000000000000,0.00000000000000000000,5.03793769090289078604,0.00000000000000000000,11.0423049908895336557,1.00000000000000000000,0.00049999996992110523,0.17345876664477777318,0.98484100558115605927,100.000000000000000000,-0.4318737124385033099,-0.4280041304715263006,-0.0000381294710861301,-0.0000305742611119437,0.00022597630784581125,0.00022268104672998735,10010.8759840379534580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +69.0000000000000000000,1.00000000000000000000,5.53250045833337988909,0.00000000000000000000,-2.1076925981927949749,1.00000000000000000000,0.00049999996992110523,0.99999985650888068011,-0.0001923076911223842,100.000000000000000000,-0.4318737124385033099,-0.4280041304715263006,0.00021592210679411796,0.00021398885654296342,-0.0000767905727972021,-0.0000687779273512886,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +70.0000000000000000000,0.00000000000000000000,-5.0357613570359269772,0.00000000000000000000,6.62249070948018925264,1.00000000000000000000,-0.0004999999758382646,0.17353452314140974110,0.98482765968371710485,100.000000000000000000,-0.4316239869640552950,-0.4280431494641024348,0.00003810936256210822,0.00003057669633516822,-0.0002258519761560260,-0.0002227066580136339,10006.5231976217837654,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +70.0000000000000000000,1.00000000000000000000,-5.5325004583333798890,0.00000000000000000000,-1.2646155489016108752,1.00000000000000000000,-0.0004999999758382646,0.99999986834319842810,-0.0001153846151284998,100.000000000000000000,-0.4316239869640552950,-0.4280431494641024348,-0.0002158031557906243,-0.0002140136558615880,0.00007674917979548627,0.00006878477293073343,11000.0014482250062428,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +71.0000000000000000000,0.00000000000000000000,-4.2610287402685669277,0.00000000000000000000,6.62249047326440631877,1.00000000000000000000,-0.0004230769076392051,0.17353452930643353813,0.98482769464730446351,100.000000000000000000,-0.4316239838875248757,-0.4280431695527843749,0.00003224638270345921,0.00002587258968026314,-0.0001911055123990294,-0.0001884440996036797,10006.5228421279589383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +71.0000000000000000000,1.00000000000000000000,-4.6813464315164816653,0.00000000000000000000,-1.2646155038403361636,1.00000000000000000000,-0.0004230769076392051,0.99999990384615544680,-0.0001153846151284998,100.000000000000000000,-0.4316239838875248757,-0.4280431695527843749,-0.0001826026646611287,-0.0001810884822496066,0.00006494161166316182,0.00005820250139589127,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +72.0000000000000000000,0.00000000000000000000,-3.4862961736513575772,0.00000000000000000000,6.62249027641701104585,1.00000000000000000000,-0.0003461538369367320,0.17353453444395344762,0.98482772378362781751,100.000000000000000000,-0.4316239813237479072,-0.4280431862933523068,0.00002638340334628019,0.00002116848278856686,-0.0001563590515854520,-0.0001541815390130382,10006.5225458831209834,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +72.0000000000000000000,1.00000000000000000000,-3.8301924597747003531,0.00000000000000000000,-1.2646154662890023434,1.00000000000000000000,-0.0003461538369367320,0.99999993343195359152,-0.0001153846151286108,100.000000000000000000,-0.4316239813237479072,-0.4280431862933523068,-0.0001494021763432557,-0.0001481633065311858,0.00005313404453580825,0.00004762022924918294,11000.0007322485616896,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +73.0000000000000000000,0.00000000000000000000,-2.7115636480660865181,0.00000000000000000000,6.62249011893982242327,1.00000000000000000000,-0.0002692307641860112,0.17353453855396935856,0.98482774709268638968,100.000000000000000000,-0.4316239792727267210,-0.4280431996858073961,0.00002052042439939489,0.00001646437570313239,-0.0001216125931801270,-0.0001199189766381985,10006.5223088872608059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +73.0000000000000000000,1.00000000000000000000,-2.9790385330943727204,0.00000000000000000000,-1.2646154362484560707,1.00000000000000000000,-0.0002692307641860112,0.99999995710059197406,-0.0001153846151286108,100.000000000000000000,-0.4316239792727267210,-0.4280431996858073961,-0.0001162016903258017,-0.0001152381290893151,0.00004132647823070378,0.00003703795660185697,11000.0004718935069831,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +74.0000000000000000000,0.00000000000000000000,-1.9368311543945435637,0.00000000000000000000,6.62249000083102146163,1.00000000000000000000,-0.0001923076898422090,0.17353454163648135422,0.98482776457448051310,100.000000000000000000,-0.4316239777344598738,-0.4280432097301485883,0.00001465744577162683,0.00001176026846701262,-0.0000868661366478869,-0.0000856564128756489,10006.5221311403711297,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +74.0000000000000000000,1.00000000000000000000,-2.1278846414618426408,0.00000000000000000000,-1.2646154137176850440,1.00000000000000000000,-0.0001923076898422090,0.99999997485207092751,-0.0001153846151285553,100.000000000000000000,-0.4316239777344598738,-0.4280432097301485883,-0.0000830012060975621,-0.0000823129503069831,0.00002951891256512624,0.00002645568356516164,11000.0002766272245935,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +75.0000000000000000000,0.00000000000000000000,-1.1620986835185191932,0.00000000000000000000,6.62248992209424613974,1.00000000000000000000,-0.0001153846143604915,0.17353454369148932356,0.98482777622900996572,100.000000000000000000,-0.4316239767089485868,-0.4280432164263753280,0.00000879446737179973,0.00000705616112326049,-0.0000521196814535650,-0.0000513938481218778,10006.5220126424501358,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +75.0000000000000000000,1.00000000000000000000,-1.2767307748634502129,0.00000000000000000000,-1.2646153986975698924,1.00000000000000000000,-0.0001153846143604915,0.99999998668639011878,-0.0001153846151285553,100.000000000000000000,-0.4316239767089485868,-0.4280432164263753280,-0.0000498007231473331,-0.0000493877705671787,0.00001771134735635374,0.00001587341025034533,11000.0001464497054257,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +76.0000000000000000000,0.00000000000000000000,-0.3873662263198047739,0.00000000000000000000,6.62248988272403948940,1.00000000000000000000,-0.0000384615381960248,0.17353454471899334987,0.98482778205627474754,100.000000000000000000,-0.4316239761961930820,-0.4280432197744888367,0.00000293148910873717,0.00000235205371492898,-0.0000173732270619938,-0.0000171312827733739,10006.5219533934887294,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +76.0000000000000000000,1.00000000000000000000,-0.4255769232855405315,0.00000000000000000000,-1.2646153911866724328,1.00000000000000000000,-0.0000384615381960248,0.99999999260354999197,-0.0001153846151285553,100.000000000000000000,-0.4316239761961930820,-0.4280432197744888367,-0.0000166002409639103,-0.0000164625902528910,0.00000590378242166424,0.00000529113676865649,11000.0000813609494798,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +77.0000000000000000000,0.00000000000000000000,0.38736622631980477393,0.00000000000000000000,6.62248988272403948940,1.00000000000000000000,0.00003846153819602484,0.17353454471899334987,0.98482778205627474754,100.000000000000000000,-0.4316239761961930820,-0.4280432197744888367,-0.0000029314891087371,-0.0000023520537149289,0.00001737322706199380,0.00001713128277337399,10006.5219533934887294,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +77.0000000000000000000,1.00000000000000000000,0.42557692328554053151,0.00000000000000000000,-1.2646153911866724328,1.00000000000000000000,0.00003846153819602484,0.99999999260354999197,-0.0001153846151285553,100.000000000000000000,-0.4316239761961930820,-0.4280432197744888367,0.00001660024096391033,0.00001646259025289103,-0.0000059037824216642,-0.0000052911367686564,11000.0000813609494798,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +78.0000000000000000000,0.00000000000000000000,1.16209868351851919321,0.00000000000000000000,6.62248992209424613974,1.00000000000000000000,0.00011538461436049158,0.17353454369148932356,0.98482777622900996572,100.000000000000000000,-0.4316239767089485868,-0.4280432164263753280,-0.0000087944673717997,-0.0000070561611232604,0.00005211968145356501,0.00005139384812187780,10006.5220126424501358,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +78.0000000000000000000,1.00000000000000000000,1.27673077486345021291,0.00000000000000000000,-1.2646153986975698924,1.00000000000000000000,0.00011538461436049158,0.99999998668639011878,-0.0001153846151285553,100.000000000000000000,-0.4316239767089485868,-0.4280432164263753280,0.00004980072314733310,0.00004938777056717873,-0.0000177113473563537,-0.0000158734102503453,11000.0001464497054257,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +79.0000000000000000000,0.00000000000000000000,1.93683115439454400785,0.00000000000000000000,6.62249000083102146163,1.00000000000000000000,0.00019230768984220914,0.17353454163648135422,0.98482776457448051310,100.000000000000000000,-0.4316239777344598738,-0.4280432097301485883,-0.0000146574457716268,-0.0000117602684670126,0.00008686613664788704,0.00008565641287564893,10006.5221311403711297,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +79.0000000000000000000,1.00000000000000000000,2.12788464146184308489,0.00000000000000000000,-1.2646154137176850440,1.00000000000000000000,0.00019230768984220914,0.99999997485207092751,-0.0001153846151285553,100.000000000000000000,-0.4316239777344598738,-0.4280432097301485883,0.00008300120609756219,0.00008231295030698317,-0.0000295189125651262,-0.0000264556835651616,11000.0002766272245935,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +80.0000000000000000000,0.00000000000000000000,2.71156364806608651818,0.00000000000000000000,6.62249011893982242327,1.00000000000000000000,0.00026923076418601120,0.17353453855396935856,0.98482774709268638968,100.000000000000000000,-0.4316239792727267210,-0.4280431996858073961,-0.0000205204243993948,-0.0000164643757031323,0.00012161259318012703,0.00011991897663819853,10006.5223088872608059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +80.0000000000000000000,1.00000000000000000000,2.97903853309437272045,0.00000000000000000000,-1.2646154362484560707,1.00000000000000000000,0.00026923076418601120,0.99999995710059197406,-0.0001153846151286108,100.000000000000000000,-0.4316239792727267210,-0.4280431996858073961,0.00011620169032580171,0.00011523812908931513,-0.0000413264782307037,-0.0000370379566018569,11000.0004718935069831,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +81.0000000000000000000,0.00000000000000000000,3.48629617365135757722,0.00000000000000000000,6.62249027641701104585,1.00000000000000000000,0.00034615383693673202,0.17353453444395344762,0.98482772378362781751,100.000000000000000000,-0.4316239813237479072,-0.4280431862933523068,-0.0000263834033462801,-0.0000211684827885668,0.00015635905158545201,0.00015418153901303823,10006.5225458831209834,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +81.0000000000000000000,1.00000000000000000000,3.83019245977470035313,0.00000000000000000000,-1.2646154662890023434,1.00000000000000000000,0.00034615383693673202,0.99999993343195359152,-0.0001153846151286108,100.000000000000000000,-0.4316239813237479072,-0.4280431862933523068,0.00014940217634325575,0.00014816330653118586,-0.0000531340445358082,-0.0000476202292491829,11000.0007322485616896,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +82.0000000000000000000,0.00000000000000000000,4.26102874026856692779,0.00000000000000000000,6.62249047326440631877,1.00000000000000000000,0.00042307690763920520,0.17353452930643353813,0.98482769464730446351,100.000000000000000000,-0.4316239838875248757,-0.4280431695527843749,-0.0000322463827034592,-0.0000258725896802631,0.00019110551239902951,0.00018844409960367978,10006.5228421279589383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +82.0000000000000000000,1.00000000000000000000,4.68134643151648166536,0.00000000000000000000,-1.2646155038403361636,1.00000000000000000000,0.00042307690763920520,0.99999990384615544680,-0.0001153846151284998,100.000000000000000000,-0.4316239838875248757,-0.4280431695527843749,0.00018260266466112878,0.00018108848224960666,-0.0000649416116631618,-0.0000582025013958912,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +83.0000000000000000000,0.00000000000000000000,5.03576135703592697723,0.00000000000000000000,6.62249070948018925264,1.00000000000000000000,0.00049999997583826468,0.17353452314140974110,0.98482765968371710485,100.000000000000000000,-0.4316239869640552950,-0.4280431494641024348,-0.0000381093625621082,-0.0000305766963351682,0.00022585197615602602,0.00022270665801363395,10006.5231976217837654,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +83.0000000000000000000,1.00000000000000000000,5.53250045833337988909,0.00000000000000000000,-1.2646155489016108752,1.00000000000000000000,0.00049999997583826468,0.99999986834319842810,-0.0001153846151284998,100.000000000000000000,-0.4316239869640552950,-0.4280431494641024348,0.00021580315579062433,0.00021401365586158800,-0.0000767491797954862,-0.0000687847729307334,11000.0014482250062428,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +84.0000000000000000000,0.00000000000000000000,-5.0335869224842184621,0.00000000000000000000,2.20653365826001390814,1.00000000000000000000,-0.0004999999787968444,0.17361027861121022808,0.98481430795889590701,100.000000000000000000,-0.4313743023777222296,-0.4280820522716073384,0.00003808925750530335,0.00003057912308849251,-0.0002257276593703114,-0.0002227322098851433,10002.1742691237504914,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +84.0000000000000000000,1.00000000000000000000,-5.5325004583333790009,0.00000000000000000000,-0.4215385146319557407,1.00000000000000000000,-0.0004999999787968444,0.99999987426035752413,-0.0000384615384519948,100.000000000000000000,-0.4313743023777222296,-0.4280820522716073384,-0.0002156842188626990,-0.0002140383981414620,0.00007670779279637734,0.00006879159985214542,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +85.0000000000000000000,0.00000000000000000000,-4.2591888342186194904,0.00000000000000000000,2.20653357959054119419,1.00000000000000000000,-0.0004230769101426188,0.17361028477623405286,0.98481434292248337669,100.000000000000000000,-0.4313742992952100396,-0.4280820723532055560,0.00003222937073233544,0.00002587464308636560,-0.0001910003212722909,-0.0001884657204144312,10002.1739139394794619,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +85.0000000000000000000,1.00000000000000000000,-4.6813464315164825535,0.00000000000000000000,-0.4215384996116823268,1.00000000000000000000,-0.0004230769101426188,0.99999990976331465386,-0.0000384615384519948,100.000000000000000000,-0.4313742992952100396,-0.4280820723532055560,-0.0001825020257217527,-0.0001811094180214334,0.00006490659189464023,0.00005820827802052772,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +86.0000000000000000000,0.00000000000000000000,-3.4847907960485748901,0.00000000000000000000,2.20653351403234410099,1.00000000000000000000,-0.0003461538389849795,0.17361028991375396235,0.98481437205880673069,100.000000000000000000,-0.4313742967264482808,-0.4280820890878700990,0.00002636948446082810,0.00002117016284772573,-0.0001562729861178717,-0.0001541992287648329,10002.1736179526014893,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +86.0000000000000000000,1.00000000000000000000,-3.8301924597746994649,0.00000000000000000000,-0.4215384870951199292,1.00000000000000000000,-0.0003461538389849795,0.99999993934911268755,-0.0000384615384520503,100.000000000000000000,-0.4313742967264482808,-0.4280820890878700990,-0.0001493198353926100,-0.0001481804357966908,0.00005310539199789638,0.00004762495557763065,11000.0006671597966487,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +87.0000000000000000000,0.00000000000000000000,-2.7103927988658003123,0.00000000000000000000,2.20653346158360363915,1.00000000000000000000,-0.0002692307657790926,0.17361029402376992880,0.98481439536786552491,100.000000000000000000,-0.4313742946714378412,-0.4280821024756021886,0.00002050959859960672,0.00001646568241557536,-0.0001215456533718538,-0.0001199327353325103,10002.1733811631074786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +87.0000000000000000000,1.00000000000000000000,-2.9790385330943731645,0.00000000000000000000,-0.4215384770810353121,1.00000000000000000000,-0.0002692307657790926,0.99999996301775140317,-0.0000384615384519948,100.000000000000000000,-0.4313742946714378412,-0.4280821024756021886,-0.0001161376473640341,-0.0001152514518499102,0.00004130419292341983,0.00003704163263459609,11000.0004068047455803,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +88.0000000000000000000,0.00000000000000000000,-1.9359948335620118520,0.00000000000000000000,2.20653342224977677688,1.00000000000000000000,-0.0001923076909801243,0.17361029710628195221,0.98481441284965987037,100.000000000000000000,-0.4313742931301800531,-0.4280821125164011031,0.00001464971305749671,0.00001176120183291681,-0.0000868183224990375,-0.0000856662405136241,10002.1732035709956107,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +88.0000000000000000000,1.00000000000000000000,-2.1278846414618417526,0.00000000000000000000,-0.4215384695705227668,1.00000000000000000000,-0.0001923076909801243,0.99999998076923057865,-0.0000384615384519948,100.000000000000000000,-0.4313742931301800531,-0.4280821125164011031,-0.0000829554611247886,-0.0000823224665637666,0.00002950299448848466,0.00002645830930256566,11000.0002115384650096,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +89.0000000000000000000,0.00000000000000000000,-1.1615968910289264925,0.00000000000000000000,2.20653339602540654595,1.00000000000000000000,-0.0001153846150432407,0.17361029916128994932,0.98481442450418932299,100.000000000000000000,-0.4313742921026754162,-0.4280821192102670647,0.00000878982774332337,0.00000705672114275241,-0.0000520909929642222,-0.0000513997447043355,10002.1730851762549718,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +89.0000000000000000000,1.00000000000000000000,-1.2767307748634504349,0.00000000000000000000,-0.4215384645634527860,1.00000000000000000000,-0.0001153846150432407,0.99999999260354999197,-0.0000384615384519393,100.000000000000000000,-0.4313742921026754162,-0.4280821192102670647,-0.0000497732761636361,-0.0000493934803209351,0.00001770179651036473,0.00001587498569268105,11000.0000813609476608,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +90.0000000000000000000,0.00000000000000000000,-0.3871989621582616614,0.00000000000000000000,2.20653338291413092520,1.00000000000000000000,-0.0000384615384236079,0.17361030018879394787,0.98481443033145410481,100.000000000000000000,-0.4313742915889225426,-0.4280821225571997956,0.00000292994256591200,0.00000235224038808452,-0.0000173636642322073,-0.0000171332483008053,10002.1730259788873809,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +90.0000000000000000000,1.00000000000000000000,-0.4255769232855404760,0.00000000000000000000,-0.4215384620603072063,1.00000000000000000000,-0.0000384615384236079,0.99999999852070975414,-0.0000384615384519948,100.000000000000000000,-0.4313742915889225426,-0.4280821225571997956,-0.0000165910919693391,-0.0000164644935040908,0.00000590059880633388,0.00000529166191608395,11000.0000162721898959,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +91.0000000000000000000,0.00000000000000000000,0.38719896215826166141,0.00000000000000000000,2.20653338291413092520,1.00000000000000000000,0.00003846153842360791,0.17361030018879394787,0.98481443033145410481,100.000000000000000000,-0.4313742915889225426,-0.4280821225571997956,-0.0000029299425659120,-0.0000023522403880845,0.00001736366423220732,0.00001713324830080531,10002.1730259788873809,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +91.0000000000000000000,1.00000000000000000000,0.42557692328554047600,0.00000000000000000000,-0.4215384620603072063,1.00000000000000000000,0.00003846153842360791,0.99999999852070975414,-0.0000384615384519948,100.000000000000000000,-0.4313742915889225426,-0.4280821225571997956,0.00001659109196933915,0.00001646449350409088,-0.0000059005988063338,-0.0000052916619160839,11000.0000162721898959,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +92.0000000000000000000,0.00000000000000000000,1.16159689102892649259,0.00000000000000000000,2.20653339602540654595,1.00000000000000000000,0.00011538461504324078,0.17361029916128994932,0.98481442450418932299,100.000000000000000000,-0.4313742921026754162,-0.4280821192102670647,-0.0000087898277433233,-0.0000070567211427524,0.00005209099296422225,0.00005139974470433550,10002.1730851762549718,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +92.0000000000000000000,1.00000000000000000000,1.27673077486345043496,0.00000000000000000000,-0.4215384645634527860,1.00000000000000000000,0.00011538461504324078,0.99999999260354999197,-0.0000384615384519393,100.000000000000000000,-0.4313742921026754162,-0.4280821192102670647,0.00004977327616363612,0.00004939348032093512,-0.0000177017965103647,-0.0000158749856926810,11000.0000813609476608,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +93.0000000000000000000,0.00000000000000000000,1.93599483356201229611,0.00000000000000000000,2.20653342224977677688,1.00000000000000000000,0.00019230769098012445,0.17361029710628195221,0.98481441284965987037,100.000000000000000000,-0.4313742931301800531,-0.4280821125164011031,-0.0000146497130574967,-0.0000117612018329168,0.00008681832249903757,0.00008566624051362422,10002.1732035709956107,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +93.0000000000000000000,1.00000000000000000000,2.12788464146184264080,0.00000000000000000000,-0.4215384695705227668,1.00000000000000000000,0.00019230769098012445,0.99999998076923057865,-0.0000384615384519948,100.000000000000000000,-0.4313742931301800531,-0.4280821125164011031,0.00008295546112478867,0.00008232246656376668,-0.0000295029944884846,-0.0000264583093025656,11000.0002115384650096,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +94.0000000000000000000,0.00000000000000000000,2.71039279886580031231,0.00000000000000000000,2.20653346158360363915,1.00000000000000000000,0.00026923076577909266,0.17361029402376992880,0.98481439536786552491,100.000000000000000000,-0.4313742946714378412,-0.4280821024756021886,-0.0000205095985996067,-0.0000164656824155753,0.00012154565337185388,0.00011993273533251037,10002.1733811631074786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +94.0000000000000000000,1.00000000000000000000,2.97903853309437316454,0.00000000000000000000,-0.4215384770810353121,1.00000000000000000000,0.00026923076577909266,0.99999996301775140317,-0.0000384615384519948,100.000000000000000000,-0.4313742946714378412,-0.4280821024756021886,0.00011613764736403419,0.00011525145184991029,-0.0000413041929234198,-0.0000370416326345960,11000.0004068047455803,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +95.0000000000000000000,0.00000000000000000000,3.48479079604857489016,0.00000000000000000000,2.20653351403234410099,1.00000000000000000000,0.00034615383898497955,0.17361028991375396235,0.98481437205880673069,100.000000000000000000,-0.4313742967264482808,-0.4280820890878700990,-0.0000263694844608281,-0.0000211701628477257,0.00015627298611787176,0.00015419922876483299,10002.1736179526014893,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +95.0000000000000000000,1.00000000000000000000,3.83019245977469946495,0.00000000000000000000,-0.4215384870951199292,1.00000000000000000000,0.00034615383898497955,0.99999993934911268755,-0.0000384615384520503,100.000000000000000000,-0.4313742967264482808,-0.4280820890878700990,0.00014931983539261001,0.00014818043579669089,-0.0000531053919978963,-0.0000476249555776306,11000.0006671597966487,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +96.0000000000000000000,0.00000000000000000000,4.25918883421861949045,0.00000000000000000000,2.20653357959054119419,1.00000000000000000000,0.00042307691014261891,0.17361028477623405286,0.98481434292248337669,100.000000000000000000,-0.4313742992952100396,-0.4280820723532055560,-0.0000322293707323354,-0.0000258746430863656,0.00019100032127229103,0.00018846572041443125,10002.1739139394794619,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +96.0000000000000000000,1.00000000000000000000,4.68134643151648255354,0.00000000000000000000,-0.4215384996116823268,1.00000000000000000000,0.00042307691014261891,0.99999990976331465386,-0.0000384615384519948,100.000000000000000000,-0.4313742992952100396,-0.4280820723532055560,0.00018250202572175282,0.00018110941802143343,-0.0000649065918946402,-0.0000582082780205277,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +97.0000000000000000000,0.00000000000000000000,5.03358692248421846215,0.00000000000000000000,2.20653365826001390814,1.00000000000000000000,0.00049999997879684445,0.17361027861121022808,0.98481430795889590701,100.000000000000000000,-0.4313743023777222296,-0.4280820522716073384,-0.0000380892575053033,-0.0000305791230884925,0.00022572765937031144,0.00022273220988514339,10002.1742691237504914,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +97.0000000000000000000,1.00000000000000000000,5.53250045833337900091,0.00000000000000000000,-0.4215385146319557407,1.00000000000000000000,0.00049999997879684445,0.99999987426035752413,-0.0000384615384519948,100.000000000000000000,-0.4313743023777222296,-0.4280820522716073384,0.00021568421886269909,0.00021403839814146207,-0.0000767077927963773,-0.0000687915998521454,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +98.0000000000000000000,0.00000000000000000000,-5.0314143847367125417,0.00000000000000000000,-2.2055712623514409642,1.00000000000000000000,-0.0004999999787968444,0.17368603305373095380,0.98480095040677106954,100.000000000000000000,-0.4311246587299824017,-0.4281208389283887028,0.00003806915591885777,0.00003058154137415927,-0.0002256033575163280,-0.0002227577023580414,9997.82919344448055198,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +98.0000000000000000000,1.00000000000000000000,-5.5325004583333790009,0.00000000000000000000,0.42153851463119040854,1.00000000000000000000,-0.0004999999787968444,0.99999987426035763515,0.00003846153845205035,100.000000000000000000,-0.4311246587299824017,-0.4281208389283887028,-0.0002155652960370369,-0.0002140630833955164,0.00007666641180777304,0.00006879840812008202,11000.0013831362375640,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +99.0000000000000000000,0.00000000000000000000,-4.2573505331566892095,0.00000000000000000000,-2.2055711837510898476,1.00000000000000000000,-0.0004230769101426188,0.17368603921875477857,0.98480098537035853922,100.000000000000000000,-0.4311246556414928265,-0.4281208590029008664,0.00003221236169766976,0.00002587668932752707,-0.0001908951427800958,-0.0001884872909648192,9997.82883856935222866,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +99.0000000000000000000,1.00000000000000000000,-4.6813464315164816653,0.00000000000000000000,0.42153849961101830245,1.00000000000000000000,-0.0004230769101426188,0.99999990976331476488,0.00003846153845210587,100.000000000000000000,-0.4311246556414928265,-0.4281208590029008664,-0.0001824013987150624,-0.0001811303055406434,0.00006487157721193078,0.00005821403886145423,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +100.000000000000000000,0.00000000000000000000,-3.4832867316177038574,0.00000000000000000000,-2.2055711182492814259,1.00000000000000000000,-0.0003461538389849795,0.17368604435627468807,0.98480101450668189322,100.000000000000000000,-0.4311246530677492194,-0.4281208757316602442,0.00002635556797793276,0.00002117183704466019,-0.0001561869309876461,-0.0001542168773945122,9997.82854284009590628,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +100.000000000000000000,1.00000000000000000000,-3.8301924597747003531,0.00000000000000000000,0.42153848709395447258,1.00000000000000000000,-0.0003461538389849795,0.99999993934911279858,0.00003846153845210587,100.000000000000000000,-0.4311246530677492194,-0.4281208757316602442,-0.0001492375042050716,-0.0001481975255827823,0.00005307674362110381,0.00004762966899213390,11000.0006671597948297,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +101.000000000000000000,0.00000000000000000000,-2.7092229710213810989,0.00000000000000000000,-2.2055710658478346886,1.00000000000000000000,-0.0002692307657790926,0.17368604846629065452,0.98480103781574068744,100.000000000000000000,-0.4311246510087544114,-0.4281208891146685013,0.00002049877466847398,0.00001646698456851050,-0.0001214787216037467,-0.0001199464620429547,9997.82830625670248991,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +101.000000000000000000,1.00000000000000000000,-2.9790385330943731645,0.00000000000000000000,0.42153847708015695916,1.00000000000000000000,-0.0002692307657790926,0.99999996301775151419,0.00003846153845205035,100.000000000000000000,-0.4311246510087544114,-0.4281208891146685013,-0.0001160736119957958,-0.0001152647439042950,0.00004128191085256240,0.00003704529862315625,11000.0004068047455803,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +102.000000000000000000,0.00000000000000000000,-1.9351592422693504325,0.00000000000000000000,-2.2055710265485686250,1.00000000000000000000,-0.0001923076909801243,0.17368605154880267793,0.98480105529753503290,100.000000000000000000,-0.4311246494645078475,-0.4281208991519243056,0.00001464198167812049,0.00001176213194202970,-0.0000867705140931641,-0.0000856760453059799,9997.82812881915924663,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +102.000000000000000000,1.00000000000000000000,-2.1278846414618421967,0.00000000000000000000,0.42153846956995033590,1.00000000000000000000,-0.0001923076909801243,0.99999998076923068968,0.00003846153845210587,100.000000000000000000,-0.4311246494645078475,-0.4281208991519243056,-0.0000829097215759649,-0.0000823319608875428,0.00002948707872357641,0.00002646092786555616,11000.0002115384650096,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +103.000000000000000000,0.00000000000000000000,-1.1610955362632422449,0.00000000000000000000,-2.2055710003478452563,1.00000000000000000000,-0.0001153846150432407,0.17368605360381067503,0.98480106695206448552,100.000000000000000000,-0.4311246484350099716,-0.4281209058434279346,0.00000878518891569935,0.00000705727920816955,-0.0000520623079206650,-0.0000514056275794214,9997.82801052746981440,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +103.000000000000000000,1.00000000000000000000,-1.2767307748634504349,0.00000000000000000000,0.42153846456330673619,1.00000000000000000000,-0.0001153846150432407,0.99999999260355010299,0.00003846153845210587,100.000000000000000000,-0.4311246484350099716,-0.4281209058434279346,-0.0000497458324343089,-0.0000493991769148870,0.00001769224705141572,0.00001587655683036865,11000.0000813609476608,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +104.000000000000000000,0.00000000000000000000,-0.3870318439046855907,0.00000000000000000000,-2.2055709872474835719,1.00000000000000000000,-0.0000384615384236079,0.17368605463131467359,0.98480107277932926734,100.000000000000000000,-0.4311246479202619497,-0.4281209091891804985,0.00000292839629003763,0.00000235242640988180,-0.0000173541025510161,-0.0000171352092591127,9997.82795138162509829,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +104.000000000000000000,1.00000000000000000000,-0.4255769232855404204,0.00000000000000000000,0.42153846205958583892,1.00000000000000000000,-0.0000384615384236079,0.99999999852070975414,0.00003846153845216138,100.000000000000000000,-0.4311246479202619497,-0.4281209091891804985,-0.0000165819440595580,-0.0000164663923686892,0.00000589741565335022,0.00000529218562862871,11000.0000162721880769,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +105.000000000000000000,0.00000000000000000000,0.38703184390468559072,0.00000000000000000000,-2.2055709872474835719,1.00000000000000000000,0.00003846153842360791,0.17368605463131467359,0.98480107277932926734,100.000000000000000000,-0.4311246479202619497,-0.4281209091891804985,-0.0000029283962900376,-0.0000023524264098818,0.00001735410255101615,0.00001713520925911272,9997.82795138162509829,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +105.000000000000000000,1.00000000000000000000,0.42557692328554042049,0.00000000000000000000,0.42153846205958583892,1.00000000000000000000,0.00003846153842360791,0.99999999852070975414,0.00003846153845216138,100.000000000000000000,-0.4311246479202619497,-0.4281209091891804985,0.00001658194405955801,0.00001646639236868924,-0.0000058974156533502,-0.0000052921856286287,11000.0000162721880769,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +106.000000000000000000,0.00000000000000000000,1.16109553626324224495,0.00000000000000000000,-2.2055710003478452563,1.00000000000000000000,0.00011538461504324078,0.17368605360381067503,0.98480106695206448552,100.000000000000000000,-0.4311246484350099716,-0.4281209058434279346,-0.0000087851889156993,-0.0000070572792081695,0.00005206230792066509,0.00005140562757942140,9997.82801052746981440,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +106.000000000000000000,1.00000000000000000000,1.27673077486345043496,0.00000000000000000000,0.42153846456330673619,1.00000000000000000000,0.00011538461504324078,0.99999999260355010299,0.00003846153845210587,100.000000000000000000,-0.4311246484350099716,-0.4281209058434279346,0.00004974583243430896,0.00004939917691488701,-0.0000176922470514157,-0.0000158765568303686,11000.0000813609476608,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +107.000000000000000000,0.00000000000000000000,1.93515924226935109864,0.00000000000000000000,-2.2055710265485686250,1.00000000000000000000,0.00019230769098012445,0.17368605154880267793,0.98480105529753503290,100.000000000000000000,-0.4311246494645078475,-0.4281208991519243056,-0.0000146419816781205,-0.0000117621319420297,0.00008677051409316415,0.00008567604530597995,9997.82812881915924663,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +107.000000000000000000,1.00000000000000000000,2.12788464146184308489,0.00000000000000000000,0.42153846956995033590,1.00000000000000000000,0.00019230769098012445,0.99999998076923068968,0.00003846153845210587,100.000000000000000000,-0.4311246494645078475,-0.4281208991519243056,0.00008290972157596490,0.00008233196088754280,-0.0000294870787235764,-0.0000264609278655561,11000.0002115384650096,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +108.000000000000000000,0.00000000000000000000,2.70922297102138109892,0.00000000000000000000,-2.2055710658478346886,1.00000000000000000000,0.00026923076577909266,0.17368604846629065452,0.98480103781574068744,100.000000000000000000,-0.4311246510087544114,-0.4281208891146685013,-0.0000204987746684739,-0.0000164669845685105,0.00012147872160374670,0.00011994646204295475,9997.82830625670248991,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +108.000000000000000000,1.00000000000000000000,2.97903853309437316454,0.00000000000000000000,0.42153847708015695916,1.00000000000000000000,0.00026923076577909266,0.99999996301775151419,0.00003846153845205035,100.000000000000000000,-0.4311246510087544114,-0.4281208891146685013,0.00011607361199579580,0.00011526474390429505,-0.0000412819108525624,-0.0000370452986231562,11000.0004068047455803,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +109.000000000000000000,0.00000000000000000000,3.48328673161770385746,0.00000000000000000000,-2.2055711182492814259,1.00000000000000000000,0.00034615383898497955,0.17368604435627468807,0.98480101450668189322,100.000000000000000000,-0.4311246530677492194,-0.4281208757316602442,-0.0000263555679779327,-0.0000211718370446601,0.00015618693098764613,0.00015421687739451225,9997.82854284009590628,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +109.000000000000000000,1.00000000000000000000,3.83019245977470035313,0.00000000000000000000,0.42153848709395447258,1.00000000000000000000,0.00034615383898497955,0.99999993934911279858,0.00003846153845210587,100.000000000000000000,-0.4311246530677492194,-0.4281208757316602442,0.00014923750420507166,0.00014819752558278232,-0.0000530767436211038,-0.0000476296689921339,11000.0006671597948297,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +110.000000000000000000,0.00000000000000000000,4.25735053315669009776,0.00000000000000000000,-2.2055711837510898476,1.00000000000000000000,0.00042307691014261891,0.17368603921875477857,0.98480098537035853922,100.000000000000000000,-0.4311246556414928265,-0.4281208590029008664,-0.0000322123616976697,-0.0000258766893275270,0.00019089514278009591,0.00018848729096481925,9997.82883856935222866,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +110.000000000000000000,1.00000000000000000000,4.68134643151648255354,0.00000000000000000000,0.42153849961101830245,1.00000000000000000000,0.00042307691014261891,0.99999990976331476488,0.00003846153845210587,100.000000000000000000,-0.4311246556414928265,-0.4281208590029008664,0.00018240139871506246,0.00018113030554064350,-0.0000648715772119307,-0.0000582140388614542,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +111.000000000000000000,0.00000000000000000000,5.03141438473671254172,0.00000000000000000000,-2.2055712623514409642,1.00000000000000000000,0.00049999997879684445,0.17368603305373095380,0.98480095040677106954,100.000000000000000000,-0.4311246587299824017,-0.4281208389283887028,-0.0000380691559188577,-0.0000305815413741592,0.00022560335751632806,0.00022275770235804148,9997.82919344448055198,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +111.000000000000000000,1.00000000000000000000,5.53250045833337900091,0.00000000000000000000,0.42153851463119040854,1.00000000000000000000,0.00049999997879684445,0.99999987426035763515,0.00003846153845205035,100.000000000000000000,-0.4311246587299824017,-0.4281208389283887028,0.00021556529603703697,0.00021406308339551644,-0.0000766664118077730,-0.0000687984081200820,11000.0013831362375640,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +112.000000000000000000,0.00000000000000000000,-5.0292437412867760926,0.00000000000000000000,-6.6138291429597302339,1.00000000000000000000,-0.0004999999758382646,0.17376178646852366571,0.98478758702742141828,100.000000000000000000,-0.4308750560713003330,-0.4281595094688204206,0.00003804905780591355,0.00003058395119441266,-0.0002254790706217317,-0.0002227831354458692,9993.48796549357393814,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +112.000000000000000000,1.00000000000000000000,-5.5325004583333790009,0.00000000000000000000,1.26461554890164218356,1.00000000000000000000,-0.0004999999758382646,0.99999986834319842810,0.00011538461512866637,100.000000000000000000,-0.4308750560713003330,-0.4281595094688204206,-0.0002154463873403279,-0.0002140877116366967,0.00007662503683757012,0.00006880519773910466,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +113.000000000000000000,0.00000000000000000000,-4.2555138349617820381,0.00000000000000000000,-6.6138289073605847079,1.00000000000000000000,-0.0004230769076392051,0.17376179263354746273,0.98478762199100877694,100.000000000000000000,-0.4308750529768378134,-0.4281595295362446984,0.00003219535560212080,0.00002587872840564651,-0.0001907899769458451,-0.0001885088112663017,9993.48761092718450527,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +113.000000000000000000,1.00000000000000000000,-4.6813464315164816653,0.00000000000000000000,1.26461550384057797025,1.00000000000000000000,-0.0004230769076392051,0.99999990384615555782,0.00011538461512866637,100.000000000000000000,-0.4308750529768378134,-0.4281595295362446984,-0.0001823007836636416,-0.0001811511448181910,0.00006483656762171525,0.00005821978392253052,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +114.000000000000000000,0.00000000000000000000,-3.4817839786233837351,0.00000000000000000000,-6.6138287110261444468,1.00000000000000000000,-0.0003461538369367320,0.17376179777106737223,0.98478765112733213094,100.000000000000000000,-0.4308750503981174095,-0.4281595462590975231,0.00002634165389976948,0.00002117350538092395,-0.0001561008862139220,-0.0001542344849114507,9993.48731545521150110,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +114.000000000000000000,1.00000000000000000000,-3.8301924597747003531,0.00000000000000000000,1.26461546628947685277,1.00000000000000000000,-0.0003461538369367320,0.99999993343195348050,0.00011538461512861086,100.000000000000000000,-0.4308750503981174095,-0.4281595462590975231,-0.0001491551827991189,-0.0001482145758984227,0.00005304809941089765,0.00004763436949585069,11000.0007322485580516,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +115.000000000000000000,0.00000000000000000000,-2.7080541631831041016,0.00000000000000000000,-6.6138285539582284400,1.00000000000000000000,-0.0002692307641860112,0.17376180188108328317,0.98478767443639070311,100.000000000000000000,-0.4308750483351410642,-0.4281595596373803935,0.00002048795260768851,0.00001646828216314622,-0.0001214117978906972,-0.0001199601567768229,9993.48707907764583069,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +115.000000000000000000,1.00000000000000000000,-2.9790385330943731645,0.00000000000000000000,1.26461543624764427562,1.00000000000000000000,-0.0002692307641860112,0.99999995710059197406,0.00011538461512855535,100.000000000000000000,-0.4308750483351410642,-0.4281595596373803935,-0.0001160095842354583,-0.0001152780052594400,0.00004125963202238356,0.00003704895456999362,11000.0004718935051641,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +116.000000000000000000,0.00000000000000000000,-1.9343243795524711625,0.00000000000000000000,-6.6138284361586556769,1.00000000000000000000,-0.0001923076898422090,0.17376180496359527882,0.98478769191818482653,100.000000000000000000,-0.4308750467879086665,-0.4281595696710925880,0.00001463425163470669,0.00001176305879521446,-0.0000867227114409039,-0.0000856858272579242,9993.48690179447476111,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +116.000000000000000000,1.00000000000000000000,-2.1278846414618426408,0.00000000000000000000,1.26461541371716790216,1.00000000000000000000,-0.0001923076898422090,0.99999997485207081648,0.00011538461512861086,100.000000000000000000,-0.4308750467879086665,-0.4281595696710925880,-0.0000828639874613565,-0.0000823414332832906,0.00002947116527343874,0.00002646353925588757,11000.0002766272227745,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +117.000000000000000000,0.00000000000000000000,-1.1605946186430131650,0.00000000000000000000,-6.6138283576256071683,1.00000000000000000000,-0.0001153846143604915,0.17376180701860324817,0.98478770357271427915,100.000000000000000000,-0.4308750457564199942,-0.4281595763602341619,0.00000878055088965283,0.00000705783532002983,-0.0000520336263292761,-0.0000514114967502605,9993.48678360569647338,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +117.000000000000000000,1.00000000000000000000,-1.2767307748634504349,0.00000000000000000000,1.26461539869681338643,1.00000000000000000000,-0.0001153846143604915,0.99999998668639034082,0.00011538461512861086,100.000000000000000000,-0.4308750457564199942,-0.4281595763602341619,-0.0000497183919655113,-0.0000494048603520220,0.00001768269898132915,0.00001587812366446083,11000.0001464497036067,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +118.000000000000000000,0.00000000000000000000,-0.3868648713662589666,0.00000000000000000000,-6.6138283183590829139,1.00000000000000000000,-0.0000384615381960248,0.17376180804610727448,0.98478770939997906097,100.000000000000000000,-0.4308750452406761577,-0.4281595797048051155,0.00000292685028135574,0.00000235261178049346,-0.0000173445420205476,-0.0000171371656493378,9993.48672451130914851,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +118.000000000000000000,1.00000000000000000000,-0.4255769232855404204,0.00000000000000000000,1.26461539118663601755,1.00000000000000000000,-0.0000384615381960248,0.99999999260354999197,0.00011538461512861086,100.000000000000000000,-0.4308750452406761577,-0.4281595797048051155,-0.0000165727972366200,-0.0000164682868476819,0.00000589423296332070,0.00000529270790664165,11000.0000813609476608,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +119.000000000000000000,0.00000000000000000000,0.38686487136625896665,0.00000000000000000000,-6.6138283183590829139,1.00000000000000000000,0.00003846153819602484,0.17376180804610727448,0.98478770939997906097,100.000000000000000000,-0.4308750452406761577,-0.4281595797048051155,-0.0000029268502813557,-0.0000023526117804934,0.00001734454202054768,0.00001713716564933784,9993.48672451130914851,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +119.000000000000000000,1.00000000000000000000,0.42557692328554042049,0.00000000000000000000,1.26461539118663601755,1.00000000000000000000,0.00003846153819602484,0.99999999260354999197,0.00011538461512861086,100.000000000000000000,-0.4308750452406761577,-0.4281595797048051155,0.00001657279723662002,0.00001646828684768196,-0.0000058942329633207,-0.0000052927079066416,11000.0000813609476608,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +120.000000000000000000,0.00000000000000000000,1.16059461864301316502,0.00000000000000000000,-6.6138283576256071683,1.00000000000000000000,0.00011538461436049158,0.17376180701860324817,0.98478770357271427915,100.000000000000000000,-0.4308750457564199942,-0.4281595763602341619,-0.0000087805508896528,-0.0000070578353200298,0.00005203362632927615,0.00005141149675026058,9993.48678360569647338,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +120.000000000000000000,1.00000000000000000000,1.27673077486345043496,0.00000000000000000000,1.26461539869681338643,1.00000000000000000000,0.00011538461436049158,0.99999998668639034082,0.00011538461512861086,100.000000000000000000,-0.4308750457564199942,-0.4281595763602341619,0.00004971839196551135,0.00004940486035202208,-0.0000176826989813291,-0.0000158781236644608,11000.0001464497036067,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +121.000000000000000000,0.00000000000000000000,1.93432437955247160665,0.00000000000000000000,-6.6138284361586556769,1.00000000000000000000,0.00019230768984220914,0.17376180496359527882,0.98478769191818482653,100.000000000000000000,-0.4308750467879086665,-0.4281595696710925880,-0.0000146342516347067,-0.0000117630587952144,0.00008672271144090392,0.00008568582725792430,9993.48690179447476111,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +121.000000000000000000,1.00000000000000000000,2.12788464146184308489,0.00000000000000000000,1.26461541371716790216,1.00000000000000000000,0.00019230768984220914,0.99999997485207081648,0.00011538461512861086,100.000000000000000000,-0.4308750467879086665,-0.4281595696710925880,0.00008286398746135657,0.00008234143328329067,-0.0000294711652734387,-0.0000264635392558875,11000.0002766272227745,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +122.000000000000000000,0.00000000000000000000,2.70805416318310410161,0.00000000000000000000,-6.6138285539582284400,1.00000000000000000000,0.00026923076418601120,0.17376180188108328317,0.98478767443639070311,100.000000000000000000,-0.4308750483351410642,-0.4281595596373803935,-0.0000204879526076885,-0.0000164682821631462,0.00012141179789069723,0.00011996015677682299,9993.48707907764583069,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +122.000000000000000000,1.00000000000000000000,2.97903853309437316454,0.00000000000000000000,1.26461543624764427562,1.00000000000000000000,0.00026923076418601120,0.99999995710059197406,0.00011538461512855535,100.000000000000000000,-0.4308750483351410642,-0.4281595596373803935,0.00011600958423545833,0.00011527800525944008,-0.0000412596320223835,-0.0000370489545699936,11000.0004718935051641,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +123.000000000000000000,0.00000000000000000000,3.48178397862338373514,0.00000000000000000000,-6.6138287110261444468,1.00000000000000000000,0.00034615383693673202,0.17376179777106737223,0.98478765112733213094,100.000000000000000000,-0.4308750503981174095,-0.4281595462590975231,-0.0000263416538997694,-0.0000211735053809239,0.00015610088621392207,0.00015423448491145075,9993.48731545521150110,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +123.000000000000000000,1.00000000000000000000,3.83019245977470035313,0.00000000000000000000,1.26461546628947685277,1.00000000000000000000,0.00034615383693673202,0.99999993343195348050,0.00011538461512861086,100.000000000000000000,-0.4308750503981174095,-0.4281595462590975231,0.00014915518279911898,0.00014821457589842272,-0.0000530480994108976,-0.0000476343694958506,11000.0007322485580516,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +124.000000000000000000,0.00000000000000000000,4.25551383496178292631,0.00000000000000000000,-6.6138289073605847079,1.00000000000000000000,0.00042307690763920520,0.17376179263354746273,0.98478762199100877694,100.000000000000000000,-0.4308750529768378134,-0.4281595295362446984,-0.0000321953556021208,-0.0000258787284056465,0.00019078997694584520,0.00018850881126630174,9993.48761092718450527,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +124.000000000000000000,1.00000000000000000000,4.68134643151648255354,0.00000000000000000000,1.26461550384057797025,1.00000000000000000000,0.00042307690763920520,0.99999990384615555782,0.00011538461512866637,100.000000000000000000,-0.4308750529768378134,-0.4281595295362446984,0.00018230078366364169,0.00018115114481819107,-0.0000648365676217152,-0.0000582197839225305,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +125.000000000000000000,0.00000000000000000000,5.02924374128677609263,0.00000000000000000000,-6.6138291429597302339,1.00000000000000000000,0.00049999997583826468,0.17376178646852366571,0.98478758702742141828,100.000000000000000000,-0.4308750560713003330,-0.4281595094688204206,-0.0000380490578059135,-0.0000305839511944126,0.00022547907062173171,0.00022278313544586925,9993.48796549357393814,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +125.000000000000000000,1.00000000000000000000,5.53250045833337900091,0.00000000000000000000,1.26461554890164218356,1.00000000000000000000,0.00049999997583826468,0.99999986834319842810,0.00011538461512866637,100.000000000000000000,-0.4308750560713003330,-0.4281595094688204206,0.00021544638734032796,0.00021408771163669679,-0.0000766250368375701,-0.0000688051977391046,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +126.000000000000000000,0.00000000000000000000,-5.0270749896321964556,0.00000000000000000000,-11.018245065186420106,1.00000000000000000000,-0.0004999999699211052,0.17383753885514013903,0.98477421782092666724,100.000000000000000000,-0.4306254944521296090,-0.4281980639273076372,0.00003802896316961269,0.00003058635255149874,-0.0002253547987141750,-0.0002228085091621849,9989.15058018961281049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +126.000000000000000000,1.00000000000000000000,-5.5325004583333781127,0.00000000000000000000,2.10769259819217058549,1.00000000000000000000,-0.0004999999699211052,0.99999985650888056909,0.00019230769112238421,100.000000000000000000,-0.4306254944521296090,-0.4281980639273076372,-0.0002153274927992590,-0.0002141122828779653,0.00007658366789366467,0.00006881196871377965,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +127.000000000000000000,0.00000000000000000000,-4.2536787375166413838,0.00000000000000000000,-11.018244672861328581,1.00000000000000000000,-0.0004230769026323778,0.17383754502016385279,0.98477425278451358181,100.000000000000000000,-0.4306254913516999183,-0.4281980839876422528,0.00003217835244834731,0.00002588076032262446,-0.0001906848237929380,-0.0001885302813303512,9989.15022593156027141,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +127.000000000000000000,1.00000000000000000000,-4.6813464315164816653,0.00000000000000000000,2.10769252309018462199,1.00000000000000000000,-0.0004230769026323778,0.99999989201183725473,0.00019230769112238421,100.000000000000000000,-0.4306254913516999183,-0.4281980839876422528,-0.0001822001805900724,-0.0001811719358650443,0.00006480156313067520,0.00005822551320762048,11000.0011878699187946,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +128.000000000000000000,0.00000000000000000000,-3.4802825353333131097,0.00000000000000000000,-11.018244345925268135,1.00000000000000000000,-0.0003461538328402369,0.17383755015768370677,0.98477428192083638069,100.000000000000000000,-0.4306254887680063259,-0.4281981007045872478,0.00002632774222851355,0.00002117516785807197,-0.0001560148518158440,-0.0001542520513250352,9989.14993071652861544,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +128.000000000000000000,1.00000000000000000000,-3.8301924597746999090,0.00000000000000000000,2.10769246050474201581,1.00000000000000000000,-0.0003461538328402369,0.99999992159763484433,0.00019230769112232870,100.000000000000000000,-0.4306254887680063259,-0.4281981007045872478,-0.0001490728711932279,-0.0001482315867525861,0.00005301945937274455,0.00004763905709194234,11000.0008624260826763,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +129.000000000000000000,0.00000000000000000000,-2.7068863740036230858,0.00000000000000000000,-11.018244084374600788,1.00000000000000000000,-0.0002692307609998483,0.17383755426769958996,0.98477430522989473082,100.000000000000000000,-0.4306254867010514408,-0.4281981140781436767,0.00002047713241894218,0.00001646957520069196,-0.0001213448822475950,-0.0001199738195414160,9989.14969454451784258,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +129.000000000000000000,1.00000000000000000000,-2.9790385330943736086,0.00000000000000000000,2.10769241043660393586,1.00000000000000000000,-0.0002692307609998483,0.99999994526627289381,0.00019230769112238421,100.000000000000000000,-0.4306254867010514408,-0.4281981140781436767,-0.0001159455640973913,-0.0001152912359223254,0.00004123735643713501,0.00003705260047756708,11000.0006020710297889,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +130.000000000000000000,0.00000000000000000000,-1.9334902444489825423,0.00000000000000000000,-11.018243888212964520,1.00000000000000000000,-0.0001923076875663784,0.17383755735021153010,0.98477432271168874322,100.000000000000000000,-0.4306254851508353742,-0.4281981241083107625,0.00001462652292846376,0.00001176398239333495,-0.0000866749145528922,-0.0000856955863746719,9989.14951741551340091,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +130.000000000000000000,1.00000000000000000000,-2.1278846414618421967,0.00000000000000000000,2.10769237288546262831,1.00000000000000000000,-0.0001923076875663784,0.99999996301775184726,0.00019230769112238421,100.000000000000000000,-0.4306254851508353742,-0.4281981241083107625,-0.0000828182587912276,-0.0000823508837559958,0.00002945525414110858,0.00002646614347531617,11000.0004068047437613,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +131.000000000000000000,0.00000000000000000000,-1.1600941375908047081,0.00000000000000000000,-11.018243757436721352,1.00000000000000000000,-0.0001153846129949931,0.17383755940521949945,0.98477433436621797380,100.000000000000000000,-0.4306254841173575709,-0.4281981307950888382,0.00000877591366590884,0.00000705838947885153,-0.0000520049481964365,-0.0000514173522199816,9989.14939932951529044,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +131.000000000000000000,1.00000000000000000000,-1.2767307748634499908,0.00000000000000000000,2.10769234785105918916,1.00000000000000000000,-0.0001153846129949931,0.99999997485207103853,0.00019230769112238421,100.000000000000000000,-0.4306254841173575709,-0.4281981307950888382,-0.0000496909547634015,-0.0000494105306353313,0.00001767315230192713,0.00001587968619601129,11000.0002766272227745,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +132.000000000000000000,0.00000000000000000000,-0.3866980443505037556,0.00000000000000000000,-11.018243692049509263,1.00000000000000000000,-0.0000384615377408587,0.17383756043272349800,0.98477434019348275562,100.000000000000000000,-0.4306254836006188635,-0.4281981341384777373,0.00000292530454010804,0.00000235279650009226,-0.0000173349826429290,-0.0000171391174725236,9989.14934028651623521,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +132.000000000000000000,1.00000000000000000000,-0.4255769232855405315,0.00000000000000000000,2.10769233533416411319,1.00000000000000000000,-0.0000384615377408587,0.99999998076923068968,0.00019230769112238421,100.000000000000000000,-0.4306254836006188635,-0.4281981341384777373,-0.0000165636515025779,-0.0000164701769420660,0.00000589105073685270,0.00000529322875047402,11000.0002115384650096,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +133.000000000000000000,0.00000000000000000000,0.38669804435050375568,0.00000000000000000000,-11.018243692049509263,1.00000000000000000000,0.00003846153774085871,0.17383756043272349800,0.98477434019348275562,100.000000000000000000,-0.4306254836006188635,-0.4281981341384777373,-0.0000029253045401080,-0.0000023527965000922,0.00001733498264292902,0.00001713911747252361,9989.14934028651623521,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +133.000000000000000000,1.00000000000000000000,0.42557692328554053151,0.00000000000000000000,2.10769233533416411319,1.00000000000000000000,0.00003846153774085871,0.99999998076923068968,0.00019230769112238421,100.000000000000000000,-0.4306254836006188635,-0.4281981341384777373,0.00001656365150257799,0.00001647017694206609,-0.0000058910507368527,-0.0000052932287504740,11000.0002115384650096,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +134.000000000000000000,0.00000000000000000000,1.16009413759080470818,0.00000000000000000000,-11.018243757436721352,1.00000000000000000000,0.00011538461299499319,0.17383755940521949945,0.98477433436621797380,100.000000000000000000,-0.4306254841173575709,-0.4281981307950888382,-0.0000087759136659088,-0.0000070583894788515,0.00005200494819643650,0.00005141735221998166,9989.14939932951529044,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +134.000000000000000000,1.00000000000000000000,1.27673077486344999087,0.00000000000000000000,2.10769234785105918916,1.00000000000000000000,0.00011538461299499319,0.99999997485207103853,0.00019230769112238421,100.000000000000000000,-0.4306254841173575709,-0.4281981307950888382,0.00004969095476340151,0.00004941053063533139,-0.0000176731523019271,-0.0000158796861960112,11000.0002766272227745,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +135.000000000000000000,0.00000000000000000000,1.93349024444898298646,0.00000000000000000000,-11.018243888212964520,1.00000000000000000000,0.00019230768756637849,0.17383755735021153010,0.98477432271168874322,100.000000000000000000,-0.4306254851508353742,-0.4281981241083107625,-0.0000146265229284637,-0.0000117639823933349,0.00008667491455289233,0.00008569558637467200,9989.14951741551340091,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +135.000000000000000000,1.00000000000000000000,2.12788464146184308489,0.00000000000000000000,2.10769237288546262831,1.00000000000000000000,0.00019230768756637849,0.99999996301775184726,0.00019230769112238421,100.000000000000000000,-0.4306254851508353742,-0.4281981241083107625,0.00008281825879122772,0.00008235088375599584,-0.0000294552541411085,-0.0000264661434753161,11000.0004068047437613,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +136.000000000000000000,0.00000000000000000000,2.70688637400362308582,0.00000000000000000000,-11.018244084374600788,1.00000000000000000000,0.00026923076099984833,0.17383755426769958996,0.98477430522989473082,100.000000000000000000,-0.4306254867010514408,-0.4281981140781436767,-0.0000204771324189421,-0.0000164695752006919,0.00012134488224759508,0.00011997381954141602,9989.14969454451784258,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +136.000000000000000000,1.00000000000000000000,2.97903853309437360863,0.00000000000000000000,2.10769241043660393586,1.00000000000000000000,0.00026923076099984833,0.99999994526627289381,0.00019230769112238421,100.000000000000000000,-0.4306254867010514408,-0.4281981140781436767,0.00011594556409739133,0.00011529123592232540,-0.0000412373564371350,-0.0000370526004775670,11000.0006020710297889,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +137.000000000000000000,0.00000000000000000000,3.48028253533331310975,0.00000000000000000000,-11.018244345925268135,1.00000000000000000000,0.00034615383284023691,0.17383755015768370677,0.98477428192083638069,100.000000000000000000,-0.4306254887680063259,-0.4281981007045872478,-0.0000263277422285135,-0.0000211751678580719,0.00015601485181584409,0.00015425205132503521,9989.14993071652861544,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +137.000000000000000000,1.00000000000000000000,3.83019245977469990904,0.00000000000000000000,2.10769246050474201581,1.00000000000000000000,0.00034615383284023691,0.99999992159763484433,0.00019230769112232870,100.000000000000000000,-0.4306254887680063259,-0.4281981007045872478,0.00014907287119322794,0.00014823158675258615,-0.0000530194593727445,-0.0000476390570919423,11000.0008624260826763,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +138.000000000000000000,0.00000000000000000000,4.25367873751664138382,0.00000000000000000000,-11.018244672861328581,1.00000000000000000000,0.00042307690263237795,0.17383754502016385279,0.98477425278451358181,100.000000000000000000,-0.4306254913516999183,-0.4281980839876422528,-0.0000321783524483473,-0.0000258807603226244,0.00019068482379293809,0.00018853028133035128,9989.15022593156027141,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +138.000000000000000000,1.00000000000000000000,4.68134643151648166536,0.00000000000000000000,2.10769252309018462199,1.00000000000000000000,0.00042307690263237795,0.99999989201183725473,0.00019230769112238421,100.000000000000000000,-0.4306254913516999183,-0.4281980839876422528,0.00018220018059007247,0.00018117193586504433,-0.0000648015631306752,-0.0000582255132076204,11000.0011878699187946,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +139.000000000000000000,0.00000000000000000000,5.02707498963219645560,0.00000000000000000000,-11.018245065186420106,1.00000000000000000000,0.00049999996992110523,0.17383753885514013903,0.98477421782092666724,100.000000000000000000,-0.4306254944521296090,-0.4281980639273076372,-0.0000380289631696126,-0.0000305863525514987,0.00022535479871417502,0.00022280850916218497,9989.15058018961281049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +139.000000000000000000,1.00000000000000000000,5.53250045833337811274,0.00000000000000000000,2.10769259819217058549,1.00000000000000000000,0.00049999996992110523,0.99999985650888056909,0.00019230769112238421,100.000000000000000000,-0.4306254944521296090,-0.4281980639273076372,0.00021532749279925904,0.00021411228287796530,-0.0000765836678936646,-0.0000688119687137796,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +140.000000000000000000,0.00000000000000000000,-5.0249081272751592308,0.00000000000000000000,-15.418824101730933762,1.00000000000000000000,-0.0004999999610453660,0.17391329021313212122,0.98476084278736519816,100.000000000000000000,-0.4303759739229126024,-0.4282365023382813107,0.00003800887201309710,0.00003058874544766507,-0.0002252305418213072,-0.0002228338235205622,9984.81703246010329166,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +140.000000000000000000,1.00000000000000000000,-5.5325004583333781127,0.00000000000000000000,2.95076967251699784355,1.00000000000000000000,-0.0004999999610453660,0.99999983875740372507,0.00026923076597823447,100.000000000000000000,-0.4303759739229126024,-0.4282365023382813107,-0.0002152086124405138,-0.0002141367971322991,0.00007654230498395210,0.00006881872104867743,11000.0017736688423610,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +141.000000000000000000,0.00000000000000000000,-4.2518452387077312337,0.00000000000000000000,-15.418823552952744648,1.00000000000000000000,-0.0004230768951221369,0.17391329637815572395,0.98476087775095144660,100.000000000000000000,-0.4303759708165197372,-0.4282365223915239327,0.00003216135223900773,0.00002588278508036264,-0.0001905796833447694,-0.0001885517011684527,9984.81667850998019275,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +141.000000000000000000,1.00000000000000000000,-4.6813464315164825535,0.00000000000000000000,2.95076956737409901165,1.00000000000000000000,-0.0004230768951221369,0.99999987426035963355,0.00026923076597823447,100.000000000000000000,-0.4303759708165197372,-0.4282365223915239327,-0.0001820995895169325,-0.0001811926786921834,0.00006476656374549118,0.00005823122672059126,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +142.000000000000000000,0.00000000000000000000,-3.4787824000182383521,0.00000000000000000000,-15.418823095638799713,1.00000000000000000000,-0.0003461538266954942,0.17391330151567546691,0.98476090688727380140,100.000000000000000000,-0.4303759682278581744,-0.4282365391025602097,0.00002631383296634015,0.00002117682447766028,-0.0001559288278125536,-0.0001542695766446626,9984.81638355155882891,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +142.000000000000000000,1.00000000000000000000,-3.8301924597747003531,0.00000000000000000000,2.95076947975442127614,1.00000000000000000000,-0.0003461538266954942,0.99999990384615666805,0.00026923076597828998,100.000000000000000000,-0.4303759682278581744,-0.4282365391025602097,-0.0001489905694058714,-0.0001482485581542566,0.00005299082351211050,0.00004764373178357304,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +143.000000000000000000,0.00000000000000000000,-2.7057196021379632533,0.00000000000000000000,-15.418822729787279968,1.00000000000000000000,-0.0002692307562206040,0.17391330562569126683,0.98476093019633170744,100.000000000000000000,-0.4303759661569280803,-0.4282365524713885873,0.00002046631410392683,0.00001647086368235791,-0.0001212779746893287,-0.0001199874503440423,9984.81614758483192417,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +143.000000000000000000,1.00000000000000000000,-2.9790385330943736086,0.00000000000000000000,2.95076940965900114122,1.00000000000000000000,-0.0002692307562206040,0.99999992751479427344,0.00026923076597823447,100.000000000000000000,-0.4303759661569280803,-0.4282365524713885873,-0.0001158815515959633,-0.0001153044358999383,0.00004121508410106827,0.00003705623634833752,11000.0007973373158165,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +144.000000000000000000,0.00000000000000000000,-1.9326568359981888267,0.00000000000000000000,-15.418822455398185411,1.00000000000000000000,-0.0001923076841526324,0.17391330870820317922,0.98476094767812538677,100.000000000000000000,-0.4303759646037298436,-0.4282365624980099538,0.00001461879556060013,0.00001176490273725561,-0.0000866271234397634,-0.0000857053226614435,9984.81597060979402158,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +144.000000000000000000,1.00000000000000000000,-2.1278846414618426408,0.00000000000000000000,2.95076935708755261345,1.00000000000000000000,-0.0001923076841526324,0.99999994526627300484,0.00026923076597823447,100.000000000000000000,-0.4303759646037298436,-0.4282365624980099538,-0.0000827725355758409,-0.0000823603123106493,0.00002943934532962260,0.00002646874052559981,11000.0006020710279699,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +145.000000000000000000,0.00000000000000000000,-1.1595940925301999602,0.00000000000000000000,-15.418822272471516043,1.00000000000000000000,-0.0001153846109467456,0.17391331076321109305,0.98476095933265450632,100.000000000000000000,-0.4303759635682647410,-0.4282365691824239761,0.00000877127724519247,0.00000705894168515334,-0.0000519762735285267,-0.0000514231939917171,9984.81585262643966416,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +145.000000000000000000,1.00000000000000000000,-1.2767307748634504349,0.00000000000000000000,2.95076932203910846652,1.00000000000000000000,-0.0001153846109467456,0.99999995710059197406,0.00026923076597823447,100.000000000000000000,-0.4303759635682647410,-0.4282365691824239761,-0.0000496635208341372,-0.0000494161877678098,0.00001766360701503168,0.00001588124442607479,11000.0004718935051641,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +146.000000000000000000,0.00000000000000000000,-0.3865313626652805978,0.00000000000000000000,-15.418822181009090854,1.00000000000000000000,-0.0000384615370581095,0.17391331179071506385,0.98476096515991906610,100.000000000000000000,-0.4303759630505318845,-0.4282365725246307652,0.00000292375906653621,0.00000235298056885110,-0.0000173254244202870,-0.0000171410647297141,9984.81579363476157595,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +146.000000000000000000,1.00000000000000000000,-0.4255769232855404760,0.00000000000000000000,2.95076930451525054621,1.00000000000000000000,-0.0000384615370581095,0.99999996301775140317,0.00026923076597828998,100.000000000000000000,-0.4303759630505318845,-0.4282365725246307652,-0.0000165545068594845,-0.0000164720626528399,0.00000588786897455357,0.00000529374816047740,11000.0004068047455803,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +147.000000000000000000,0.00000000000000000000,0.38653136266528059783,0.00000000000000000000,-15.418822181009090854,1.00000000000000000000,0.00003846153705810951,0.17391331179071506385,0.98476096515991906610,100.000000000000000000,-0.4303759630505318845,-0.4282365725246307652,-0.0000029237590665362,-0.0000023529805688511,0.00001732542442028700,0.00001714106472971419,9984.81579363476157595,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +147.000000000000000000,1.00000000000000000000,0.42557692328554047600,0.00000000000000000000,2.95076930451525054621,1.00000000000000000000,0.00003846153705810951,0.99999996301775140317,0.00026923076597828998,100.000000000000000000,-0.4303759630505318845,-0.4282365725246307652,0.00001655450685948450,0.00001647206265283994,-0.0000058878689745535,-0.0000052937481604774,11000.0004068047455803,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +148.000000000000000000,0.00000000000000000000,1.15959409253019996022,0.00000000000000000000,-15.418822272471516043,1.00000000000000000000,0.00011538461094674560,0.17391331076321109305,0.98476095933265450632,100.000000000000000000,-0.4303759635682647410,-0.4282365691824239761,-0.0000087712772451924,-0.0000070589416851533,0.00005197627352852672,0.00005142319399171712,9984.81585262643966416,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +148.000000000000000000,1.00000000000000000000,1.27673077486345043496,0.00000000000000000000,2.95076932203910846652,1.00000000000000000000,0.00011538461094674560,0.99999995710059197406,0.00026923076597823447,100.000000000000000000,-0.4303759635682647410,-0.4282365691824239761,0.00004966352083413722,0.00004941618776780981,-0.0000176636070150316,-0.0000158812444260747,11000.0004718935051641,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +149.000000000000000000,0.00000000000000000000,1.93265683599818927085,0.00000000000000000000,-15.418822455398185411,1.00000000000000000000,0.00019230768415263250,0.17391330870820317922,0.98476094767812538677,100.000000000000000000,-0.4303759646037298436,-0.4282365624980099538,-0.0000146187955606001,-0.0000117649027372556,0.00008662712343976343,0.00008570532266144359,9984.81597060979402158,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +149.000000000000000000,1.00000000000000000000,2.12788464146184308489,0.00000000000000000000,2.95076935708755261345,1.00000000000000000000,0.00019230768415263250,0.99999994526627300484,0.00026923076597823447,100.000000000000000000,-0.4303759646037298436,-0.4282365624980099538,0.00008277253557584097,0.00008236031231064940,-0.0000294393453296225,-0.0000264687405255998,11000.0006020710279699,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +150.000000000000000000,0.00000000000000000000,2.70571960213796325334,0.00000000000000000000,-15.418822729787279968,1.00000000000000000000,0.00026923075622060400,0.17391330562569126683,0.98476093019633170744,100.000000000000000000,-0.4303759661569280803,-0.4282365524713885873,-0.0000204663141039268,-0.0000164708636823579,0.00012127797468932874,0.00011998745034404238,9984.81614758483192417,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +150.000000000000000000,1.00000000000000000000,2.97903853309437360863,0.00000000000000000000,2.95076940965900114122,1.00000000000000000000,0.00026923075622060400,0.99999992751479427344,0.00026923076597823447,100.000000000000000000,-0.4303759661569280803,-0.4282365524713885873,0.00011588155159596337,0.00011530443589993838,-0.0000412150841010682,-0.0000370562363483375,11000.0007973373158165,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +151.000000000000000000,0.00000000000000000000,3.47878240001823835214,0.00000000000000000000,-15.418823095638799713,1.00000000000000000000,0.00034615382669549426,0.17391330151567546691,0.98476090688727380140,100.000000000000000000,-0.4303759682278581744,-0.4282365391025602097,-0.0000263138329663401,-0.0000211768244776602,0.00015592882781255364,0.00015426957664466263,9984.81638355155882891,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +151.000000000000000000,1.00000000000000000000,3.83019245977470035313,0.00000000000000000000,2.95076947975442127614,1.00000000000000000000,0.00034615382669549426,0.99999990384615666805,0.00026923076597828998,100.000000000000000000,-0.4303759682278581744,-0.4282365391025602097,0.00014899056940587146,0.00014824855815425664,-0.0000529908235121105,-0.0000476437317835730,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +152.000000000000000000,0.00000000000000000000,4.25184523870773123377,0.00000000000000000000,-15.418823552952744648,1.00000000000000000000,0.00042307689512213698,0.17391329637815572395,0.98476087775095144660,100.000000000000000000,-0.4303759708165197372,-0.4282365223915239327,-0.0000321613522390077,-0.0000258827850803626,0.00019057968334476935,0.00018855170116845277,9984.81667850998019275,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +152.000000000000000000,1.00000000000000000000,4.68134643151648255354,0.00000000000000000000,2.95076956737409901165,1.00000000000000000000,0.00042307689512213698,0.99999987426035963355,0.00026923076597823447,100.000000000000000000,-0.4303759708165197372,-0.4282365223915239327,0.00018209958951693246,0.00018119267869218350,-0.0000647665637454911,-0.0000582312267205912,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +153.000000000000000000,0.00000000000000000000,5.02490812727515923086,0.00000000000000000000,-15.418824101730933762,1.00000000000000000000,0.00049999996104536600,0.17391329021313212122,0.98476084278736519816,100.000000000000000000,-0.4303759739229126024,-0.4282365023382813107,-0.0000380088720130971,-0.0000305887454476650,0.00022523054182130725,0.00022283382352056226,9984.81703246010329166,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +153.000000000000000000,1.00000000000000000000,5.53250045833337811274,0.00000000000000000000,2.95076967251699784355,1.00000000000000000000,0.00049999996104536600,0.99999983875740372507,0.00026923076597823447,100.000000000000000000,-0.4303759739229126024,-0.4282365023382813107,0.00021520861244051384,0.00021413679713229915,-0.0000765423049839521,-0.0000688187210486774,11000.0017736688423610,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +154.000000000000000000,0.00000000000000000000,-5.0227431517222500545,0.00000000000000000000,-19.815571316348723485,1.00000000000000000000,-0.0004999999492110472,0.17398904054205135971,0.98474746192681661405,100.000000000000000000,-0.4301264945340786405,-0.4282748247362038185,0.00003798878433950870,0.00003059112988516111,-0.0002251062999707727,-0.0002228590785345918,9980.48731724149729416,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +154.000000000000000000,1.00000000000000000000,-5.5325004583333807772,0.00000000000000000000,3.79384678189031054884,1.00000000000000000000,-0.0004999999492110472,0.99999981508876789604,0.00034615383924102571,100.000000000000000000,-0.4301264945340786405,-0.4282748247362038185,-0.0002150897462907710,-0.0002141612544126920,0.00007650094811632697,0.00006882545474837329,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +155.000000000000000000,0.00000000000000000000,-4.2500133364252379308,0.00000000000000000000,-19.815570611392104183,1.00000000000000000000,-0.0004230768851084824,0.17398904670707482367,0.98474749689040208533,100.000000000000000000,-0.4301264914217284851,-0.4282748447823533366,0.00003214435497676072,0.00002588480268076454,-0.0001904745556247311,-0.0001885730707921068,9980.48696359889618179,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +155.000000000000000000,1.00000000000000000000,-4.6813464315164825535,0.00000000000000000000,3.79384664670590465718,1.00000000000000000000,-0.0004230768851084824,0.99999985059172291634,0.00034615383924108122,100.000000000000000000,-0.4301264914217284851,-0.4282748447823533366,-0.0001819990104667969,-0.0001812133733106038,0.00006473156947284343,0.00005823692446531449,11000.0016434912868135,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +156.000000000000000000,0.00000000000000000000,-3.4772835709519478442,0.00000000000000000000,-19.815570023925829445,1.00000000000000000000,-0.0003461538185025041,0.17398905184459445560,0.98474752602672377399,100.000000000000000000,-0.4301264888281012277,-0.4282748614874778425,0.00002629992611542442,0.00002117847524124612,-0.0001558428142231888,-0.0001542870608797416,9980.48666889674859703,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +156.000000000000000000,1.00000000000000000000,-3.8301924597747012413,0.00000000000000000000,3.79384653405199445685,1.00000000000000000000,-0.0003461538185025041,0.99999988017751950675,0.00034615383924102571,100.000000000000000000,-0.4301264888281012277,-0.4282748614874778425,-0.0001489082774555192,-0.0001482654901124295,0.00005296219183446092,0.00004764839357391014,11000.0013180474416003,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +157.000000000000000000,0.00000000000000000000,-2.7045538462435154691,0.00000000000000000000,-19.815569553953537251,1.00000000000000000000,-0.0002692307498482782,0.17398905595461017226,0.98474754933578123594,100.000000000000000000,-0.4301264867531992552,-0.4282748748515771142,0.00002045549766433420,0.00001647214760935532,-0.0001212110752307831,-0.0001200010491920201,9980.48643313503998797,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +157.000000000000000000,1.00000000000000000000,-2.9790385330943731645,0.00000000000000000000,3.79384644392900982623,1.00000000000000000000,-0.0002692307498482782,0.99999990384615677907,0.00034615383924097020,100.000000000000000000,-0.4301264867531992552,-0.4282748748515771142,-0.0001158175467455394,-0.0001153176051992755,0.00004119281501843411,0.00003705986218476857,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +158.000000000000000000,0.00000000000000000000,-1.9318241532410840299,0.00000000000000000000,-19.815569201475227600,1.00000000000000000000,-0.0001923076796009712,0.17398905903712200138,0.98474756681757447118,100.000000000000000000,-0.4301264851970224567,-0.4282748848746521508,0.00001461106953232425,0.00001176581982784162,-0.0000865793381121501,-0.0000857150361234662,9980.48625631376307865,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +158.000000000000000000,1.00000000000000000000,-2.1278846414618426408,0.00000000000000000000,3.79384637633706400805,1.00000000000000000000,-0.0001923076796009712,0.99999992159763484433,0.00034615383924102571,100.000000000000000000,-0.4301264851970224567,-0.4282748848746521508,-0.0000827268178254578,-0.0000823697189522489,0.00002942343884201724,0.00002647133040849821,11000.0008624260826763,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +159.000000000000000000,0.00000000000000000000,-1.1590944828857943083,0.00000000000000000000,-19.815568966487262514,1.00000000000000000000,-0.0001153846082157488,0.17398906109212988746,0.98474757847210336869,100.000000000000000000,-0.4301264841595711652,-0.4282748915567018421,0.00000876664162822876,0.00000705949193945437,-0.0000519476023319264,-0.0000514290220686033,9980.48613843291786906,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +159.000000000000000000,1.00000000000000000000,-1.2767307748634502129,0.00000000000000000000,3.79384633127566939236,1.00000000000000000000,-0.0001153846082157488,0.99999993343195359152,0.00034615383924102571,100.000000000000000000,-0.4301264841595711652,-0.4282748915567018421,-0.0000496360901838752,-0.0000494218317524558,0.00001765406312246465,0.00001588279835570717,11000.0007322485580516,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +160.000000000000000000,0.00000000000000000000,-0.3863648261187884180,0.00000000000000000000,-19.815568848993279971,1.00000000000000000000,-0.0000384615361477772,0.17398906211963380274,0.98474758429936770642,100.000000000000000000,-0.4301264836408460467,-0.4282748948977271319,0.00000292221386088195,0.00000235316398694302,-0.0000173158673547481,-0.0000171430074219550,9980.48607949249526427,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +160.000000000000000000,1.00000000000000000000,-0.4255769232855405315,0.00000000000000000000,3.79384630874480155426,1.00000000000000000000,-0.0000384615361477772,0.99999993934911279858,0.00034615383924108122,100.000000000000000000,-0.4301264836408460467,-0.4282748948977271319,-0.0000165453633093918,-0.0000164739439810030,0.00000588468767703059,0.00000529426613700376,11000.0006671597966487,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +161.000000000000000000,0.00000000000000000000,0.38636482611878841808,0.00000000000000000000,-19.815568848993279971,1.00000000000000000000,0.00003846153614777726,0.17398906211963380274,0.98474758429936770642,100.000000000000000000,-0.4301264836408460467,-0.4282748948977271319,-0.0000029222138608819,-0.0000023531639869430,0.00001731586735474819,0.00001714300742195503,9980.48607949249526427,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +161.000000000000000000,1.00000000000000000000,0.42557692328554053151,0.00000000000000000000,3.79384630874480155426,1.00000000000000000000,0.00003846153614777726,0.99999993934911279858,0.00034615383924108122,100.000000000000000000,-0.4301264836408460467,-0.4282748948977271319,0.00001654536330939181,0.00001647394398100303,-0.0000058846876770305,-0.0000052942661370037,11000.0006671597966487,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +162.000000000000000000,0.00000000000000000000,1.15909448288579430830,0.00000000000000000000,-19.815568966487262514,1.00000000000000000000,0.00011538460821574884,0.17398906109212988746,0.98474757847210336869,100.000000000000000000,-0.4301264841595711652,-0.4282748915567018421,-0.0000087666416282287,-0.0000070594919394543,0.00005194760233192641,0.00005142902206860333,9980.48613843291786906,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +162.000000000000000000,1.00000000000000000000,1.27673077486345021291,0.00000000000000000000,3.79384633127566939236,1.00000000000000000000,0.00011538460821574884,0.99999993343195359152,0.00034615383924102571,100.000000000000000000,-0.4301264841595711652,-0.4282748915567018421,0.00004963609018387520,0.00004942183175245586,-0.0000176540631224646,-0.0000158827983557071,11000.0007322485580516,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +163.000000000000000000,0.00000000000000000000,1.93182415324108469611,0.00000000000000000000,-19.815569201475227600,1.00000000000000000000,0.00019230767960097126,0.17398905903712200138,0.98474756681757447118,100.000000000000000000,-0.4301264851970224567,-0.4282748848746521508,-0.0000146110695323242,-0.0000117658198278416,0.00008657933811215016,0.00008571503612346630,9980.48625631376307865,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +163.000000000000000000,1.00000000000000000000,2.12788464146184352898,0.00000000000000000000,3.79384637633706400805,1.00000000000000000000,0.00019230767960097126,0.99999992159763484433,0.00034615383924102571,100.000000000000000000,-0.4301264851970224567,-0.4282748848746521508,0.00008272681782545788,0.00008236971895224895,-0.0000294234388420172,-0.0000264713304084982,11000.0008624260826763,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +164.000000000000000000,0.00000000000000000000,2.70455384624351546918,0.00000000000000000000,-19.815569553953537251,1.00000000000000000000,0.00026923074984827827,0.17398905595461017226,0.98474754933578123594,100.000000000000000000,-0.4301264867531992552,-0.4282748748515771142,-0.0000204554976643342,-0.0000164721476093553,0.00012121107523078311,0.00012000104919202013,9980.48643313503998797,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +164.000000000000000000,1.00000000000000000000,2.97903853309437316454,0.00000000000000000000,3.79384644392900982623,1.00000000000000000000,0.00026923074984827827,0.99999990384615677907,0.00034615383924097020,100.000000000000000000,-0.4301264867531992552,-0.4282748748515771142,0.00011581754674553943,0.00011531760519927553,-0.0000411928150184341,-0.0000370598621847685,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +165.000000000000000000,0.00000000000000000000,3.47728357095194784420,0.00000000000000000000,-19.815570023925829445,1.00000000000000000000,0.00034615381850250414,0.17398905184459445560,0.98474752602672377399,100.000000000000000000,-0.4301264888281012277,-0.4282748614874778425,-0.0000262999261154244,-0.0000211784752412461,0.00015584281422318887,0.00015428706087974167,9980.48666889674859703,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +165.000000000000000000,1.00000000000000000000,3.83019245977470124131,0.00000000000000000000,3.79384653405199445685,1.00000000000000000000,0.00034615381850250414,0.99999988017751950675,0.00034615383924102571,100.000000000000000000,-0.4301264888281012277,-0.4282748614874778425,0.00014890827745551923,0.00014826549011242952,-0.0000529621918344609,-0.0000476483935739101,11000.0013180474416003,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +166.000000000000000000,0.00000000000000000000,4.25001333642523881906,0.00000000000000000000,-19.815570611392104183,1.00000000000000000000,0.00042307688510848247,0.17398904670707482367,0.98474749689040208533,100.000000000000000000,-0.4301264914217284851,-0.4282748447823533366,-0.0000321443549767607,-0.0000258848026807645,0.00019047455562473122,0.00018857307079210683,9980.48696359889618179,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +166.000000000000000000,1.00000000000000000000,4.68134643151648344172,0.00000000000000000000,3.79384664670590465718,1.00000000000000000000,0.00042307688510848247,0.99999985059172291634,0.00034615383924108122,100.000000000000000000,-0.4301264914217284851,-0.4282748447823533366,0.00018199901046679696,0.00018121337331060392,-0.0000647315694728434,-0.0000582369244653144,11000.0016434912868135,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +167.000000000000000000,0.00000000000000000000,5.02274315172225005454,0.00000000000000000000,-19.815571316348723485,1.00000000000000000000,0.00049999994921104721,0.17398904054205135971,0.98474746192681661405,100.000000000000000000,-0.4301264945340786405,-0.4282748247362038185,-0.0000379887843395087,-0.0000305911298851611,0.00022510629997077275,0.00022285907853459189,9980.48731724149729416,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +167.000000000000000000,1.00000000000000000000,5.53250045833338077727,0.00000000000000000000,3.79384678189031054884,1.00000000000000000000,0.00049999994921104721,0.99999981508876789604,0.00034615383924102571,100.000000000000000000,-0.4301264945340786405,-0.4282748247362038185,0.00021508974629077102,0.00021416125441269201,-0.0000765009481163269,-0.0000688254547483732,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +168.000000000000000000,0.00000000000000000000,-5.0205800604844332823,0.00000000000000000000,-24.208491763902202364,1.00000000000000000000,-0.0004999999344181487,0.17406478984144968524,0.98473407523935996277,100.000000000000000000,-0.4298770563360462815,-0.4283130311555628511,0.00003796870015198939,0.00003059350586623781,-0.0002249820731902136,-0.0002228842742178797,9976.16142947913795069,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +168.000000000000000000,1.00000000000000000000,-5.5325004583333790009,0.00000000000000000000,4.63692393632391208768,1.00000000000000000000,-0.0004999999344181487,0.99999978550297341506,0.00042307691045562201,100.000000000000000000,-0.4298770563360462815,-0.4283130311555628511,-0.0002149708943767073,-0.0002141856547321522,0.00007645959729868348,0.00006883216981744666,11000.0023594677968503,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +169.000000000000000000,0.00000000000000000000,-4.2481830285630586274,0.00000000000000000000,-24.208490903036363306,1.00000000000000000000,-0.0004230768725914143,0.17406479600647295491,0.98473411020294432383,100.000000000000000000,-0.4298770532177428327,-0.4283130511946176000,0.00003212736066426462,0.00002588681312573469,-0.0001903694406562121,-0.0001885943902128257,9976.16107614366046618,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +169.000000000000000000,1.00000000000000000000,-4.6813464315164825535,0.00000000000000000000,4.63692377109861553208,1.00000000000000000000,-0.0004230768725914143,0.99999982100592754719,0.00042307691045556650,100.000000000000000000,-0.4298770532177428327,-0.4283130511946176000,-0.0001818984434622373,-0.0001812340197313122,0.00006469658031941130,0.00005824260644566486,11000.0019689351483975,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +170.000000000000000000,0.00000000000000000000,-3.4757860464112639853,0.00000000000000000000,-24.208490185645132442,1.00000000000000000000,-0.0003461538082612664,0.17406480114399242031,0.98473413933926512431,100.000000000000000000,-0.4298770506191554319,-0.4283130678938288915,0.00002628602167794151,0.00002118012015038787,-0.0001557568110668869,-0.0001543045040396921,9976.16078169744650949,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +170.000000000000000000,1.00000000000000000000,-3.8301924597746999090,0.00000000000000000000,4.63692363341065316717,1.00000000000000000000,-0.0003461538082612664,0.99999985059172302737,0.00042307691045556650,100.000000000000000000,-0.4298770506191554319,-0.4283130678938288915,-0.0001488259953606399,-0.0001482823826361109,0.00005293356434526104,0.00004765304246612410,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +171.000000000000000000,0.00000000000000000000,-2.7033891049800322647,0.00000000000000000000,-24.208489611733966739,1.00000000000000000000,-0.0002692307418828711,0.17406480525400802594,0.98473416264832192013,100.000000000000000000,-0.4298770485402849117,-0.4283130812531985021,0.00002044468310185609,0.00001647342698289625,-0.0001211441838868428,-0.0001200146160926759,9976.16054614048698567,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +171.000000000000000000,1.00000000000000000000,-2.9790385330943722763,0.00000000000000000000,4.63692352326049839206,1.00000000000000000000,-0.0002692307418828711,0.99999987426035952253,0.00042307691045562201,100.000000000000000000,-0.4298770485402849117,-0.4283130812531985021,-0.0001157535495604842,-0.0001153307438273418,0.00004117054919348332,0.00003706347798932616,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +172.000000000000000000,0.00000000000000000000,-1.9309921952203483730,0.00000000000000000000,-24.208489181299228221,1.00000000000000000000,-0.0001923076739113946,0.17406480833651974404,0.98473418013011471128,100.000000000000000000,-0.4298770469811318273,-0.4283130912727254324,0.00001460334484484451,0.00001176673366595872,-0.0000865315585806838,-0.0000857247267659731,9976.16036947277279978,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +172.000000000000000000,1.00000000000000000000,-2.1278846414618417526,0.00000000000000000000,4.63692344064766448497,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,0.00042307691045556650,100.000000000000000000,-0.4298770469811318273,-0.4283130912727254324,-0.0000826811055503385,-0.0000823791036857976,0.00002940753468132872,0.00002647391312577267,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +173.000000000000000000,0.00000000000000000000,-1.1585953080831965511,0.00000000000000000000,-24.208488894344554864,1.00000000000000000000,-0.0001153846048020029,0.17406481039152757461,0.98473419178464305367,100.000000000000000000,-0.4298770459416957900,-0.4283130979524101267,0.00000876200681574275,0.00000706004024227406,-0.0000519189346130145,-0.0000514348364537800,9976.16025169429849484,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +173.000000000000000000,1.00000000000000000000,-1.2767307748634504349,0.00000000000000000000,4.63692338557309469138,1.00000000000000000000,-0.0001153846048020029,0.99999990384615555782,0.00042307691045556650,100.000000000000000000,-0.4298770459416957900,-0.4283130979524101267,-0.0000496086628187715,-0.0000494274625922714,0.00001764452062604775,0.00001588434798596519,11000.0010576923905318,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +174.000000000000000000,0.00000000000000000000,-0.3861984345195630385,0.00000000000000000000,-24.208488750866308691,1.00000000000000000000,-0.0000384615350098619,0.17406481141903148990,0.98473419761190739141,100.000000000000000000,-0.4298770454219784098,-0.4283131012922531399,0.00000292066892338692,0.00000235334675454116,-0.0000173063114484388,-0.0000171449455502927,9976.16019280506225186,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +174.000000000000000000,1.00000000000000000000,-0.4255769232855404204,0.00000000000000000000,4.63692335803498956181,1.00000000000000000000,-0.0000384615350098619,0.99999990976331476488,0.00042307691045551099,100.000000000000000000,-0.4298770454219784098,-0.4283131012922531399,-0.0000165362208543519,-0.0000164758209275559,0.00000588150684489100,0.00000529478268040532,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +175.000000000000000000,0.00000000000000000000,0.38619843451956303859,0.00000000000000000000,-24.208488750866308691,1.00000000000000000000,0.00003846153500986195,0.17406481141903148990,0.98473419761190739141,100.000000000000000000,-0.4298770454219784098,-0.4283131012922531399,-0.0000029206689233869,-0.0000023533467545411,0.00001730631144843886,0.00001714494555029271,9976.16019280506225186,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +175.000000000000000000,1.00000000000000000000,0.42557692328554042049,0.00000000000000000000,4.63692335803498956181,1.00000000000000000000,0.00003846153500986195,0.99999990976331476488,0.00042307691045551099,100.000000000000000000,-0.4298770454219784098,-0.4283131012922531399,0.00001653622085435194,0.00001647582092755596,-0.0000058815068448910,-0.0000052947826804053,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +176.000000000000000000,0.00000000000000000000,1.15859530808319655115,0.00000000000000000000,-24.208488894344554864,1.00000000000000000000,0.00011538460480200291,0.17406481039152757461,0.98473419178464305367,100.000000000000000000,-0.4298770459416957900,-0.4283130979524101267,-0.0000087620068157427,-0.0000070600402422740,0.00005191893461301450,0.00005143483645378006,9976.16025169429849484,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +176.000000000000000000,1.00000000000000000000,1.27673077486345043496,0.00000000000000000000,4.63692338557309469138,1.00000000000000000000,0.00011538460480200291,0.99999990384615555782,0.00042307691045556650,100.000000000000000000,-0.4298770459416957900,-0.4283130979524101267,0.00004960866281877159,0.00004942746259227146,-0.0000176445206260477,-0.0000158843479859651,11000.0010576923905318,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +177.000000000000000000,0.00000000000000000000,1.93099219522034881713,0.00000000000000000000,-24.208489181299228221,1.00000000000000000000,0.00019230767391139474,0.17406480833651974404,0.98473418013011471128,100.000000000000000000,-0.4298770469811318273,-0.4283130912727254324,-0.0000146033448448445,-0.0000117667336659587,0.00008653155858068394,0.00008572472676597320,9976.16036947277279978,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +177.000000000000000000,1.00000000000000000000,2.12788464146184219671,0.00000000000000000000,4.63692344064766448497,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,0.00042307691045556650,100.000000000000000000,-0.4298770469811318273,-0.4283130912727254324,0.00008268110555033857,0.00008237910368579767,-0.0000294075346813287,-0.0000264739131257726,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +178.000000000000000000,0.00000000000000000000,2.70338910498003226479,0.00000000000000000000,-24.208489611733966739,1.00000000000000000000,0.00026923074188287118,0.17406480525400802594,0.98473416264832192013,100.000000000000000000,-0.4298770485402849117,-0.4283130812531985021,-0.0000204446831018560,-0.0000164734269828962,0.00012114418388684287,0.00012001461609267594,9976.16054614048698567,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +178.000000000000000000,1.00000000000000000000,2.97903853309437227636,0.00000000000000000000,4.63692352326049839206,1.00000000000000000000,0.00026923074188287118,0.99999987426035952253,0.00042307691045562201,100.000000000000000000,-0.4298770485402849117,-0.4283130812531985021,0.00011575354956048426,0.00011533074382734181,-0.0000411705491934833,-0.0000370634779893261,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +179.000000000000000000,0.00000000000000000000,3.47578604641126398533,0.00000000000000000000,-24.208490185645132442,1.00000000000000000000,0.00034615380826126648,0.17406480114399242031,0.98473413933926512431,100.000000000000000000,-0.4298770506191554319,-0.4283130678938288915,-0.0000262860216779415,-0.0000211801201503878,0.00015575681106688694,0.00015430450403969216,9976.16078169744650949,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +179.000000000000000000,1.00000000000000000000,3.83019245977469990904,0.00000000000000000000,4.63692363341065316717,1.00000000000000000000,0.00034615380826126648,0.99999985059172302737,0.00042307691045556650,100.000000000000000000,-0.4298770506191554319,-0.4283130678938288915,0.00014882599536063996,0.00014828238263611090,-0.0000529335643452610,-0.0000476530424661241,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +180.000000000000000000,0.00000000000000000000,4.24818302856305862746,0.00000000000000000000,-24.208490903036363306,1.00000000000000000000,0.00042307687259141442,0.17406479600647295491,0.98473411020294432383,100.000000000000000000,-0.4298770532177428327,-0.4283130511946176000,-0.0000321273606642646,-0.0000258868131257347,0.00019036944065621216,0.00018859439021282580,9976.16107614366046618,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +180.000000000000000000,1.00000000000000000000,4.68134643151648255354,0.00000000000000000000,4.63692377109861553208,1.00000000000000000000,0.00042307687259141442,0.99999982100592754719,0.00042307691045556650,100.000000000000000000,-0.4298770532177428327,-0.4283130511946176000,0.00018189844346223738,0.00018123401973131232,-0.0000646965803194113,-0.0000582426064456648,11000.0019689351483975,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +181.000000000000000000,0.00000000000000000000,5.02058006048443328239,0.00000000000000000000,-24.208491763902202364,1.00000000000000000000,0.00049999993441814875,0.17406478984144968524,0.98473407523935996277,100.000000000000000000,-0.4298770563360462815,-0.4283130311555628511,-0.0000379687001519893,-0.0000305935058662378,0.00022498207319021369,0.00022288427421787978,9976.16142947913795069,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +181.000000000000000000,1.00000000000000000000,5.53250045833337900091,0.00000000000000000000,4.63692393632391208768,1.00000000000000000000,0.00049999993441814875,0.99999978550297341506,0.00042307691045562201,100.000000000000000000,-0.4298770563360462815,-0.4283130311555628511,0.00021497089437670738,0.00021418565473215223,-0.0000764595972986834,-0.0000688321698174466,11000.0023594677968503,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +182.000000000000000000,0.00000000000000000000,-5.0184188510770537661,0.00000000000000000000,-28.597590490364382276,1.00000000000000000000,-0.0004999999166666708,0.17414053811087884526,0.98472068272507462527,100.000000000000000000,-0.4296276593792218712,-0.4283511216308781288,0.00003794861945368084,0.00003059587339314796,-0.0002248578615072674,-0.0002229094105840494,9971.83936412725233822,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +182.000000000000000000,1.00000000000000000000,-5.5325004583333790009,0.00000000000000000000,5.48000114583352537778,1.00000000000000000000,-0.0004999999166666708,0.99999975000002072622,0.00049999997916677640,100.000000000000000000,-0.4296276593792218712,-0.4283511216308781288,-0.0002148520567249947,-0.0002142099981037051,0.00007641825253891477,0.00006883886626048178,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +183.000000000000000000,0.00000000000000000000,-4.2463543130187906271,0.00000000000000000000,-28.597589473860352882,1.00000000000000000000,-0.0004230768575709328,0.17414054427590189288,0.98472071768865776508,100.000000000000000000,-0.4296276562549701805,-0.4283511416628356660,0.00003211036930417793,0.00002588881641717936,-0.0001902643384625983,-0.0001886156594421369,9971.83901109849648491,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +183.000000000000000000,1.00000000000000000000,-4.6813464315164816653,0.00000000000000000000,5.48000095056758151912,1.00000000000000000000,-0.0004230768575709328,0.99999978550297352608,0.00049999997916672089,100.000000000000000000,-0.4296276562549701805,-0.4283511416628356660,-0.0001817978885258230,-0.0001812546179653297,0.00006466159629187387,0.00005824827266552137,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +184.000000000000000000,0.00000000000000000000,-3.4742898246760431923,0.00000000000000000000,-28.597588626771539566,1.00000000000000000000,-0.0003461537959717815,0.17414054941342116400,0.98472074682497745534,100.000000000000000000,-0.4296276536514254673,-0.4283511583561326330,0.00002627211965606637,0.00002118175920664518,-0.0001556708183627811,-0.0001543219061339456,9971.83871690788328123,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +184.000000000000000000,1.00000000000000000000,-3.8301924597747007972,0.00000000000000000000,5.48000078784559541134,1.00000000000000000000,-0.0003461537959717815,0.99999981508876789604,0.00049999997916672089,100.000000000000000000,-0.4296276536514254673,-0.4283511583561326330,-0.0001487437231396986,-0.0001482992357343181,0.00005290494104997525,0.00004765767846338861,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +185.000000000000000000,0.00000000000000000000,-2.7022253770096229530,0.00000000000000000000,-28.597587949099761317,1.00000000000000000000,-0.0002692307323243828,0.17414055352343663085,0.98472077013403347400,100.000000000000000000,-0.4296276515685901742,-0.4283511717107714167,0.00002043387041818420,0.00001647470180419379,-0.0001210773006723893,-0.0001200281510533453,9971.83848155540363222,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +185.000000000000000000,1.00000000000000000000,-2.9790385330943736086,0.00000000000000000000,5.48000065766767274766,1.00000000000000000000,-0.0002692307323243828,0.99999983875740361405,0.00049999997916672089,100.000000000000000000,-0.4296276515685901742,-0.4283511717107714167,-0.0001156895600551593,-0.0001153438517911505,0.00004114828663046600,0.00003706708376447871,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +186.000000000000000000,0.00000000000000000000,-1.9301609609803449529,0.00000000000000000000,-28.597587440846837125,1.00000000000000000000,-0.0001923076670839029,0.17414055660594823793,0.98472078761582559902,100.000000000000000000,-0.4296276500064628578,-0.4283511817267496857,0.00001459562149936924,0.00001176764425247338,-0.0000864837848559943,-0.0000857343945942041,9971.83830504104844294,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +186.000000000000000000,1.00000000000000000000,-2.1278846414618421967,0.00000000000000000000,5.48000056003487845401,1.00000000000000000000,-0.0001923076670839029,0.99999985650888068011,0.00049999997916672089,100.000000000000000000,-0.4296276500064628578,-0.4283511817267496857,-0.0000826353987607412,-0.0000823884665163054,0.00002939163285059277,0.00002647648867918640,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +187.000000000000000000,0.00000000000000000000,-1.1580965675490242361,0.00000000000000000000,-28.597587102014585980,1.00000000000000000000,-0.0001153846007055078,0.17414055866095598523,0.98472079927035349733,100.000000000000000000,-0.4296276489650449059,-0.4283511884040689943,0.00000875737280845947,0.00000706058659413230,-0.0000518902703781689,-0.0000514406371503912,9971.83818736481225641,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +187.000000000000000000,1.00000000000000000000,-1.2767307748634506570,0.00000000000000000000,5.48000049494640517622,1.00000000000000000000,-0.0001153846007055078,0.99999986834319842810,0.00049999997916666538,100.000000000000000000,-0.4296276489650449059,-0.4283511884040689943,-0.0000495812387449815,-0.0000494330802902624,0.00001763497952760250,0.00001588589331790679,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +188.000000000000000000,0.00000000000000000000,-0.3860321876764773452,0.00000000000000000000,-28.597586932593912933,1.00000000000000000000,-0.0000384615336443635,0.17414055968845987276,0.98472080509761772404,100.000000000000000000,-0.4296276484443354304,-0.4283511917427275661,0.00000291912425429280,0.00000235352887181880,-0.0000172967567034849,-0.0000171468791157751,9971.83812852669871062,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +188.000000000000000000,1.00000000000000000000,-0.4255769232855405315,0.00000000000000000000,5.48000046240157168142,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,0.00049999997916666538,100.000000000000000000,-0.4296276484443354304,-0.4283511917427275661,-0.0000165270794964165,-0.0000164776934935006,0.00000587832647874196,0.00000529529779103473,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +189.000000000000000000,0.00000000000000000000,0.38603218767647734521,0.00000000000000000000,-28.597586932593912933,1.00000000000000000000,0.00003846153364436359,0.17414055968845987276,0.98472080509761772404,100.000000000000000000,-0.4296276484443354304,-0.4283511917427275661,-0.0000029191242542928,-0.0000023535288718188,0.00001729675670348496,0.00001714687911577515,9971.83812852669871062,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +189.000000000000000000,1.00000000000000000000,0.42557692328554053151,0.00000000000000000000,5.48000046240157168142,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,0.00049999997916666538,100.000000000000000000,-0.4296276484443354304,-0.4283511917427275661,0.00001652707949641659,0.00001647769349350064,-0.0000058783264787419,-0.0000052952977910347,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +190.000000000000000000,0.00000000000000000000,1.15809656754902423614,0.00000000000000000000,-28.597587102014585980,1.00000000000000000000,0.00011538460070550785,0.17414055866095598523,0.98472079927035349733,100.000000000000000000,-0.4296276489650449059,-0.4283511884040689943,-0.0000087573728084594,-0.0000070605865941323,0.00005189027037816891,0.00005144063715039126,9971.83818736481225641,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +190.000000000000000000,1.00000000000000000000,1.27673077486345065700,0.00000000000000000000,5.48000049494640517622,1.00000000000000000000,0.00011538460070550785,0.99999986834319842810,0.00049999997916666538,100.000000000000000000,-0.4296276489650449059,-0.4283511884040689943,0.00004958123874498154,0.00004943308029026249,-0.0000176349795276025,-0.0000158858933179067,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +191.000000000000000000,0.00000000000000000000,1.93016096098034539707,0.00000000000000000000,-28.597587440846837125,1.00000000000000000000,0.00019230766708390299,0.17414055660594823793,0.98472078761582559902,100.000000000000000000,-0.4296276500064628578,-0.4283511817267496857,-0.0000145956214993692,-0.0000117676442524733,0.00008648378485599436,0.00008573439459420417,9971.83830504104844294,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +191.000000000000000000,1.00000000000000000000,2.12788464146184264080,0.00000000000000000000,5.48000056003487845401,1.00000000000000000000,0.00019230766708390299,0.99999985650888068011,0.00049999997916672089,100.000000000000000000,-0.4296276500064628578,-0.4283511817267496857,0.00008263539876074128,0.00008238846651630546,-0.0000293916328505927,-0.0000264764886791864,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +192.000000000000000000,0.00000000000000000000,2.70222537700962295303,0.00000000000000000000,-28.597587949099761317,1.00000000000000000000,0.00026923073232438285,0.17414055352343663085,0.98472077013403347400,100.000000000000000000,-0.4296276515685901742,-0.4283511717107714167,-0.0000204338704181842,-0.0000164747018041937,0.00012107730067238930,0.00012002815105334533,9971.83848155540363222,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +192.000000000000000000,1.00000000000000000000,2.97903853309437360863,0.00000000000000000000,5.48000065766767274766,1.00000000000000000000,0.00026923073232438285,0.99999983875740361405,0.00049999997916672089,100.000000000000000000,-0.4296276515685901742,-0.4283511717107714167,0.00011568956005515932,0.00011534385179115056,-0.0000411482866304660,-0.0000370670837644787,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +193.000000000000000000,0.00000000000000000000,3.47428982467604319239,0.00000000000000000000,-28.597588626771539566,1.00000000000000000000,0.00034615379597178157,0.17414054941342116400,0.98472074682497745534,100.000000000000000000,-0.4296276536514254673,-0.4283511583561326330,-0.0000262721196560663,-0.0000211817592066451,0.00015567081836278119,0.00015432190613394561,9971.83871690788328123,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +193.000000000000000000,1.00000000000000000000,3.83019245977470079722,0.00000000000000000000,5.48000078784559541134,1.00000000000000000000,0.00034615379597178157,0.99999981508876789604,0.00049999997916672089,100.000000000000000000,-0.4296276536514254673,-0.4283511583561326330,0.00014874372313969865,0.00014829923573431819,-0.0000529049410499752,-0.0000476576784633886,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +194.000000000000000000,0.00000000000000000000,4.24635431301879062715,0.00000000000000000000,-28.597589473860352882,1.00000000000000000000,0.00042307685757093292,0.17414054427590189288,0.98472071768865776508,100.000000000000000000,-0.4296276562549701805,-0.4283511416628356660,-0.0000321103693041779,-0.0000258888164171793,0.00019026433846259838,0.00018861565944213690,9971.83901109849648491,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +194.000000000000000000,1.00000000000000000000,4.68134643151648255354,0.00000000000000000000,5.48000095056758151912,1.00000000000000000000,0.00042307685757093292,0.99999978550297352608,0.00049999997916672089,100.000000000000000000,-0.4296276562549701805,-0.4283511416628356660,0.00018179788852582307,0.00018125461796532978,-0.0000646615962918738,-0.0000582482726655214,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +195.000000000000000000,0.00000000000000000000,5.01841885107705376611,0.00000000000000000000,-28.597590490364382276,1.00000000000000000000,0.00049999991666667084,0.17414053811087884526,0.98472068272507462527,100.000000000000000000,-0.4296276593792218712,-0.4283511216308781288,-0.0000379486194536808,-0.0000305958733931479,0.00022485786150726745,0.00022290941058404948,9971.83936412725233822,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +195.000000000000000000,1.00000000000000000000,5.53250045833337900091,0.00000000000000000000,5.48000114583352537778,1.00000000000000000000,0.00049999991666667084,0.99999975000002072622,0.00049999997916677640,100.000000000000000000,-0.4296276593792218712,-0.4283511216308781288,0.00021485205672499478,0.00021420999810370518,-0.0000764182525389147,-0.0000688388662604817,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +196.000000000000000000,0.00000000000000000000,-5.0466620698997637362,0.00000000000000000000,28.7602367256004072260,1.00000000000000000000,-0.0004999999166666708,0.17315573039890028161,0.98489433089550615374,100.000000000000000000,-0.4328730222075060085,-0.4278468919645758150,0.00003820993979154383,0.00003056443547525051,-0.0002264737830923415,-0.0002225780072040917,10028.3258111870818538,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +196.000000000000000000,1.00000000000000000000,-5.5325004583333790009,0.00000000000000000000,-5.4800011458330635250,1.00000000000000000000,-0.0004999999166666708,0.99999975000002072622,-0.0004999999791666098,100.000000000000000000,-0.4328730222075060085,-0.4278468919645758150,-0.0002163980510297783,-0.0002138890886229009,0.00007695620467216277,0.00006875035836219549,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +197.000000000000000000,0.00000000000000000000,-4.2702524198358808860,0.00000000000000000000,28.7602356975221482571,1.00000000000000000000,-0.0004230768575709328,0.17315573656392332924,0.98489436585908929355,100.000000000000000000,-0.4328730191609597155,-0.4278469120886494447,0.00003233148651289173,0.00002586221510927040,-0.0001916316567316117,-0.0001883352412443913,10028.3254541393671388,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +197.000000000000000000,1.00000000000000000000,-4.6813464315164816653,0.00000000000000000000,-5.4800009505671178899,1.00000000000000000000,-0.0004230768575709328,0.99999978550297341506,-0.0004999999791665543,100.000000000000000000,-0.4328730191609597155,-0.4278469120886494447,-0.0001831060375576387,-0.0001809830792187461,0.00006511678655904454,0.00005817338138222919,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +198.000000000000000000,0.00000000000000000000,-3.4938428201962703489,0.00000000000000000000,28.7602348407926911022,1.00000000000000000000,-0.0003461537959717815,0.17315574170144260035,0.98489439499540898381,100.000000000000000000,-0.4328730166221709807,-0.4278469288587109509,0.00002645303373575461,0.00002115999450510721,-0.0001567895333133745,-0.0001540924730949954,10028.3251565996233694,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +198.000000000000000000,1.00000000000000000000,-3.8301924597747012413,0.00000000000000000000,-5.4800007878455039289,1.00000000000000000000,-0.0003461537959717815,0.99999981508876789604,-0.0004999999791666098,100.000000000000000000,-0.4328730166221709807,-0.4278469288587109509,-0.0001498140268962015,-0.0001480770676995224,0.00005327736945078058,0.00004759640378746175,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +199.000000000000000000,0.00000000000000000000,-2.7174332618128755889,0.00000000000000000000,28.7602341554065787931,1.00000000000000000000,-0.0002692307323243828,0.17315574581145806720,0.98489441830446500247,100.000000000000000000,-0.4328730145911391380,-0.4278469422747606110,0.00002057458136894794,0.00001645777370606699,-0.0001219474123026308,-0.0001198497031540308,10028.3249185678359935,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +199.000000000000000000,1.00000000000000000000,-2.9790385330943736086,0.00000000000000000000,-5.4800006576671842495,1.00000000000000000000,-0.0002692307323243828,0.99999983875740361405,-0.0004999999791666653,100.000000000000000000,-0.4328730145911391380,-0.4278469422747606110,-0.0001165220185344293,-0.0001151710544497879,0.00004143795316467010,0.00003701942568967524,11000.0017736688459990,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 diff --git a/Intern/rayx-core/tests/input/PointSource_seeded.correct.csv b/Intern/rayx-core/tests/input/PointSource_seeded.correct.csv index 925c9fe3..33746b3d 100644 --- a/Intern/rayx-core/tests/input/PointSource_seeded.correct.csv +++ b/Intern/rayx-core/tests/input/PointSource_seeded.correct.csv @@ -1,201 +1,201 @@ -Ray-ID ,Event-ID ,X-position ,Y-position ,Z-position ,Event-type ,X-direction ,Y-direction ,Z-direction ,Energy ,Stokes0 ,Stokes1 ,Stokes2 ,Stokes3 ,pathLength ,order ,lastElement ,lightSourceIndex -0.00000000000000000000,0.00000000000000000000,-1.7903320893902066046,0.00000000000000000000,0.83611441621380244715,1.00000000000000000000,-0.0018170116945435889,0.99999800383513115509,0.00083114033415540903,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.770001767253575053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -1.00000000000000000000,0.00000000000000000000,-0.3830814019361608036,0.00000000000000000000,-0.7210972937484624312,1.00000000000000000000,-0.0004846383878598668,0.99999968473657607770,-0.0006290090472399334,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.634138999235915434,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -2.00000000000000000000,0.00000000000000000000,2.01352449880240058632,0.00000000000000000000,-1.7615669936310247578,1.00000000000000000000,0.00184424753055840605,0.99999674983824460294,-0.0017604158580713192,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.670806455260503753,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -3.00000000000000000000,0.00000000000000000000,-1.6402858072429193914,0.00000000000000000000,-1.3292548960560024440,1.00000000000000000000,-0.0015517666731649575,0.99999797405508994430,-0.0012821489412684855,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.977269462267940980,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -4.00000000000000000000,0.00000000000000000000,1.00357544087991645831,0.00000000000000000000,-0.0771343848143010990,1.00000000000000000000,0.00105544701572107303,0.99999943129483714887,-0.0001531064967828895,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.20842417606024810,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -5.00000000000000000000,0.00000000000000000000,1.54531010138667967979,0.00000000000000000000,0.94793746464542627538,1.00000000000000000000,0.00157859591959139274,0.99999825297050071171,0.00100104488861495156,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.987512571353363455,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -6.00000000000000000000,0.00000000000000000000,-0.2714569659798616307,0.00000000000000000000,-0.3745661476704158499,1.00000000000000000000,-0.0002438350236688279,0.99999992442576390860,-0.0003028084339632207,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.43502401281421043,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -7.00000000000000000000,0.00000000000000000000,-0.5536757354308237122,0.00000000000000000000,0.01224841014304983710,1.00000000000000000000,-0.0005215916611252036,0.99999986276578778365,-0.0000490972964520432,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.40246517247874180,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -8.00000000000000000000,0.00000000000000000000,0.57670663071799399546,0.00000000000000000000,0.36163962509956976143,1.00000000000000000000,0.00067911592935621448,0.99999971234439299916,0.00033780569231646619,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.46589926653450675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -9.00000000000000000000,0.00000000000000000000,1.80399368221311484639,0.00000000000000000000,0.94654532698218507569,1.00000000000000000000,0.00180203948281240796,0.99999787531532768891,0.00100100875754007175,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.982056625634413649,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -10.0000000000000000000,0.00000000000000000000,-0.1354297711550078164,0.00000000000000000000,-0.4492112234203732290,1.00000000000000000000,-0.0001443446548242443,0.99999990043152697793,-0.0004222576897879662,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.560600585650945504,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -11.0000000000000000000,0.00000000000000000000,0.82683613978170367175,0.00000000000000000000,-2.4950482565762244213,1.00000000000000000000,0.00083870667843186118,0.99999673287559565082,-0.0024147068646381644,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.30728526463701655,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -12.0000000000000000000,0.00000000000000000000,-1.2476277961299009344,0.00000000000000000000,-1.4638361817216085647,1.00000000000000000000,-0.0012465307828809888,0.99999824071519016754,-0.0014016873872770528,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.673021199931099545,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -13.0000000000000000000,0.00000000000000000000,-0.1556663252481808590,0.00000000000000000000,-2.2897474866541167592,1.00000000000000000000,-0.0001440217948228577,0.99999741833300426208,-0.0022677268461958502,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.700383910517530239,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -14.0000000000000000000,0.00000000000000000000,-0.2373469274248576899,0.00000000000000000000,-0.2213027829556896974,1.00000000000000000000,-0.0002003432061171753,0.99999995957007770108,-0.0002017980246750739,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.49451832754061797,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -15.0000000000000000000,0.00000000000000000000,1.80047163078523708712,0.00000000000000000000,0.81178219094069570260,1.00000000000000000000,0.00178679960427859823,0.99999805581245349017,0.00083409740871731141,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.42790037368388311,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -16.0000000000000000000,0.00000000000000000000,-0.7254368893133744666,0.00000000000000000000,1.57920030017431933799,1.00000000000000000000,-0.0007460480046487706,0.99999841618198470616,0.00161587310664486403,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.17068606389921114,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -17.0000000000000000000,0.00000000000000000000,-0.9572452276555470929,0.00000000000000000000,0.42670914588741787332,1.00000000000000000000,-0.0009082610451504131,0.99999948472287214507,0.00045344885496587187,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.862957735426448380,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -18.0000000000000000000,0.00000000000000000000,0.10436128514304782166,0.00000000000000000000,-0.0753476891996055081,1.00000000000000000000,-0.0000274938995140157,0.99999999515509951919,-0.0000945192389796586,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.739219800220439537,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -19.0000000000000000000,0.00000000000000000000,0.70517857792753046997,0.00000000000000000000,2.50462461091878996199,1.00000000000000000000,0.00063039141656364826,0.99999663722505505170,0.00251558049831528346,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.07582200902572822,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -20.0000000000000000000,0.00000000000000000000,0.41782372823360380831,0.00000000000000000000,0.35286249232938704523,1.00000000000000000000,0.00028216243403025653,0.99999988400039063751,0.00039036337680465498,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.18576003978080279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -21.0000000000000000000,0.00000000000000000000,-1.9269250036527880709,0.00000000000000000000,-1.6592921244966489791,1.00000000000000000000,-0.0018415400574254634,0.99999701156776654720,-0.0016079756692825868,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.747436537930298072,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -22.0000000000000000000,0.00000000000000000000,0.71819057674736941354,0.00000000000000000000,0.24038868057686565982,1.00000000000000000000,0.00075330027603372098,0.99999969922941900346,0.00018460705761746973,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.570602993291004167,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -23.0000000000000000000,0.00000000000000000000,-0.5333944448865765020,0.00000000000000000000,-0.3491162148992121294,1.00000000000000000000,-0.0005004043916503004,0.99999981206357990703,-0.0003542149766876076,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.31361793697294615,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -24.0000000000000000000,0.00000000000000000000,-1.0004845293630566516,0.00000000000000000000,0.27965548998261063884,1.00000000000000000000,-0.0010309023807825096,0.99999942621927151442,0.00029120681483637569,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.18257041579738597,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -25.0000000000000000000,0.00000000000000000000,-1.0475245727238207127,0.00000000000000000000,-1.6252015690166470296,1.00000000000000000000,-0.0011327159901788927,0.99999806154309189842,-0.0016105479018686105,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.641207178355102769,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -26.0000000000000000000,0.00000000000000000000,0.08293425913302393537,0.00000000000000000000,-0.0789550597434337947,1.00000000000000000000,0.00016840245556516079,0.99999998434163883676,-0.0000543813850827478,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.38015029476844119,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -27.0000000000000000000,0.00000000000000000000,0.01316612190347112368,0.00000000000000000000,-1.3483435538680108578,1.00000000000000000000,-0.0000058856042086105,0.99999914742349982343,-0.0013058015290100481,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.797833446225013176,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -28.0000000000000000000,0.00000000000000000000,1.58501814641925853344,0.00000000000000000000,-0.9479911811010655053,1.00000000000000000000,0.00158465814080821975,0.99999831569309793888,-0.0009259965140188350,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00443581343915866,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -29.0000000000000000000,0.00000000000000000000,-0.9167279291628699366,0.00000000000000000000,-2.3441055475799839058,1.00000000000000000000,-0.0008991533767250880,0.99999675527913600703,-0.0023834752788065701,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00056570218316664,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -30.0000000000000000000,0.00000000000000000000,-0.1797181128960924634,0.00000000000000000000,1.10350129359520043870,1.00000000000000000000,-0.0001607173333056111,0.99999934680408208986,0.00113161890575448165,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.35575855989588944,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -31.0000000000000000000,0.00000000000000000000,0.16950431700712986771,0.00000000000000000000,-0.0523025034678316763,1.00000000000000000000,0.00026100702396103373,0.99999996245343492073,-0.0000834773157025421,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.738417921663312881,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -32.0000000000000000000,0.00000000000000000000,0.56553865649371481971,0.00000000000000000000,-0.4147385932787035489,1.00000000000000000000,0.00065596589530285322,0.99999968229942304276,-0.0004528904915224072,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.866787949154399939,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -33.0000000000000000000,0.00000000000000000000,-0.4485652701366859007,0.00000000000000000000,-1.6530440751237360785,1.00000000000000000000,-0.0004711956062625525,0.99999862127102201458,-0.0015923036003770889,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.31486065666229023,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -34.0000000000000000000,0.00000000000000000000,0.78105532412396028174,0.00000000000000000000,0.97356690375945087456,1.00000000000000000000,0.00077040280388320642,0.99999920197999903059,0.00100125865035467363,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.988704958134462685,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -35.0000000000000000000,0.00000000000000000000,-0.7836334710378285439,0.00000000000000000000,-0.2168541122606920945,1.00000000000000000000,-0.0008966323682086169,0.99999958010453171564,-0.0001893176076927331,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.11368459345328574,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -36.0000000000000000000,0.00000000000000000000,0.21225987736993515153,0.00000000000000000000,0.19207157739838520704,1.00000000000000000000,0.00022119708182556045,0.99999996092909781975,0.00017092002168079842,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.575345434728433247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -37.0000000000000000000,0.00000000000000000000,1.71124919276442999382,0.00000000000000000000,0.10190353922986196411,1.00000000000000000000,0.00168442302812935929,0.99999857842072448210,0.00007665241349480921,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.946220689356550792,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -38.0000000000000000000,0.00000000000000000000,-0.1269411358338377038,0.00000000000000000000,-0.3764478417177709590,1.00000000000000000000,-0.0002653531611246259,0.99999990028239815753,-0.0003591975689766601,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.599681625954872288,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -39.0000000000000000000,0.00000000000000000000,0.50783166221466424783,0.00000000000000000000,0.42212588908461795567,1.00000000000000000000,0.00053697948549918331,0.99999977421173635860,0.00040401671790679649,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.603115444404807021,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -40.0000000000000000000,0.00000000000000000000,-0.8384072931463998346,0.00000000000000000000,0.30729520301197282838,1.00000000000000000000,-0.0008743664504504158,0.99999959233922897094,0.00022539894884708019,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.33877908896715780,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -41.0000000000000000000,0.00000000000000000000,-0.7899393467840394311,0.00000000000000000000,0.76723135621776183956,1.00000000000000000000,-0.0006517192778375967,0.99999955112402438839,0.00068775993822289924,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.836947040311201817,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -42.0000000000000000000,0.00000000000000000000,0.74757061350202691496,0.00000000000000000000,-0.8084556387039878444,1.00000000000000000000,0.00081861611342077329,0.99999936382322474059,-0.0007760288684307970,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.848674824768181679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -43.0000000000000000000,0.00000000000000000000,-0.2139615585003428743,0.00000000000000000000,0.05992546375144839482,1.00000000000000000000,-0.0001038115510734464,0.99999999403314809853,0.00003401273033540993,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.753514558396091160,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -44.0000000000000000000,0.00000000000000000000,-0.0259617457223818223,0.00000000000000000000,0.88588997594541107893,1.00000000000000000000,-0.0000047276659541162,0.99999957076249468279,0.00092652710465491495,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.40675464547962292,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -45.0000000000000000000,0.00000000000000000000,-0.9713664266712693784,0.00000000000000000000,-0.3879490312881589408,1.00000000000000000000,-0.0008790426328031954,0.99999953476546177277,-0.0003971812050399908,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.10736756056348895,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -46.0000000000000000000,0.00000000000000000000,0.19852324774040028265,0.00000000000000000000,-0.8110501106401932780,1.00000000000000000000,0.00022445089431004437,0.99999966875307821911,-0.0007823781246552961,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.923427335494238832,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -47.0000000000000000000,0.00000000000000000000,1.80801825985799835549,0.00000000000000000000,-0.9585792106883930241,1.00000000000000000000,0.00185954213099227242,0.99999786532162326935,-0.0009008081146911684,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.47781973719145298,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -48.0000000000000000000,0.00000000000000000000,2.73967015752784348592,0.00000000000000000000,0.01792996819285708892,1.00000000000000000000,0.00276317660115505585,0.99999618221608632673,0.00002020699536371607,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.588951826112975140,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -49.0000000000000000000,0.00000000000000000000,0.48945419975328080530,0.00000000000000000000,-0.3193027228559737196,1.00000000000000000000,0.00050186940267031056,0.99999983756833754622,-0.0002701673572949503,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.533507536227716627,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -50.0000000000000000000,0.00000000000000000000,-1.3471564098272748033,0.00000000000000000000,1.52902220345003980739,1.00000000000000000000,-0.0013127657516968141,0.99999799902404773455,0.00150950123607214176,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.650863602501658533,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -51.0000000000000000000,0.00000000000000000000,0.49558075392898187638,0.00000000000000000000,-0.9498188443236809108,1.00000000000000000000,0.00055118516153753534,0.99999938910645136402,-0.0009581135850559639,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.804580978439958016,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -52.0000000000000000000,0.00000000000000000000,-0.2557343463800159089,0.00000000000000000000,0.31839950798907895590,1.00000000000000000000,-0.0002251812763279580,0.99999992285248517909,0.00032185154431477777,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.35999316167919914,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -53.0000000000000000000,0.00000000000000000000,-0.4216889763453134931,0.00000000000000000000,1.37431653696732136715,1.00000000000000000000,-0.0004510359085725458,0.99999898382415208786,0.00135237467899688513,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.798531889923651760,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -54.0000000000000000000,0.00000000000000000000,1.12014432126193463901,0.00000000000000000000,-0.3721451184583186022,1.00000000000000000000,0.00115758704346757813,0.99999926107550762832,-0.0003712690067350706,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.633666333985502205,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -55.0000000000000000000,0.00000000000000000000,0.58869468921998990840,0.00000000000000000000,0.67958205016432982059,1.00000000000000000000,0.00064179749339880103,0.99999956928135802503,0.00067047227829122163,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.850466723834642834,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -56.0000000000000000000,0.00000000000000000000,-0.4688057571369460552,0.00000000000000000000,2.07249872204422835864,1.00000000000000000000,-0.0004924910138135828,0.99999785019827058807,0.00201421236181962290,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.12656711912279661,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -57.0000000000000000000,0.00000000000000000000,0.57685328936845792213,0.00000000000000000000,-0.8103843964160919455,1.00000000000000000000,0.00065593180329993742,0.99999943357940734856,-0.0008382090037037597,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.957921762255182329,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -58.0000000000000000000,0.00000000000000000000,-0.9408871378345999847,0.00000000000000000000,1.48953737914822781363,1.00000000000000000000,-0.0009409181307578014,0.99999859065213336783,0.00139045561530202056,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.678808335439953225,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -59.0000000000000000000,0.00000000000000000000,1.24764877075773483738,0.00000000000000000000,0.93451929437038605552,1.00000000000000000000,0.00121248222199622757,0.99999882487602531622,0.00093815426768459190,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.28535443638509150,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -60.0000000000000000000,0.00000000000000000000,0.59171738784053651283,0.00000000000000000000,-0.6506155605881596137,1.00000000000000000000,0.00053756356162720818,0.99999966796120576262,-0.0006124564436113300,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.959696905628106833,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -61.0000000000000000000,0.00000000000000000000,-1.4635139042672067333,0.00000000000000000000,0.53470839520275903478,1.00000000000000000000,-0.0014773600400536099,0.99999876032190504471,0.00054475863018046814,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.17828341964650462,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -62.0000000000000000000,0.00000000000000000000,-0.5422612966631934483,0.00000000000000000000,-0.2416637075114058119,1.00000000000000000000,-0.0005388840563157253,0.99999982574669943335,-0.0002410612880775294,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.47482359306081889,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -63.0000000000000000000,0.00000000000000000000,0.08591421232759309523,0.00000000000000000000,1.85175436147774408190,1.00000000000000000000,0.00010673566705110033,0.99999837212744058234,0.00180120791867362283,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.32833408793237595,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -64.0000000000000000000,0.00000000000000000000,-0.2430691772559476770,0.00000000000000000000,1.04372760174422318790,1.00000000000000000000,-0.0003022533785151572,0.99999942339074887609,0.00103046643067751238,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.840379145674319261,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -65.0000000000000000000,0.00000000000000000000,-1.5565802006859368322,0.00000000000000000000,-1.2989388232442971027,1.00000000000000000000,-0.0015288205757833291,0.99999803864949821097,-0.0012591285889789931,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.890240389397604303,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -66.0000000000000000000,0.00000000000000000000,2.11153608544163828852,0.00000000000000000000,-1.7187514664914440576,1.00000000000000000000,0.00205980031063825955,0.99999636551241277704,-0.0017395932412820887,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.48924277406013061,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -67.0000000000000000000,0.00000000000000000000,0.11890747152019709442,0.00000000000000000000,-1.1921153847567598216,1.00000000000000000000,0.00018084119877233612,0.99999924610894896925,-0.0012145278895877474,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.797095875422201061,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -68.0000000000000000000,0.00000000000000000000,1.32265381648594892993,0.00000000000000000000,0.73352131742713910789,1.00000000000000000000,0.00129511654073349554,0.99999887170255563617,0.00076109576389209979,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.32792680095519699,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -69.0000000000000000000,0.00000000000000000000,0.94584093436695537704,0.00000000000000000000,-1.3666366437469541494,1.00000000000000000000,0.00088467575533312864,0.99999863586262849324,-0.0013948554369992089,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.45606075142950430,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -70.0000000000000000000,0.00000000000000000000,2.08453918437952667730,0.00000000000000000000,1.40035435615291636857,1.00000000000000000000,0.00216105894451558595,0.99999665363402368001,0.00142216208391018699,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.844652218518035624,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -71.0000000000000000000,0.00000000000000000000,-0.4069753088334398527,0.00000000000000000000,-0.0380850055988729840,1.00000000000000000000,-0.0004644513129295223,0.99999988603945466625,-0.0001104810191282935,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.914338366897254672,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -72.0000000000000000000,0.00000000000000000000,-0.3242418849809126646,0.00000000000000000000,-0.4467221357914749613,1.00000000000000000000,-0.0002441435275330030,0.99999985848392802800,-0.0004726796610111265,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.04188863744559512,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -73.0000000000000000000,0.00000000000000000000,0.54795736024740770986,0.00000000000000000000,0.26422237465476128281,1.00000000000000000000,0.00050976502655702613,0.99999983338664599763,0.00027086213819938235,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.594815903122480449,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -74.0000000000000000000,0.00000000000000000000,-1.3838907911750455426,0.00000000000000000000,0.56183783660451214192,1.00000000000000000000,-0.0012835147329476723,0.99999907422383726984,0.00045182009547032854,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.40648319211265970,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -75.0000000000000000000,0.00000000000000000000,-1.6655895380302467856,0.00000000000000000000,0.03336220469314755965,1.00000000000000000000,-0.0015909603563935301,0.99999873349654355703,0.00004301689647944952,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.47799516981478973,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -76.0000000000000000000,0.00000000000000000000,-0.7296919625333229131,0.00000000000000000000,-0.5155082677398085122,1.00000000000000000000,-0.0006826033172506007,0.99999964408114916381,-0.0004958732562483936,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.871413030342637284,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -77.0000000000000000000,0.00000000000000000000,-0.5401182505938456612,0.00000000000000000000,0.62777631819664170276,1.00000000000000000000,-0.0005820398418553848,0.99999959371771773852,0.00068832697304810276,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.32296687073653629,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -78.0000000000000000000,0.00000000000000000000,0.98397114436807842086,0.00000000000000000000,0.65933452354979937837,1.00000000000000000000,0.00098487746168404786,0.99999932140353031684,0.00062226109014273587,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.12866059580358069,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -79.0000000000000000000,0.00000000000000000000,0.03264102177293599915,0.00000000000000000000,0.04955095577989235278,1.00000000000000000000,0.00005542406252287200,0.99999999731375333045,0.00004796526416486207,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.07100866030236829,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -80.0000000000000000000,0.00000000000000000000,-0.5447107265508674966,0.00000000000000000000,0.45709242085101681185,1.00000000000000000000,-0.0004450758993624834,0.99999978824170221436,0.00047478836824383296,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.994959381612488868,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -81.0000000000000000000,0.00000000000000000000,-1.3159830892265409474,0.00000000000000000000,-0.2038041873885136912,1.00000000000000000000,-0.0013400320074743615,0.99999906950201766786,-0.0002555568776573170,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.49009330711089660,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -82.0000000000000000000,0.00000000000000000000,0.92426414986894955827,0.00000000000000000000,1.04744241302273843885,1.00000000000000000000,0.00083001729408805973,0.99999910049699525238,0.00105360167614902818,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.550291947709411033,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -83.0000000000000000000,0.00000000000000000000,0.78080121015752335100,0.00000000000000000000,-0.2568587679963586500,1.00000000000000000000,0.00071165003959696880,0.99999972541398995939,-0.0002067030863929171,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.17161008622281315,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -84.0000000000000000000,0.00000000000000000000,2.39842212411325306220,0.00000000000000000000,-1.1510856808509866144,1.00000000000000000000,0.00238875458607482700,0.99999646083072657454,-0.0011713998243742561,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.41233452966707773,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -85.0000000000000000000,0.00000000000000000000,2.09719206044459616222,0.00000000000000000000,0.39217859604741583945,1.00000000000000000000,0.00203118663636463192,0.99999785853469991270,0.00039649320596414730,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.614436455609165932,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -86.0000000000000000000,0.00000000000000000000,-2.0379453778828944265,0.00000000000000000000,-1.1142956025783143925,1.00000000000000000000,-0.0019895104228308596,0.99999738273157490198,-0.0011297691256858671,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.884398906303204057,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -87.0000000000000000000,0.00000000000000000000,-2.2221363543113357152,0.00000000000000000000,-0.5772824515812883250,1.00000000000000000000,-0.0022322434790677000,0.99999738127717763269,-0.0005045075194250165,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.680757830020866094,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -88.0000000000000000000,0.00000000000000000000,0.06899502188641938593,0.00000000000000000000,-1.0350850553824955113,1.00000000000000000000,0.00005380118861179269,0.99999946889319635268,-0.0010292321202283365,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.12626038095652347,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -89.0000000000000000000,0.00000000000000000000,-2.1951824614942032631,0.00000000000000000000,0.35745149730564490520,1.00000000000000000000,-0.0022136378953403314,0.99999748395405108070,0.00036317053236873645,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.749137231243139467,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -90.0000000000000000000,0.00000000000000000000,-1.9540578361717375610,0.00000000000000000000,0.20224266990360872942,1.00000000000000000000,-0.0019206639383721631,0.99999813257152603274,0.00021425101281859413,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.07764555992525856,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -91.0000000000000000000,0.00000000000000000000,0.22078146898190106894,0.00000000000000000000,0.03687690546975989913,1.00000000000000000000,0.00022256382620524053,0.99999996598913787337,0.00013596715162152224,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.03137336779730048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -92.0000000000000000000,0.00000000000000000000,-0.1654499813753515791,0.00000000000000000000,-0.0827465214174573776,1.00000000000000000000,-0.0002249006518194522,0.99999997139567797788,-0.0000814146187858942,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.753983722919997489,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -93.0000000000000000000,0.00000000000000000000,-0.0021580378342530848,0.00000000000000000000,1.64854046404500431677,1.00000000000000000000,0.00008803766096529720,0.99999872537840994723,0.00159420542139942860,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.632675023579508888,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -94.0000000000000000000,0.00000000000000000000,1.19793906877164912927,0.00000000000000000000,-0.4718622440529978145,1.00000000000000000000,0.00100629528758512860,0.99999938679445010691,-0.0004623640534316621,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.45745356998725128,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -95.0000000000000000000,0.00000000000000000000,0.57871398906186477528,0.00000000000000000000,-0.2238900879201876914,1.00000000000000000000,0.00057199701723625027,0.99999981172631613457,-0.0002221862834076512,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.946333983765271113,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -96.0000000000000000000,0.00000000000000000000,-0.7612365363911161031,0.00000000000000000000,0.30659328003550390118,1.00000000000000000000,-0.0007741508019879976,0.99999965042342686682,0.00031598031540485419,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.04580852814763147,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -97.0000000000000000000,0.00000000000000000000,-0.3825729369826243453,0.00000000000000000000,-0.2124654565857720389,1.00000000000000000000,-0.0003800887565084805,0.99999988333783051963,-0.0002980886823312195,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.21915350266056066,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -98.0000000000000000000,0.00000000000000000000,-0.8829789714450672066,0.00000000000000000000,1.08370584632762767540,1.00000000000000000000,-0.0009466077942127096,0.99999894310641879169,0.00110350338890192155,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.22367594657157496,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -99.0000000000000000000,0.00000000000000000000,-0.1474668622954377616,0.00000000000000000000,0.01008611097185791935,1.00000000000000000000,-0.0001595040788485187,0.99999998717797877745,0.00001422993553839629,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.42227818685091733,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -100.000000000000000000,0.00000000000000000000,-0.0603262639038006226,0.00000000000000000000,0.50446361388396299130,1.00000000000000000000,-0.0001142735496553844,0.99999986205541091521,0.00051267018153745326,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.19061035758807065,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -101.000000000000000000,0.00000000000000000000,-0.6156483108968969775,0.00000000000000000000,0.29316741609214919117,1.00000000000000000000,-0.0006988564399292118,0.99999971717958802130,0.00027792160833836051,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.677745486645335404,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -102.000000000000000000,0.00000000000000000000,1.32456890192451814947,0.00000000000000000000,0.55396745248067802425,1.00000000000000000000,0.00126896438936705056,0.99999906565380858314,0.00050835114686429512,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.568205460351350666,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -103.000000000000000000,0.00000000000000000000,-1.5396019109354142084,0.00000000000000000000,-0.1496533342816879219,1.00000000000000000000,-0.0013913073566147135,0.99999901943506508406,-0.0001593510202706875,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.690426933986827862,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -104.000000000000000000,0.00000000000000000000,0.54678213455293844802,0.00000000000000000000,0.48814011557159342480,1.00000000000000000000,0.00054721486465063133,0.99999970883487354633,0.00053187034154602620,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.530376631636499951,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -105.000000000000000000,0.00000000000000000000,-0.1152209066197300429,0.00000000000000000000,-2.0994739425787463105,1.00000000000000000000,-0.0001930662768033853,0.99999770360739914654,-0.0021343629824942780,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.22888984632925257,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -106.000000000000000000,0.00000000000000000000,-0.1491554478290753327,0.00000000000000000000,0.93244407003061569039,1.00000000000000000000,-0.0001083420673039859,0.99999955897269154903,0.00093290750811767626,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.503803976805897946,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -107.000000000000000000,0.00000000000000000000,-0.0173663832416336497,0.00000000000000000000,-0.3684789010119428609,1.00000000000000000000,-0.0000183363254805070,0.99999993789489916018,-0.0003519573512776842,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.25271401706584128,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -108.000000000000000000,0.00000000000000000000,0.93577121833889109758,0.00000000000000000000,-0.0286036256160615738,1.00000000000000000000,0.00093860170741715432,0.99999955874421075918,-0.0000392201299542482,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.27179856995644513,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -109.000000000000000000,0.00000000000000000000,0.34075089129921348751,0.00000000000000000000,1.21278330064369566088,1.00000000000000000000,0.00035171408412968600,0.99999929930217523743,0.00113035054813297500,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.829127380236513999,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -110.000000000000000000,0.00000000000000000000,0.10687739901674064846,0.00000000000000000000,-0.9044179142900955481,1.00000000000000000000,0.00013327452176803520,0.99999957375844339413,-0.0009136305780599550,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.948519383032817131,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -111.000000000000000000,0.00000000000000000000,-0.7002075067655183504,0.00000000000000000000,-0.2416104847479868533,1.00000000000000000000,-0.0006259573049297531,0.99999979097192037702,-0.0001619677993512259,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.47142645017459017,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -112.000000000000000000,0.00000000000000000000,-1.1085517044286259391,0.00000000000000000000,-2.8302387579938095285,1.00000000000000000000,-0.0011265952731726901,0.99999519829134009274,-0.0028868975308952811,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.36843200557939326,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -113.000000000000000000,0.00000000000000000000,-1.4321251743169440828,0.00000000000000000000,0.01482061266824478973,1.00000000000000000000,-0.0013883939739688824,0.99999903398097023110,0.00006632721506343647,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.06349115286229789,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -114.000000000000000000,0.00000000000000000000,-0.2472896183592099839,0.00000000000000000000,0.98737930139752494440,1.00000000000000000000,-0.0001758175652766191,0.99999952023114735411,0.00096365224998128465,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.10393703223837746,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -115.000000000000000000,0.00000000000000000000,1.51043377551021373861,0.00000000000000000000,-0.2169311989335328538,1.00000000000000000000,0.00150505175241432884,0.99999885743831984363,-0.0001412135882759790,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.574554451124186016,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -116.000000000000000000,0.00000000000000000000,-0.7607180071865433657,0.00000000000000000000,-0.3846649619431722344,1.00000000000000000000,-0.0008384697626784454,0.99999957672672279418,-0.0003788335151369918,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00780518040505739,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -117.000000000000000000,0.00000000000000000000,-1.6330979464376105259,0.00000000000000000000,1.65895347479569177373,1.00000000000000000000,-0.0015727734524358632,0.99999723777102833555,0.00174666367128369689,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.37388353762310089,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -118.000000000000000000,0.00000000000000000000,0.28702839616850633897,0.00000000000000000000,1.25521152545001424272,1.00000000000000000000,0.00032863511558845875,0.99999917872964327880,0.00123876511087269857,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.31894145141211538,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -119.000000000000000000,0.00000000000000000000,1.02367781838379978687,0.00000000000000000000,-0.2616809369357491754,1.00000000000000000000,0.00110238149033753721,0.99999934826311198676,-0.0002970326596745579,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.32833208015892978,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -120.000000000000000000,0.00000000000000000000,-2.0783712518146328918,0.00000000000000000000,2.06268688814147305166,1.00000000000000000000,-0.0020087605156341244,0.99999577992772692436,0.00209881107487270906,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.32721096252669212,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -121.000000000000000000,0.00000000000000000000,-0.4242820676737372176,0.00000000000000000000,0.62108500633306584770,1.00000000000000000000,-0.0003742399542581290,0.99999977032037457025,0.00056506960190200498,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.13595985044628378,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -122.000000000000000000,0.00000000000000000000,0.42516837882992075670,0.00000000000000000000,2.20498683036770959375,1.00000000000000000000,0.00028687047624722535,0.99999746828334334924,0.00223184502898915665,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.874631009157155858,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -123.000000000000000000,0.00000000000000000000,-0.6427675255254926556,0.00000000000000000000,-0.4715472174206579158,1.00000000000000000000,-0.0006236996913295527,0.99999964532632090730,-0.0005659911019849165,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.22347710537746934,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -124.000000000000000000,0.00000000000000000000,0.18036590550494269180,0.00000000000000000000,-0.1737701892963341432,1.00000000000000000000,0.00006130244453754971,0.99999999262121141985,-0.0001048789176421406,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.12953527676643261,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -125.000000000000000000,0.00000000000000000000,1.02164219992728022567,0.00000000000000000000,-1.5494571188910311043,1.00000000000000000000,0.00111194454540221462,0.99999819493095154498,-0.0015406862648384648,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.754333684966582040,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -126.000000000000000000,0.00000000000000000000,1.39900747398519786912,0.00000000000000000000,-1.0922357013441632567,1.00000000000000000000,0.00141957046160898063,0.99999838435642218748,-0.0011027711683089522,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.989938187644952449,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -127.000000000000000000,0.00000000000000000000,0.52627552313479031287,0.00000000000000000000,0.09224830652260498919,1.00000000000000000000,0.00057630421925416270,0.99999982573668388941,0.00012806267406872135,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.25770380205483434,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -128.000000000000000000,0.00000000000000000000,0.04966782196664951132,0.00000000000000000000,1.49040844754269219407,1.00000000000000000000,0.00021685630376955947,0.99999891433774201754,0.00145749671723349001,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.28963796892878690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -129.000000000000000000,0.00000000000000000000,-1.1874054217342067119,0.00000000000000000000,0.36820714322833242304,1.00000000000000000000,-0.0011703594787441187,0.99999923165688453519,0.00040858821713569173,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.821665888738380090,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -130.000000000000000000,0.00000000000000000000,-1.3153011062132182740,0.00000000000000000000,0.65224169109521834553,1.00000000000000000000,-0.0011913735163205996,0.99999907515505803701,0.00065598641242377352,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.914083651247779016,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -131.000000000000000000,0.00000000000000000000,-0.0578833854356642779,0.00000000000000000000,0.69642178075324800978,1.00000000000000000000,0.00003756605077242365,0.99999973322703716860,0.00072947559678418873,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.13718451861541325,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -132.000000000000000000,0.00000000000000000000,0.23655954399227602236,0.00000000000000000000,-1.6974229447520070568,1.00000000000000000000,0.00032999638911670694,0.99999851003467743471,-0.0016944116407554288,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.895714996468768731,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -133.000000000000000000,0.00000000000000000000,0.46140041453821345474,0.00000000000000000000,-1.6274262969414239332,1.00000000000000000000,0.00054473895926402369,0.99999863467842164954,-0.0015600963940617651,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.34068441906572388,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -134.000000000000000000,0.00000000000000000000,-0.3224463755724100155,0.00000000000000000000,-1.1188216529804291266,1.00000000000000000000,-0.0004365826953249883,0.99999926785035320175,-0.0011285806606543147,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.42049870709684000,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -135.000000000000000000,0.00000000000000000000,0.54948684184325191637,0.00000000000000000000,-0.1496011492484608518,1.00000000000000000000,0.00053717693976299441,0.99999983234382294750,-0.0002162250248606715,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.10231207825063393,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -136.000000000000000000,0.00000000000000000000,-0.0345708724237000081,0.00000000000000000000,-0.4522761606790505206,1.00000000000000000000,-0.0000753576101162860,0.99999992250516533953,-0.0003864076782100584,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.32918993294617848,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -137.000000000000000000,0.00000000000000000000,1.72592087793923498750,0.00000000000000000000,-0.2435202456849824836,1.00000000000000000000,0.00179417075950594564,0.99999837014781056687,-0.0002016259117035014,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.22165112177958690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -138.000000000000000000,0.00000000000000000000,-0.5760998064593531031,0.00000000000000000000,1.67032349258729517771,1.00000000000000000000,-0.0005523899245112957,0.99999847954164544638,0.00165401927701125427,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.993910075777989732,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -139.000000000000000000,0.00000000000000000000,-0.5122060777761603400,0.00000000000000000000,-1.7054535968306798743,1.00000000000000000000,-0.0005194447268289061,0.99999831733777166942,-0.0017594029672487699,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.920444309644494751,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -140.000000000000000000,0.00000000000000000000,-2.2998120460417958987,0.00000000000000000000,1.84475737879524737117,1.00000000000000000000,-0.0022388042909037716,0.99999566845220433375,0.00191071509547904232,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.16772799547175054,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -141.000000000000000000,0.00000000000000000000,0.87809365492342916770,0.00000000000000000000,-1.0874219316685163061,1.00000000000000000000,0.00087560637382764680,0.99999905092966778763,-0.0010636979090274795,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.691074331518620965,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -142.000000000000000000,0.00000000000000000000,1.17294337967185335891,0.00000000000000000000,-0.4060547722081593868,1.00000000000000000000,0.00113714893279738007,0.99999928650336000757,-0.0003659030960984761,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.02913732793024337,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -143.000000000000000000,0.00000000000000000000,0.80490734205957281677,0.00000000000000000000,-1.8632321568375183051,1.00000000000000000000,0.00079057540889227741,0.99999795121690926436,-0.0018634786037395746,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.537020924138346344,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -144.000000000000000000,0.00000000000000000000,1.01209888758879862358,0.00000000000000000000,0.08382509522847159111,1.00000000000000000000,0.00100519304958020618,0.99999948535237281888,0.00013741150855588654,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.43401861004849706,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -145.000000000000000000,0.00000000000000000000,0.87243440763819013472,0.00000000000000000000,-0.5105776814637036364,1.00000000000000000000,0.00086518587207238975,0.99999947553916579412,-0.0005480645946984032,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.705256997936885454,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -146.000000000000000000,0.00000000000000000000,-0.5303079211674113224,0.00000000000000000000,-0.9505139623341494203,1.00000000000000000000,-0.0005784653185793286,0.99999937861207410794,-0.0009529707974413657,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.835424063477603340,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -147.000000000000000000,0.00000000000000000000,1.09975504878559982024,0.00000000000000000000,0.26697717018781080833,1.00000000000000000000,0.00112839324811603064,0.99999932147887282685,0.00028943128983041329,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.684078868843698728,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -148.000000000000000000,0.00000000000000000000,-1.1075701713126493430,0.00000000000000000000,0.97623855959239469459,1.00000000000000000000,-0.0010504439730581712,0.99999891109537197841,0.00103652087768188981,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.753479253986824915,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -149.000000000000000000,0.00000000000000000000,-0.9590031313109312893,0.00000000000000000000,-0.1124766118144636950,1.00000000000000000000,-0.0009358249929737988,0.99999956042010273993,-0.0000582338713146863,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.956886697174468281,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -150.000000000000000000,0.00000000000000000000,0.86958353310342051400,0.00000000000000000000,0.50516188875780887457,1.00000000000000000000,0.00099211273074085743,0.99999937666461791163,0.00051223305761451034,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.872915206994093750,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -151.000000000000000000,0.00000000000000000000,0.72102636353709592675,0.00000000000000000000,0.38538567169104409604,1.00000000000000000000,0.00068912931584655520,0.99999967245431686801,0.00042449033566020169,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.966866443830326716,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -152.000000000000000000,0.00000000000000000000,0.73625883515161893999,0.00000000000000000000,-0.4949540857609284194,1.00000000000000000000,0.00073416782473513303,0.99999961600540332451,-0.0004785254966934466,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.25189495632014313,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -153.000000000000000000,0.00000000000000000000,-0.6263524085509930561,0.00000000000000000000,-1.1980117384462851681,1.00000000000000000000,-0.0006111498823232647,0.99999912995215689548,-0.0011690127246862180,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.624104083398606235,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -154.000000000000000000,0.00000000000000000000,-0.7510724184302914885,0.00000000000000000000,1.33685438994740724005,1.00000000000000000000,-0.0006520965043689225,0.99999886448021368945,0.00135860532607777494,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.37364728085321985,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -155.000000000000000000,0.00000000000000000000,-0.8941736353637003142,0.00000000000000000000,-0.8656612108649162085,1.00000000000000000000,-0.0007681781898507246,0.99999937842486230632,-0.0008081164258645607,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.778368872006012679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -156.000000000000000000,0.00000000000000000000,1.73592983449858406785,0.00000000000000000000,-0.6858358870394097861,1.00000000000000000000,0.00178640585047315329,0.99999817565765158899,-0.0006763397859771539,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.25002574165023361,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -157.000000000000000000,0.00000000000000000000,-0.2626041840059393228,0.00000000000000000000,0.29928702777356908093,1.00000000000000000000,-0.0002469378147658386,0.99999992647838642501,0.00029336826224570796,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.09922211357775267,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -158.000000000000000000,0.00000000000000000000,-0.3167609494714722084,0.00000000000000000000,0.06400787546781350201,1.00000000000000000000,-0.0004238190662400125,0.99999990948628469933,0.00003748094959009653,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.994201828187215141,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -159.000000000000000000,0.00000000000000000000,0.36908190689264908090,0.00000000000000000000,-0.1998650961692860772,1.00000000000000000000,0.00039747276604974192,0.99999989855923376858,-0.0002118889387020046,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.934968256595311686,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -160.000000000000000000,0.00000000000000000000,1.12668363282676353698,0.00000000000000000000,-0.8970225128427929961,1.00000000000000000000,0.00115819362913016556,0.99999891759187353734,-0.0009074153397321589,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.924793962925264168,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -161.000000000000000000,0.00000000000000000000,0.22483569004246750644,0.00000000000000000000,-0.8964250664117614508,1.00000000000000000000,0.00018459310523905755,0.99999957368396441559,-0.0009047415515184491,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.574857623563957531,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -162.000000000000000000,0.00000000000000000000,-0.1931323151243086455,0.00000000000000000000,0.20974211374092832649,1.00000000000000000000,-0.0001988089006670074,0.99999996015107972535,0.00020043168407771737,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.37537718399676123,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -163.000000000000000000,0.00000000000000000000,0.41790482346332769036,0.00000000000000000000,0.05513614526546858907,1.00000000000000000000,0.00040732352448121688,0.99999991325350301440,0.00008706625596953004,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.10108404947209237,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -164.000000000000000000,0.00000000000000000000,0.73944978209545098035,0.00000000000000000000,1.06189627253040508314,1.00000000000000000000,0.00072919568824619199,0.99999905439460978762,0.00116596892517173054,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.16744659094842972,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -165.000000000000000000,0.00000000000000000000,-1.0526156847951111394,0.00000000000000000000,-0.7371665148604780171,1.00000000000000000000,-0.0010759665801535641,0.99999918983897351232,-0.0006801597715372904,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.15385708332269132,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -166.000000000000000000,0.00000000000000000000,0.70764957455189481105,0.00000000000000000000,1.68917335263883572338,1.00000000000000000000,0.00059748215510562277,0.99999846753222509931,0.00164558447850564424,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.36067599774526115,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -167.000000000000000000,0.00000000000000000000,0.26268498720822108793,0.00000000000000000000,0.17351716657381893726,1.00000000000000000000,0.00017885175482876348,0.99999996783304079261,0.00017984984618626666,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.13763827427544583,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -168.000000000000000000,0.00000000000000000000,-1.7833910721284178535,0.00000000000000000000,0.23652686230887559615,1.00000000000000000000,-0.0018272706020346287,0.99999829341062396181,0.00027250318638620649,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.32367118070999367,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -169.000000000000000000,0.00000000000000000000,-0.3190867513532914534,0.00000000000000000000,0.27307757631366502693,1.00000000000000000000,-0.0003745147221899521,0.99999986512228344892,0.00035985293913503972,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.503260553494442319,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -170.000000000000000000,0.00000000000000000000,-1.8658197946872976391,0.00000000000000000000,0.24401852596303333364,1.00000000000000000000,-0.0017445823091439059,0.99999844145955307794,0.00027112917851608076,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.29165340176132303,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -171.000000000000000000,0.00000000000000000000,-0.7212577688069411463,0.00000000000000000000,0.83752651953835688392,1.00000000000000000000,-0.0006375530281022329,0.99999938134714172477,0.00091149957211580879,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.02855172478257372,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -172.000000000000000000,0.00000000000000000000,-1.3624272544388280614,0.00000000000000000000,1.22142138540378653033,1.00000000000000000000,-0.0013520803212153666,0.99999827820333075933,0.00127101108527204469,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.977331491938230101,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -173.000000000000000000,0.00000000000000000000,0.01353739544861685614,0.00000000000000000000,-0.4237527656726442493,1.00000000000000000000,0.00000678829595763770,0.99999988226791469703,-0.0004851990063404724,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.31818964149988460,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -174.000000000000000000,0.00000000000000000000,2.67371116717622214764,0.00000000000000000000,-0.3676033882395243201,1.00000000000000000000,0.00268683260780566875,0.99999630252966864585,-0.0004193537040725902,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.859697409074328788,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -175.000000000000000000,0.00000000000000000000,0.02459844599824614896,0.00000000000000000000,2.56731284750729882304,1.00000000000000000000,-0.0000423874168204936,0.99999675859848935477,0.00254578000255407553,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.844316951336281817,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -176.000000000000000000,0.00000000000000000000,-0.5689354848898595662,0.00000000000000000000,1.09642598622943476804,1.00000000000000000000,-0.0006055999232185845,0.99999917644128277771,0.00113153236326868291,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.48111341509763860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -177.000000000000000000,0.00000000000000000000,1.76961319770709546439,0.00000000000000000000,-0.7666202034943433440,1.00000000000000000000,0.00167744068256197339,0.99999832532722765510,-0.0007318029083495808,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.26349233504447511,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -178.000000000000000000,0.00000000000000000000,0.52580761212979276741,0.00000000000000000000,-1.2686540527361578334,1.00000000000000000000,0.00056778664841427033,0.99999902359403725071,-0.0012768826469575216,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.670756224570936865,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -179.000000000000000000,0.00000000000000000000,-0.2923529042405514921,0.00000000000000000000,1.94438582133221027348,1.00000000000000000000,-0.0001961528976255865,0.99999803388739905152,0.00197325755463025661,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.605629515649411587,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -180.000000000000000000,0.00000000000000000000,-0.3086215062055968627,0.00000000000000000000,0.72476563901371560127,1.00000000000000000000,-0.0003751187601797995,0.99999972014531290920,0.00064729839471593022,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.31884450879601899,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -181.000000000000000000,0.00000000000000000000,-0.8814667034052865446,0.00000000000000000000,-0.7648785614257627152,1.00000000000000000000,-0.0009075395184941109,0.99999930934989755826,-0.0007467742297933565,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.15887340612948719,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -182.000000000000000000,0.00000000000000000000,-0.6439925250011044877,0.00000000000000000000,-0.1678659957010294467,1.00000000000000000000,-0.0007092832525992437,0.99999972857972330153,-0.0001993934485842573,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.876122480299954986,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -183.000000000000000000,0.00000000000000000000,1.54655297447042738845,0.00000000000000000000,-0.1245570105420309020,1.00000000000000000000,0.00149341283062951434,0.99999887553856381394,-0.0001365273799193438,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.552670654085886781,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -184.000000000000000000,0.00000000000000000000,-1.3329193804921237731,0.00000000000000000000,-0.2286652937479626834,1.00000000000000000000,-0.0013018178875449034,0.99999911440162614351,-0.0002765251364048309,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.606333023123511338,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -185.000000000000000000,0.00000000000000000000,0.15000362360782232284,0.00000000000000000000,0.77853052941398070974,1.00000000000000000000,0.00032855782265182767,0.99999964030303556405,0.00078194856397054233,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.958725470908120769,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -186.000000000000000000,0.00000000000000000000,-0.7563893916945210182,0.00000000000000000000,-0.9405955851449695481,1.00000000000000000000,-0.0006776593335579426,0.99999934731498674178,-0.0009198627224375874,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.516250188631261153,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -187.000000000000000000,0.00000000000000000000,-1.0917483323401608874,0.00000000000000000000,-0.7719766219255629335,1.00000000000000000000,-0.0010494489394910616,0.99999911138906971697,-0.0008221179929434755,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.586589436784038298,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -188.000000000000000000,0.00000000000000000000,1.48797525363940508214,0.00000000000000000000,0.07771899093101181099,1.00000000000000000000,0.00139277864426614900,0.99999902361723780330,0.00011371991506157912,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.849555845486065663,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -189.000000000000000000,0.00000000000000000000,0.11976349854686918483,0.00000000000000000000,0.05112685162775232328,1.00000000000000000000,-0.0000046598493032417,0.99999999830713015569,0.00005800022031752912,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.599983046532656771,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -190.000000000000000000,0.00000000000000000000,-1.1327254351856947955,0.00000000000000000000,-0.2585808753439884921,1.00000000000000000000,-0.0010883746343630003,0.99999938298866075658,-0.0002224026824093203,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.32524593622986230,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -191.000000000000000000,0.00000000000000000000,0.32431671587864419059,0.00000000000000000000,-1.8718525438505440039,1.00000000000000000000,0.00031237875729571358,0.99999827567672594508,-0.0018305909119021180,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.45475913605855566,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -192.000000000000000000,0.00000000000000000000,-1.3331937119878278785,0.00000000000000000000,-0.7095084348704514543,1.00000000000000000000,-0.0014551620659826831,0.99999868591431750886,-0.0007146138818031683,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.25596530699226605,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -193.000000000000000000,0.00000000000000000000,-0.8899978158793553362,0.00000000000000000000,-1.0186073360776866092,1.00000000000000000000,-0.0009703997640205161,0.99999901646109012887,-0.0010126209311497776,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.20386202687450349,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -194.000000000000000000,0.00000000000000000000,-2.4944757955006613414,0.00000000000000000000,0.22830832438270431961,1.00000000000000000000,-0.0025514864183554890,0.99999672101590530992,0.00021880240996159563,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.770706137535967172,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -195.000000000000000000,0.00000000000000000000,0.62889122764706384405,0.00000000000000000000,-1.1154250979477626781,1.00000000000000000000,0.00057279140119570969,0.99999918947733468232,-0.0011370816524773541,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.44938507738390853,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -196.000000000000000000,0.00000000000000000000,-0.7489040295563595961,0.00000000000000000000,1.32717851469182956947,1.00000000000000000000,-0.0006798817059735764,0.99999885070319882718,0.00135512108206687644,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.39455149500849984,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -197.000000000000000000,0.00000000000000000000,0.53632557043256889883,0.00000000000000000000,-1.5151579779707224915,1.00000000000000000000,0.00055781382481424077,0.99999873901888780558,-0.0014868773894378588,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.06643372750829712,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -198.000000000000000000,0.00000000000000000000,-0.5202647065843338802,0.00000000000000000000,-0.7856201136795475381,1.00000000000000000000,-0.0005636253851618358,0.99999950588520825078,-0.0008188746940756027,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.22834908361619454,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -199.000000000000000000,0.00000000000000000000,-1.2096803958756046082,0.00000000000000000000,0.13276527669827409283,1.00000000000000000000,-0.0012594018072288333,0.99999920015856635924,0.00011657322022616087,100.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.36398150097716097,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +Ray-ID ,Event-ID ,X-position ,Y-position ,Z-position ,Event-type ,X-direction ,Y-direction ,Z-direction ,Energy ,ElectricField-x-real ,ElectricField-x-imag ,ElectricField-y-real ,ElectricField-y-imag ,ElectricField-z-real ,ElectricField-z-imag ,pathLength ,order ,lastElement ,lightSourceIndex +0.00000000000000000000,0.00000000000000000000,-1.7903320893902066046,0.00000000000000000000,0.83611441621380244715,1.00000000000000000000,-0.0018170116945435889,0.99999800383513115509,0.00083114033415540903,100.000000000000000000,0.99999834923174801826,0.00000000000000000000,0.00181701232213453390,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.770001767253575053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +1.00000000000000000000,0.00000000000000000000,-0.3830814019361608036,0.00000000000000000000,-0.7210972937484624312,1.00000000000000000000,-0.0004846383878598668,0.99999968473657607770,-0.0006290090472399334,100.000000000000000000,0.99999988256276306497,0.00000000000000000000,0.00048463848373406139,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.634138999235915434,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +2.00000000000000000000,0.00000000000000000000,2.01352449880240058632,0.00000000000000000000,-1.7615669936310247578,1.00000000000000000000,0.00184424753055840605,0.99999674983824460294,-0.0017604158580713192,100.000000000000000000,0.99999829936880668679,0.00000000000000000000,-0.0018442503882856067,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.670806455260503753,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +3.00000000000000000000,0.00000000000000000000,-1.6402858072429193914,0.00000000000000000000,-1.3292548960560024440,1.00000000000000000000,-0.0015517666731649575,0.99999797405508994430,-0.0012821489412684855,100.000000000000000000,0.99999879600739205454,0.00000000000000000000,0.00155176794864573088,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.977269462267940980,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +4.00000000000000000000,0.00000000000000000000,1.00357544087991645831,0.00000000000000000000,-0.0771343848143010990,1.00000000000000000000,0.00105544701572107303,0.99999943129483714887,-0.0001531064967828895,100.000000000000000000,0.99999944301563037374,0.00000000000000000000,-0.0010554470280917562,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.20842417606024810,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +5.00000000000000000000,0.00000000000000000000,1.54531010138667967979,0.00000000000000000000,0.94793746464542627538,1.00000000000000000000,0.00157859591959139274,0.99999825297050071171,0.00100104488861495156,100.000000000000000000,0.99999875401543647512,0.00000000000000000000,-0.0015785967105402655,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.987512571353363455,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +6.00000000000000000000,0.00000000000000000000,-0.2714569659798616307,0.00000000000000000000,-0.3745661476704158499,1.00000000000000000000,-0.0002438350236688279,0.99999992442576390860,-0.0003028084339632207,100.000000000000000000,0.99999997027223752610,0.00000000000000000000,0.00024383503484780481,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.43502401281421043,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +7.00000000000000000000,0.00000000000000000000,-0.5536757354308237122,0.00000000000000000000,0.01224841014304983710,1.00000000000000000000,-0.0005215916611252036,0.99999986276578778365,-0.0000490972964520432,100.000000000000000000,0.99999986397105999902,0.00000000000000000000,0.00052159166175386368,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.40246517247874180,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +8.00000000000000000000,0.00000000000000000000,0.57670663071799399546,0.00000000000000000000,0.36163962509956976143,1.00000000000000000000,0.00067911592935621448,0.99999971234439299916,0.00033780569231646619,100.000000000000000000,0.99999976940072443643,0.00000000000000000000,-0.0006791159681040891,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.46589926653450675,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +9.00000000000000000000,0.00000000000000000000,1.80399368221311484639,0.00000000000000000000,0.94654532698218507569,1.00000000000000000000,0.00180203948281240796,0.99999787531532768891,0.00100100875754007175,100.000000000000000000,0.99999837632390609076,0.00000000000000000000,-0.0018020403856515657,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.982056625634413649,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +10.0000000000000000000,0.00000000000000000000,-0.1354297711550078164,0.00000000000000000000,-0.4492112234203732290,1.00000000000000000000,-0.0001443446548242443,0.99999990043152697793,-0.0004222576897879662,100.000000000000000000,0.99999998958230840173,0.00000000000000000000,0.00014434466769268439,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.560600585650945504,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +11.0000000000000000000,0.00000000000000000000,0.82683613978170367175,0.00000000000000000000,-2.4950482565762244213,1.00000000000000000000,0.00083870667843186118,0.99999673287559565082,-0.0024147068646381644,100.000000000000000000,0.99999964828344101164,0.00000000000000000000,-0.0008387091236118801,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.30728526463701655,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +12.0000000000000000000,0.00000000000000000000,-1.2476277961299009344,0.00000000000000000000,-1.4638361817216085647,1.00000000000000000000,-0.0012465307828809888,0.99999824071519016754,-0.0014016873872770528,100.000000000000000000,0.99999922307867550319,0.00000000000000000000,0.00124653200742946769,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.673021199931099545,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +13.0000000000000000000,0.00000000000000000000,-0.1556663252481808590,0.00000000000000000000,-2.2897474866541167592,1.00000000000000000000,-0.0001440217948228577,0.99999741833300426208,-0.0022677268461958502,100.000000000000000000,0.99999998962880787267,0.00000000000000000000,0.00014402216514645046,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.700383910517530239,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +14.0000000000000000000,0.00000000000000000000,-0.2373469274248576899,0.00000000000000000000,-0.2213027829556896974,1.00000000000000000000,-0.0002003432061171753,0.99999995957007770108,-0.0002017980246750739,100.000000000000000000,0.99999997993129874362,0.00000000000000000000,0.00020034321019640776,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.49451832754061797,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +15.0000000000000000000,0.00000000000000000000,1.80047163078523708712,0.00000000000000000000,0.81178219094069570260,1.00000000000000000000,0.00178679960427859823,0.99999805581245349017,0.00083409740871731141,100.000000000000000000,0.99999840367120218509,0.00000000000000000000,-0.0017868002258336812,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.42790037368388311,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +16.0000000000000000000,0.00000000000000000000,-0.7254368893133744666,0.00000000000000000000,1.57920030017431933799,1.00000000000000000000,-0.0007460480046487706,0.99999841618198470616,0.00161587310664486403,100.000000000000000000,0.99999972170542206217,0.00000000000000000000,0.00074604897863346866,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.17068606389921114,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +17.0000000000000000000,0.00000000000000000000,-0.9572452276555470929,0.00000000000000000000,0.42670914588741787332,1.00000000000000000000,-0.0009082610451504131,0.99999948472287214507,0.00045344885496587187,100.000000000000000000,0.99999958753076712003,0.00000000000000000000,0.00090826113852686743,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.862957735426448380,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +18.0000000000000000000,0.00000000000000000000,0.10436128514304782166,0.00000000000000000000,-0.0753476891996055081,1.00000000000000000000,-0.0000274938995140157,0.99999999515509951919,-0.0000945192389796586,100.000000000000000000,0.99999999962204277892,0.00000000000000000000,0.00002749389963682944,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.739219800220439537,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +19.0000000000000000000,0.00000000000000000000,0.70517857792753046997,0.00000000000000000000,2.50462461091878996199,1.00000000000000000000,0.00063039141656364826,0.99999663722505505170,0.00251558049831528346,100.000000000000000000,0.99999980130205368134,0.00000000000000000000,-0.0006303934111773370,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.07582200902572822,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +20.0000000000000000000,0.00000000000000000000,0.41782372823360380831,0.00000000000000000000,0.35286249232938704523,1.00000000000000000000,0.00028216243403025653,0.99999988400039063751,0.00039036337680465498,100.000000000000000000,0.99999996019217352039,0.00000000000000000000,-0.0002821624555287179,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.18576003978080279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +21.0000000000000000000,0.00000000000000000000,-1.9269250036527880709,0.00000000000000000000,-1.6592921244966489791,1.00000000000000000000,-0.0018415400574254634,0.99999701156776654720,-0.0016079756692825868,100.000000000000000000,0.99999830435928649396,0.00000000000000000000,0.00184154243815994804,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.747436537930298072,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +22.0000000000000000000,0.00000000000000000000,0.71819057674736941354,0.00000000000000000000,0.24038868057686565982,1.00000000000000000000,0.00075330027603372098,0.99999969922941900346,0.00018460705761746973,100.000000000000000000,0.99999971626929717860,0.00000000000000000000,-0.0007533002888698697,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.570602993291004167,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +23.0000000000000000000,0.00000000000000000000,-0.5333944448865765020,0.00000000000000000000,-0.3491162148992121294,1.00000000000000000000,-0.0005004043916503004,0.99999981206357990703,-0.0003542149766876076,100.000000000000000000,0.99999987479769891773,0.00000000000000000000,0.00050040442304273504,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.31361793697294615,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +24.0000000000000000000,0.00000000000000000000,-1.0004845293630566516,0.00000000000000000000,0.27965548998261063884,1.00000000000000000000,-0.0010309023807825096,0.99999942621927151442,0.00029120681483637569,100.000000000000000000,0.99999946861995459013,0.00000000000000000000,0.00103090242449349980,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.18257041579738597,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +25.0000000000000000000,0.00000000000000000000,-1.0475245727238207127,0.00000000000000000000,-1.6252015690166470296,1.00000000000000000000,-0.0011327159901788927,0.99999806154309189842,-0.0016105479018686105,100.000000000000000000,0.99999935847537291255,0.00000000000000000000,0.00113271745923767337,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.641207178355102769,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +26.0000000000000000000,0.00000000000000000000,0.08293425913302393537,0.00000000000000000000,-0.0789550597434337947,1.00000000000000000000,0.00016840245556516079,0.99999998434163883676,-0.0000543813850827478,100.000000000000000000,0.99999998582030646954,0.00000000000000000000,-0.0001684024558141720,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.38015029476844119,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +27.0000000000000000000,0.00000000000000000000,0.01316612190347112368,0.00000000000000000000,-1.3483435538680108578,1.00000000000000000000,-0.0000058856042086105,0.99999914742349982343,-0.0013058015290100481,100.000000000000000000,0.99999999998267985468,0.00000000000000000000,0.00000588560922644068,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.797833446225013176,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +28.0000000000000000000,0.00000000000000000000,1.58501814641925853344,0.00000000000000000000,-0.9479911811010655053,1.00000000000000000000,0.00158465814080821975,0.99999831569309793888,-0.0009259965140188350,100.000000000000000000,0.99999874442742353597,0.00000000000000000000,-0.0015846588202067034,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00443581343915866,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +29.0000000000000000000,0.00000000000000000000,-0.9167279291628699366,0.00000000000000000000,-2.3441055475799839058,1.00000000000000000000,-0.0008991533767250880,0.99999675527913600703,-0.0023834752788065701,100.000000000000000000,0.99999959575922447996,0.00000000000000000000,0.00089915593076063827,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00056570218316664,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +30.0000000000000000000,0.00000000000000000000,-0.1797181128960924634,0.00000000000000000000,1.10350129359520043870,1.00000000000000000000,-0.0001607173333056111,0.99999934680408208986,0.00113161890575448165,100.000000000000000000,0.99999998708495274613,0.00000000000000000000,0.00016071743620991245,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.35575855989588944,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +31.0000000000000000000,0.00000000000000000000,0.16950431700712986771,0.00000000000000000000,-0.0523025034678316763,1.00000000000000000000,0.00026100702396103373,0.99999996245343492073,-0.0000834773157025421,100.000000000000000000,0.99999996593766593555,0.00000000000000000000,-0.0002610070248704425,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.738417921663312881,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +32.0000000000000000000,0.00000000000000000000,0.56553865649371481971,0.00000000000000000000,-0.4147385932787035489,1.00000000000000000000,0.00065596589530285322,0.99999968229942304276,-0.0004528904915224072,100.000000000000000000,0.99999978485430485175,0.00000000000000000000,-0.0006559659625753794,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.866787949154399939,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +33.0000000000000000000,0.00000000000000000000,-0.4485652701366859007,0.00000000000000000000,-1.6530440751237360785,1.00000000000000000000,-0.0004711956062625525,0.99999862127102201458,-0.0015923036003770889,100.000000000000000000,0.99999988898706271278,0.00000000000000000000,0.00047119620360560449,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.31486065666229023,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +34.0000000000000000000,0.00000000000000000000,0.78105532412396028174,0.00000000000000000000,0.97356690375945087456,1.00000000000000000000,0.00077040280388320642,0.99999920197999903059,0.00100125865035467363,100.000000000000000000,0.99999970323941844707,0.00000000000000000000,-0.0007704031900551767,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.988704958134462685,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +35.0000000000000000000,0.00000000000000000000,-0.7836334710378285439,0.00000000000000000000,-0.2168541122606920945,1.00000000000000000000,-0.0008966323682086169,0.99999958010453171564,-0.0001893176076927331,100.000000000000000000,0.99999959802510296480,0.00000000000000000000,0.00089663238427678797,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.11368459345328574,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +36.0000000000000000000,0.00000000000000000000,0.21225987736993515153,0.00000000000000000000,0.19207157739838520704,1.00000000000000000000,0.00022119708182556045,0.99999996092909781975,0.00017092002168079842,100.000000000000000000,0.99999997553592434584,0.00000000000000000000,-0.0002211970850565479,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.575345434728433247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +37.0000000000000000000,0.00000000000000000000,1.71124919276442999382,0.00000000000000000000,0.10190353922986196411,1.00000000000000000000,0.00168442302812935929,0.99999857842072448210,0.00007665241349480921,100.000000000000000000,0.99999858135851649176,0.00000000000000000000,-0.0016844230330778510,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.946220689356550792,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +38.0000000000000000000,0.00000000000000000000,-0.1269411358338377038,0.00000000000000000000,-0.3764478417177709590,1.00000000000000000000,-0.0002653531611246259,0.99999990028239815753,-0.0003591975689766601,100.000000000000000000,0.99999996479384478664,0.00000000000000000000,0.00026535317824294396,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.599681625954872288,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +39.0000000000000000000,0.00000000000000000000,0.50783166221466424783,0.00000000000000000000,0.42212588908461795567,1.00000000000000000000,0.00053697948549918331,0.99999977421173635860,0.00040401671790679649,100.000000000000000000,0.99999985582648198700,0.00000000000000000000,-0.0005369795293246373,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.603115444404807021,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +40.0000000000000000000,0.00000000000000000000,-0.8384072931463998346,0.00000000000000000000,0.30729520301197282838,1.00000000000000000000,-0.0008743664504504158,0.99999959233922897094,0.00022539894884708019,100.000000000000000000,0.99999961774156265192,0.00000000000000000000,0.00087436647266137315,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.33877908896715780,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +41.0000000000000000000,0.00000000000000000000,-0.7899393467840394311,0.00000000000000000000,0.76723135621776183956,1.00000000000000000000,-0.0006517192778375967,0.99999955112402438839,0.00068775993822289924,100.000000000000000000,0.99999978763086849742,0.00000000000000000000,0.00065171943197373557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.836947040311201817,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +42.0000000000000000000,0.00000000000000000000,0.74757061350202691496,0.00000000000000000000,-0.8084556387039878444,1.00000000000000000000,0.00081861611342077329,0.99999936382322474059,-0.0007760288684307970,100.000000000000000000,0.99999966493357150820,0.00000000000000000000,-0.0008186163599147118,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.848674824768181679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +43.0000000000000000000,0.00000000000000000000,-0.2139615585003428743,0.00000000000000000000,0.05992546375144839482,1.00000000000000000000,-0.0001038115510734464,0.99999999403314809853,0.00003401273033540993,100.000000000000000000,0.99999999461158095570,0.00000000000000000000,0.00010381155113349445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.753514558396091160,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +44.0000000000000000000,0.00000000000000000000,-0.0259617457223818223,0.00000000000000000000,0.88588997594541107893,1.00000000000000000000,-0.0000047276659541162,0.99999957076249468279,0.00092652710465491495,100.000000000000000000,0.99999999998882460605,0.00000000000000000000,0.00000472766798335581,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.40675464547962292,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +45.0000000000000000000,0.00000000000000000000,-0.9713664266712693784,0.00000000000000000000,-0.3879490312881589408,1.00000000000000000000,-0.0008790426328031954,0.99999953476546177277,-0.0003971812050399908,100.000000000000000000,0.99999961364188927337,0.00000000000000000000,0.00087904270213897024,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.10736756056348895,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +46.0000000000000000000,0.00000000000000000000,0.19852324774040028265,0.00000000000000000000,-0.8110501106401932780,1.00000000000000000000,0.00022445089431004437,0.99999966875307821911,-0.0007823781246552961,100.000000000000000000,0.99999997481088231943,0.00000000000000000000,-0.0002244509630050149,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.923427335494238832,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +47.0000000000000000000,0.00000000000000000000,1.80801825985799835549,0.00000000000000000000,-0.9585792106883930241,1.00000000000000000000,0.00185954213099227242,0.99999786532162326935,-0.0009008081146911684,100.000000000000000000,0.99999827104863403537,0.00000000000000000000,-0.0018595428854603530,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.47781973719145298,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +48.0000000000000000000,0.00000000000000000000,2.73967015752784348592,0.00000000000000000000,0.01792996819285708892,1.00000000000000000000,0.00276317660115505585,0.99999618221608632673,0.00002020699536371607,100.000000000000000000,0.99999618242024690406,0.00000000000000000000,-0.0027631766017191896,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.588951826112975140,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +49.0000000000000000000,0.00000000000000000000,0.48945419975328080530,0.00000000000000000000,-0.3193027228559737196,1.00000000000000000000,0.00050186940267031056,0.99999983756833754622,-0.0002701673572949503,100.000000000000000000,0.99999987406353407770,0.00000000000000000000,-0.0005018694209861359,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.533507536227716627,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +50.0000000000000000000,0.00000000000000000000,-1.3471564098272748033,0.00000000000000000000,1.52902220345003980739,1.00000000000000000000,-0.0013127657516968141,0.99999799902404773455,0.00150950123607214176,100.000000000000000000,0.99999913832070586039,0.00000000000000000000,0.00131276724732944083,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.650863602501658533,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +51.0000000000000000000,0.00000000000000000000,0.49558075392898187638,0.00000000000000000000,-0.9498188443236809108,1.00000000000000000000,0.00055118516153753534,0.99999938910645136402,-0.0009581135850559639,100.000000000000000000,0.99999984809730779744,0.00000000000000000000,-0.0005511854145266392,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.804580978439958016,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +52.0000000000000000000,0.00000000000000000000,-0.2557343463800159089,0.00000000000000000000,0.31839950798907895590,1.00000000000000000000,-0.0002251812763279580,0.99999992285248517909,0.00032185154431477777,100.000000000000000000,0.99999997464669343472,0.00000000000000000000,0.00022518128799104488,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.35999316167919914,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +53.0000000000000000000,0.00000000000000000000,-0.4216889763453134931,0.00000000000000000000,1.37431653696732136715,1.00000000000000000000,-0.0004510359085725458,0.99999898382415208786,0.00135237467899688513,100.000000000000000000,0.99999989828311353079,0.00000000000000000000,0.00045103632102679350,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.798531889923651760,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +54.0000000000000000000,0.00000000000000000000,1.12014432126193463901,0.00000000000000000000,-0.3721451184583186022,1.00000000000000000000,0.00115758704346757813,0.99999926107550762832,-0.0003712690067350706,100.000000000000000000,0.99999932999580143366,0.00000000000000000000,-0.0011575871232488762,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.633666333985502205,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +55.0000000000000000000,0.00000000000000000000,0.58869468921998990840,0.00000000000000000000,0.67958205016432982059,1.00000000000000000000,0.00064179749339880103,0.99999956928135802503,0.00067047227829122163,100.000000000000000000,0.99999979404787497916,0.00000000000000000000,-0.0006417976376534503,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.850466723834642834,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +56.0000000000000000000,0.00000000000000000000,-0.4688057571369460552,0.00000000000000000000,2.07249872204422835864,1.00000000000000000000,-0.0004924910138135828,0.99999785019827058807,0.00201421236181962290,100.000000000000000000,0.99999987872580120562,0.00000000000000000000,0.00049249201284731064,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.12656711912279661,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +57.0000000000000000000,0.00000000000000000000,0.57685328936845792213,0.00000000000000000000,-0.8103843964160919455,1.00000000000000000000,0.00065593180329993742,0.99999943357940734856,-0.0008382090037037597,100.000000000000000000,0.99999978487656049352,0.00000000000000000000,-0.0006559320337270430,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.957921762255182329,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +58.0000000000000000000,0.00000000000000000000,-0.9408871378345999847,0.00000000000000000000,1.48953737914822781363,1.00000000000000000000,-0.0009409181307578014,0.99999859065213336783,0.00139045561530202056,100.000000000000000000,0.99999955733558187898,0.00000000000000000000,0.00094091904032906671,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.678808335439953225,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +59.0000000000000000000,0.00000000000000000000,1.24764877075773483738,0.00000000000000000000,0.93451929437038605552,1.00000000000000000000,0.00121248222199622757,0.99999882487602531622,0.00093815426768459190,100.000000000000000000,0.99999926494251367703,0.00000000000000000000,-0.0012124827555696482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.28535443638509150,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +60.0000000000000000000,0.00000000000000000000,0.59171738784053651283,0.00000000000000000000,-0.6506155605881596137,1.00000000000000000000,0.00053756356162720818,0.99999966796120576262,-0.0006124564436113300,100.000000000000000000,0.99999985551264380934,0.00000000000000000000,-0.0005375636624480607,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.959696905628106833,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +61.0000000000000000000,0.00000000000000000000,-1.4635139042672067333,0.00000000000000000000,0.53470839520275903478,1.00000000000000000000,-0.0014773600400536099,0.99999876032190504471,0.00054475863018046814,100.000000000000000000,0.99999890870273677734,0.00000000000000000000,0.00147736025926579334,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.17828341964650462,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +62.0000000000000000000,0.00000000000000000000,-0.5422612966631934483,0.00000000000000000000,-0.2416637075114058119,1.00000000000000000000,-0.0005388840563157253,0.99999982574669943335,-0.0002410612880775294,100.000000000000000000,0.99999985480196784681,0.00000000000000000000,0.00053888407197314890,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.47482359306081889,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +63.0000000000000000000,0.00000000000000000000,0.08591421232759309523,0.00000000000000000000,1.85175436147774408190,1.00000000000000000000,0.00010673566705110033,0.99999837212744058234,0.00180120791867362283,100.000000000000000000,0.99999999430373021080,0.00000000000000000000,-0.0001067358401954505,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.32833408793237595,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +64.0000000000000000000,0.00000000000000000000,-0.2430691772559476770,0.00000000000000000000,1.04372760174422318790,1.00000000000000000000,-0.0003022533785151572,0.99999942339074887609,0.00103046643067751238,100.000000000000000000,0.99999995432139821005,0.00000000000000000000,0.00030225353899083221,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.840379145674319261,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +65.0000000000000000000,0.00000000000000000000,-1.5565802006859368322,0.00000000000000000000,-1.2989388232442971027,1.00000000000000000000,-0.0015288205757833291,0.99999803864949821097,-0.0012591285889789931,100.000000000000000000,0.99999883135128775357,0.00000000000000000000,0.00152882178768451253,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.890240389397604303,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +66.0000000000000000000,0.00000000000000000000,2.11153608544163828852,0.00000000000000000000,-1.7187514664914440576,1.00000000000000000000,0.00205980031063825955,0.99999636551241277704,-0.0017395932412820887,100.000000000000000000,0.99999787860267008721,0.00000000000000000000,-0.0020598034273133693,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.48924277406013061,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +67.0000000000000000000,0.00000000000000000000,0.11890747152019709442,0.00000000000000000000,-1.1921153847567598216,1.00000000000000000000,0.00018084119877233612,0.99999924610894896925,-0.0012145278895877474,100.000000000000000000,0.99999998364820619212,0.00000000000000000000,-0.0001808413321499200,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.797095875422201061,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +68.0000000000000000000,0.00000000000000000000,1.32265381648594892993,0.00000000000000000000,0.73352131742713910789,1.00000000000000000000,0.00129511654073349554,0.99999887170255563617,0.00076109576389209979,100.000000000000000000,0.99999916133573540921,0.00000000000000000000,-0.0012951169158426406,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.32792680095519699,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +69.0000000000000000000,0.00000000000000000000,0.94584093436695537704,0.00000000000000000000,-1.3666366437469541494,1.00000000000000000000,0.00088467575533312864,0.99999863586262849324,-0.0013948554369992089,100.000000000000000000,0.99999960867356618710,0.00000000000000000000,-0.0008846766159565537,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.45606075142950430,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +70.0000000000000000000,0.00000000000000000000,2.08453918437952667730,0.00000000000000000000,1.40035435615291636857,1.00000000000000000000,0.00216105894451558595,0.99999665363402368001,0.00142216208391018699,100.000000000000000000,0.99999766490467012491,0.00000000000000000000,-0.0021610611299383748,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.844652218518035624,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +71.0000000000000000000,0.00000000000000000000,-0.4069753088334398527,0.00000000000000000000,-0.0380850055988729840,1.00000000000000000000,-0.0004644513129295223,0.99999988603945466625,-0.0001104810191282935,100.000000000000000000,0.99999989214248186097,0.00000000000000000000,0.00046445131576408160,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.914338366897254672,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +72.0000000000000000000,0.00000000000000000000,-0.3242418849809126646,0.00000000000000000000,-0.4467221357914749613,1.00000000000000000000,-0.0002441435275330030,0.99999985848392802800,-0.0004726796610111265,100.000000000000000000,0.99999997019696196254,0.00000000000000000000,0.00024414355480702106,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.04188863744559512,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +73.0000000000000000000,0.00000000000000000000,0.54795736024740770986,0.00000000000000000000,0.26422237465476128281,1.00000000000000000000,0.00050976502655702613,0.99999983338664599763,0.00027086213819938235,100.000000000000000000,0.99999987006979085268,0.00000000000000000000,-0.0005097650452568135,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.594815903122480449,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +74.0000000000000000000,0.00000000000000000000,-1.3838907911750455426,0.00000000000000000000,0.56183783660451214192,1.00000000000000000000,-0.0012835147329476723,0.99999907422383726984,0.00045182009547032854,100.000000000000000000,0.99999917629445778111,0.00000000000000000000,0.00128351486395693889,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.40648319211265970,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +75.0000000000000000000,0.00000000000000000000,-1.6655895380302467856,0.00000000000000000000,0.03336220469314755965,1.00000000000000000000,-0.0015909603563935301,0.99999873349654355703,0.00004301689647944952,100.000000000000000000,0.99999873442176911986,0.00000000000000000000,0.00159096035786552929,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.47799516981478973,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +76.0000000000000000000,0.00000000000000000000,-0.7296919625333229131,0.00000000000000000000,-0.5155082677398085122,1.00000000000000000000,-0.0006826033172506007,0.99999964408114916381,-0.0004958732562483936,100.000000000000000000,0.99999976702627124680,0.00000000000000000000,0.00068260340117337874,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.871413030342637284,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +77.0000000000000000000,0.00000000000000000000,-0.5401182505938456612,0.00000000000000000000,0.62777631819664170276,1.00000000000000000000,-0.0005820398418553848,0.99999959371771773852,0.00068832697304810276,100.000000000000000000,0.99999983061471653389,0.00000000000000000000,0.00058203997973893268,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.32296687073653629,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +78.0000000000000000000,0.00000000000000000000,0.98397114436807842086,0.00000000000000000000,0.65933452354979937837,1.00000000000000000000,0.00098487746168404786,0.99999932140353031684,0.00062226109014273587,100.000000000000000000,0.99999951500788741842,0.00000000000000000000,-0.0009848776523607449,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.12866059580358069,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +79.0000000000000000000,0.00000000000000000000,0.03264102177293599915,0.00000000000000000000,0.04955095577989235278,1.00000000000000000000,0.00005542406252287200,0.99999999731375333045,0.00004796526416486207,100.000000000000000000,0.99999999846408671455,0.00000000000000000000,-0.0000554240625866281,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.07100866030236829,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +80.0000000000000000000,0.00000000000000000000,-0.5447107265508674966,0.00000000000000000000,0.45709242085101681185,1.00000000000000000000,-0.0004450758993624834,0.99999978824170221436,0.00047478836824383296,100.000000000000000000,0.99999990095369473142,0.00000000000000000000,0.00044507594952788548,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.994959381612488868,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +81.0000000000000000000,0.00000000000000000000,-1.3159830892265409474,0.00000000000000000000,-0.2038041873885136912,1.00000000000000000000,-0.0013400320074743615,0.99999906950201766786,-0.0002555568776573170,100.000000000000000000,0.99999910215664777890,0.00000000000000000000,0.00134003205123265191,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.49009330711089660,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +82.0000000000000000000,0.00000000000000000000,0.92426414986894955827,0.00000000000000000000,1.04744241302273843885,1.00000000000000000000,0.00083001729408805973,0.99999910049699525238,0.00105360167614902818,100.000000000000000000,0.99999965553520386851,0.00000000000000000000,-0.0008300177547797861,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.550291947709411033,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +83.0000000000000000000,0.00000000000000000000,0.78080121015752335100,0.00000000000000000000,-0.2568587679963586500,1.00000000000000000000,0.00071165003959696880,0.99999972541398995939,-0.0002067030863929171,100.000000000000000000,0.99999974677706782166,0.00000000000000000000,-0.0007116500548000081,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.17161008622281315,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +84.0000000000000000000,0.00000000000000000000,2.39842212411325306220,0.00000000000000000000,-1.1510856808509866144,1.00000000000000000000,0.00238875458607482700,0.99999646083072657454,-0.0011713998243742561,100.000000000000000000,0.99999714691777874531,0.00000000000000000000,-0.0023887562249742195,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.41233452966707773,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +85.0000000000000000000,0.00000000000000000000,2.09719206044459616222,0.00000000000000000000,0.39217859604741583945,1.00000000000000000000,0.00203118663636463192,0.99999785853469991270,0.00039649320596414730,100.000000000000000000,0.99999793713797202610,0.00000000000000000000,-0.0020311867960228898,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.614436455609165932,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +86.0000000000000000000,0.00000000000000000000,-2.0379453778828944265,0.00000000000000000000,-1.1142956025783143925,1.00000000000000000000,-0.0019895104228308596,0.99999738273157490198,-0.0011297691256858671,100.000000000000000000,0.99999802091965428463,0.00000000000000000000,0.00198951169251601828,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.884398906303204057,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +87.0000000000000000000,0.00000000000000000000,-2.2221363543113357152,0.00000000000000000000,-0.5772824515812883250,1.00000000000000000000,-0.0022322434790677000,0.99999738127717763269,-0.0005045075194250165,100.000000000000000000,0.99999750854078706119,0.00000000000000000000,0.00223224376315180614,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.680757830020866094,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +88.0000000000000000000,0.00000000000000000000,0.06899502188641938593,0.00000000000000000000,-1.0350850553824955113,1.00000000000000000000,0.00005380118861179269,0.99999946889319635268,-0.0010292321202283365,100.000000000000000000,0.99999999855271437532,0.00000000000000000000,-0.0000538012171081194,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.12626038095652347,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +89.0000000000000000000,0.00000000000000000000,-2.1951824614942032631,0.00000000000000000000,0.35745149730564490520,1.00000000000000000000,-0.0022136378953403314,0.99999748395405108070,0.00036317053236873645,100.000000000000000000,0.99999754990030942369,0.00000000000000000000,0.00221363804132183525,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.749137231243139467,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +90.0000000000000000000,0.00000000000000000000,-1.9540578361717375610,0.00000000000000000000,0.20224266990360872942,1.00000000000000000000,-0.0019206639383721631,0.99999813257152603274,0.00021425101281859413,100.000000000000000000,0.99999815552323212397,0.00000000000000000000,0.00192066398245475966,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.07764555992525856,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +91.0000000000000000000,0.00000000000000000000,0.22078146898190106894,0.00000000000000000000,0.03687690546975989913,1.00000000000000000000,0.00022256382620524053,0.99999996598913787337,0.00013596715162152224,100.000000000000000000,0.99999997523267081245,0.00000000000000000000,-0.0002225638282625166,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.03137336779730048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +92.0000000000000000000,0.00000000000000000000,-0.1654499813753515791,0.00000000000000000000,-0.0827465214174573776,1.00000000000000000000,-0.0002249006518194522,0.99999997139567797788,-0.0000814146187858942,100.000000000000000000,0.99999997470984791636,0.00000000000000000000,0.00022490065256481123,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.753983722919997489,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +93.0000000000000000000,0.00000000000000000000,-0.0021580378342530848,0.00000000000000000000,1.64854046404500431677,1.00000000000000000000,0.00008803766096529720,0.99999872537840994723,0.00159420542139942860,100.000000000000000000,0.99999999612467516119,0.00000000000000000000,-0.0000880377728389686,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.632675023579508888,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +94.0000000000000000000,0.00000000000000000000,1.19793906877164912927,0.00000000000000000000,-0.4718622440529978145,1.00000000000000000000,0.00100629528758512860,0.99999938679445010691,-0.0004623640534316621,100.000000000000000000,0.99999949368466056753,0.00000000000000000000,-0.0010062953951483096,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.45745356998725128,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +95.0000000000000000000,0.00000000000000000000,0.57871398906186477528,0.00000000000000000000,-0.2238900879201876914,1.00000000000000000000,0.00057199701723625027,0.99999981172631613457,-0.0002221862834076512,100.000000000000000000,0.99999983640968459486,0.00000000000000000000,-0.0005719970313550660,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.946333983765271113,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +96.0000000000000000000,0.00000000000000000000,-0.7612365363911161031,0.00000000000000000000,0.30659328003550390118,1.00000000000000000000,-0.0007741508019879976,0.99999965042342686682,0.00031598031540485419,100.000000000000000000,0.99999970034519303219,0.00000000000000000000,0.00077415084063498645,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.04580852814763147,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +97.0000000000000000000,0.00000000000000000000,-0.3825729369826243453,0.00000000000000000000,-0.2124654565857720389,1.00000000000000000000,-0.0003800887565084805,0.99999988333783051963,-0.0002980886823312195,100.000000000000000000,0.99999992776625956647,0.00000000000000000000,0.00038008877339522887,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.21915350266056066,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +98.0000000000000000000,0.00000000000000000000,-0.8829789714450672066,0.00000000000000000000,1.08370584632762767540,1.00000000000000000000,-0.0009466077942127096,0.99999894310641879169,0.00110350338890192155,100.000000000000000000,0.99999955196619605413,0.00000000000000000000,0.00094660837056472944,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.22367594657157496,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +99.0000000000000000000,0.00000000000000000000,-0.1474668622954377616,0.00000000000000000000,0.01008611097185791935,1.00000000000000000000,-0.0001595040788485187,0.99999998717797877745,0.00001422993553839629,100.000000000000000000,0.99999998727922445596,0.00000000000000000000,0.00015950407886466781,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.42227818685091733,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +100.000000000000000000,0.00000000000000000000,-0.0603262639038006226,0.00000000000000000000,0.50446361388396299130,1.00000000000000000000,-0.0001142735496553844,0.99999986205541091521,0.00051267018153745326,100.000000000000000000,0.99999999347077628275,0.00000000000000000000,0.00011427356467268681,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.19061035758807065,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +101.000000000000000000,0.00000000000000000000,-0.6156483108968969775,0.00000000000000000000,0.29316741609214919117,1.00000000000000000000,-0.0006988564399292118,0.99999971717958802130,0.00027792160833836051,100.000000000000000000,0.99999975579978950257,0.00000000000000000000,0.00069885646691919599,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.677745486645335404,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +102.000000000000000000,0.00000000000000000000,1.32456890192451814947,0.00000000000000000000,0.55396745248067802425,1.00000000000000000000,0.00126896438936705056,0.99999906565380858314,0.00050835114686429512,100.000000000000000000,0.99999919486415711489,0.00000000000000000000,-0.0012689645533305346,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.568205460351350666,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +103.000000000000000000,0.00000000000000000000,-1.5396019109354142084,0.00000000000000000000,-0.1496533342816879219,1.00000000000000000000,-0.0013913073566147135,0.99999901943506508406,-0.0001593510202706875,100.000000000000000000,0.99999903213142682378,0.00000000000000000000,0.00139130737427927233,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.690426933986827862,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +104.000000000000000000,0.00000000000000000000,0.54678213455293844802,0.00000000000000000000,0.48814011557159342480,1.00000000000000000000,0.00054721486465063133,0.99999970883487354633,0.00053187034154602620,100.000000000000000000,0.99999985027789251024,0.00000000000000000000,-0.0005472149420503763,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.530376631636499951,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +105.000000000000000000,0.00000000000000000000,-0.1152209066197300429,0.00000000000000000000,-2.0994739425787463105,1.00000000000000000000,-0.0001930662768033853,0.99999770360739914654,-0.0021343629824942780,100.000000000000000000,0.99999998136262124859,0.00000000000000000000,0.00019306671656211540,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.22888984632925257,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +106.000000000000000000,0.00000000000000000000,-0.1491554478290753327,0.00000000000000000000,0.93244407003061569039,1.00000000000000000000,-0.0001083420673039859,0.99999955897269154903,0.00093290750811767626,100.000000000000000000,0.99999999413099305289,0.00000000000000000000,0.00010834211444995674,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.503803976805897946,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +107.000000000000000000,0.00000000000000000000,-0.0173663832416336497,0.00000000000000000000,-0.3684789010119428609,1.00000000000000000000,-0.0000183363254805070,0.99999993789489916018,-0.0003519573512776842,100.000000000000000000,0.99999999983188947449,0.00000000000000000000,0.00001833632661620396,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.25271401706584128,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +108.000000000000000000,0.00000000000000000000,0.93577121833889109758,0.00000000000000000000,-0.0286036256160615738,1.00000000000000000000,0.00093860170741715432,0.99999955874421075918,-0.0000392201299542482,100.000000000000000000,0.99999955951331986891,0.00000000000000000000,-0.0009386017081390417,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.27179856995644513,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +109.000000000000000000,0.00000000000000000000,0.34075089129921348751,0.00000000000000000000,1.21278330064369566088,1.00000000000000000000,0.00035171408412968600,0.99999929930217523743,0.00113035054813297500,100.000000000000000000,0.99999993814852061735,0.00000000000000000000,-0.0003517143088211007,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.829127380236513999,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +110.000000000000000000,0.00000000000000000000,0.10687739901674064846,0.00000000000000000000,-0.9044179142900955481,1.00000000000000000000,0.00013327452176803520,0.99999957375844339413,-0.0009136305780599550,100.000000000000000000,0.99999999111894355419,0.00000000000000000000,-0.0001332745773915799,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.948519383032817131,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +111.000000000000000000,0.00000000000000000000,-0.7002075067655183504,0.00000000000000000000,-0.2416104847479868533,1.00000000000000000000,-0.0006259573049297531,0.99999979097192037702,-0.0001619677993512259,100.000000000000000000,0.99999980408870170478,0.00000000000000000000,0.00062595731314029994,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.47142645017459017,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +112.000000000000000000,0.00000000000000000000,-1.1085517044286259391,0.00000000000000000000,-2.8302387579938095285,1.00000000000000000000,-0.0011265952731726901,0.99999519829134009274,-0.0028868975308952811,100.000000000000000000,0.99999936538605482816,0.00000000000000000000,0.00112659996782444086,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.36843200557939326,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +113.000000000000000000,0.00000000000000000000,-1.4321251743169440828,0.00000000000000000000,0.01482061266824478973,1.00000000000000000000,-0.0013883939739688824,0.99999903398097023110,0.00006632721506343647,100.000000000000000000,0.99999903618061791732,0.00000000000000000000,0.00138839397702286292,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.06349115286229789,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +114.000000000000000000,0.00000000000000000000,-0.2472896183592099839,0.00000000000000000000,0.98737930139752494440,1.00000000000000000000,-0.0001758175652766191,0.99999952023114735411,0.00096365224998128465,100.000000000000000000,0.99999998454407745818,0.00000000000000000000,0.00017581764691102720,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.10393703223837746,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +115.000000000000000000,0.00000000000000000000,1.51043377551021373861,0.00000000000000000000,-0.2169311989335328538,1.00000000000000000000,0.00150505175241432884,0.99999885743831984363,-0.0001412135882759790,100.000000000000000000,0.99999886740894716741,0.00000000000000000000,-0.0015050517674206561,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.574554451124186016,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +116.000000000000000000,0.00000000000000000000,-0.7607180071865433657,0.00000000000000000000,-0.3846649619431722344,1.00000000000000000000,-0.0008384697626784454,0.99999957672672279418,-0.0003788335151369918,100.000000000000000000,0.99999964848411615481,0.00000000000000000000,0.00083846982284487556,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.00780518040505739,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +117.000000000000000000,0.00000000000000000000,-1.6330979464376105259,0.00000000000000000000,1.65895347479569177373,1.00000000000000000000,-0.0015727734524358632,0.99999723777102833555,0.00174666367128369689,100.000000000000000000,0.99999876318729541413,0.00000000000000000000,0.00157277585157669891,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.37388353762310089,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +118.000000000000000000,0.00000000000000000000,0.28702839616850633897,0.00000000000000000000,1.25521152545001424272,1.00000000000000000000,0.00032863511558845875,0.99999917872964327880,0.00123876511087269857,100.000000000000000000,0.99999994599939612260,0.00000000000000000000,-0.0003286353677404497,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.31894145141211538,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +119.000000000000000000,0.00000000000000000000,1.02367781838379978687,0.00000000000000000000,-0.2616809369357491754,1.00000000000000000000,0.00110238149033753721,0.99999934826311198676,-0.0002970326596745579,100.000000000000000000,0.99999939237728663332,0.00000000000000000000,-0.0011023815389682185,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.32833208015892978,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +120.000000000000000000,0.00000000000000000000,-2.0783712518146328918,0.00000000000000000000,2.06268688814147305166,1.00000000000000000000,-0.0020087605156341244,0.99999577992772692436,0.00209881107487270906,100.000000000000000000,0.99999798242967263828,0.00000000000000000000,0.00200876493995173939,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.32721096252669212,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +121.000000000000000000,0.00000000000000000000,-0.4242820676737372176,0.00000000000000000000,0.62108500633306584770,1.00000000000000000000,-0.0003742399542581290,0.99999977032037457025,0.00056506960190200498,100.000000000000000000,0.99999992997220343848,0.00000000000000000000,0.00037424001400623586,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.13595985044628378,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +122.000000000000000000,0.00000000000000000000,0.42516837882992075670,0.00000000000000000000,2.20498683036770959375,1.00000000000000000000,0.00028687047624722535,0.99999746828334334924,0.00223184502898915665,100.000000000000000000,0.99999995885245918092,0.00000000000000000000,-0.0002868711907197825,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.874631009157155858,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +123.000000000000000000,0.00000000000000000000,-0.6427675255254926556,0.00000000000000000000,-0.4715472174206579158,1.00000000000000000000,-0.0006236996913295527,0.99999964532632090730,-0.0005659911019849165,100.000000000000000000,0.99999980549926625883,0.00000000000000000000,0.00062369979122940482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.22347710537746934,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +124.000000000000000000,0.00000000000000000000,0.18036590550494269180,0.00000000000000000000,-0.1737701892963341432,1.00000000000000000000,0.00006130244453754971,0.99999999262121141985,-0.0001048789176421406,100.000000000000000000,0.99999999812100515139,0.00000000000000000000,-0.0000613024448747005,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.12953527676643261,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +125.000000000000000000,0.00000000000000000000,1.02164219992728022567,0.00000000000000000000,-1.5494571188910311043,1.00000000000000000000,0.00111194454540221462,0.99999819493095154498,-0.0015406862648384648,100.000000000000000000,0.99999938178800540367,0.00000000000000000000,-0.0011119458651238239,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.754333684966582040,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +126.000000000000000000,0.00000000000000000000,1.39900747398519786912,0.00000000000000000000,-1.0922357013441632567,1.00000000000000000000,0.00141957046160898063,0.99999838435642218748,-0.0011027711683089522,100.000000000000000000,0.99999899240811929157,0.00000000000000000000,-0.0014195713247826037,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.989938187644952449,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +127.000000000000000000,0.00000000000000000000,0.52627552313479031287,0.00000000000000000000,0.09224830652260498919,1.00000000000000000000,0.00057630421925416270,0.99999982573668388941,0.00012806267406872135,100.000000000000000000,0.99999983393670688336,0.00000000000000000000,-0.0005763042239798713,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.25770380205483434,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +128.000000000000000000,0.00000000000000000000,0.04966782196664951132,0.00000000000000000000,1.49040844754269219407,1.00000000000000000000,0.00021685630376955947,0.99999891433774201754,0.00145749671723349001,100.000000000000000000,0.99999997648662142246,0.00000000000000000000,-0.0002168565341034895,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.28963796892878690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +129.000000000000000000,0.00000000000000000000,-1.1874054217342067119,0.00000000000000000000,0.36820714322833242304,1.00000000000000000000,-0.0011703594787441187,0.99999923165688453519,0.00040858821713569173,100.000000000000000000,0.99999931512899642438,0.00000000000000000000,0.00117035957643657115,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.821665888738380090,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +130.000000000000000000,0.00000000000000000000,-1.3153011062132182740,0.00000000000000000000,0.65224169109521834553,1.00000000000000000000,-0.0011913735163205996,0.99999907515505803701,0.00065598641242377352,100.000000000000000000,0.99999929031401513235,0.00000000000000000000,0.00119137377265551998,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.914083651247779016,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +131.000000000000000000,0.00000000000000000000,-0.0578833854356642779,0.00000000000000000000,0.69642178075324800978,1.00000000000000000000,0.00003756605077242365,0.99999973322703716860,0.00072947559678418873,100.000000000000000000,0.99999999929439564727,0.00000000000000000000,-0.0000375660607675262,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.13718451861541325,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +132.000000000000000000,0.00000000000000000000,0.23655954399227602236,0.00000000000000000000,-1.6974229447520070568,1.00000000000000000000,0.00032999638911670694,0.99999851003467743471,-0.0016944116407554288,100.000000000000000000,0.99999994555103377535,0.00000000000000000000,-0.0003299968628326268,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.895714996468768731,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +133.000000000000000000,0.00000000000000000000,0.46140041453821345474,0.00000000000000000000,-1.6274262969414239332,1.00000000000000000000,0.00054473895926402369,0.99999863467842164954,-0.0015600963940617651,100.000000000000000000,0.99999985162936100291,0.00000000000000000000,-0.0005447396221855170,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.34068441906572388,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +134.000000000000000000,0.00000000000000000000,-0.3224463755724100155,0.00000000000000000000,-1.1188216529804291266,1.00000000000000000000,-0.0004365826953249883,0.99999926785035320175,-0.0011285806606543147,100.000000000000000000,0.99999990469764921119,0.00000000000000000000,0.00043658297336170094,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.42049870709684000,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +135.000000000000000000,0.00000000000000000000,0.54948684184325191637,0.00000000000000000000,-0.1496011492484608518,1.00000000000000000000,0.00053717693976299441,0.99999983234382294750,-0.0002162250248606715,100.000000000000000000,0.99999985572045058113,0.00000000000000000000,-0.0005371769523203818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.10231207825063393,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +136.000000000000000000,0.00000000000000000000,-0.0345708724237000081,0.00000000000000000000,-0.4522761606790505206,1.00000000000000000000,-0.0000753576101162860,0.99999992250516533953,-0.0003864076782100584,100.000000000000000000,0.99999999716061493959,0.00000000000000000000,0.00007535761574214270,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.32918993294617848,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +137.000000000000000000,0.00000000000000000000,1.72592087793923498750,0.00000000000000000000,-0.2435202456849824836,1.00000000000000000000,0.00179417075950594564,0.99999837014781056687,-0.0002016259117035014,100.000000000000000000,0.99999839047428218385,0.00000000000000000000,-0.0017941707959751660,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.22165112177958690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +138.000000000000000000,0.00000000000000000000,-0.5760998064593531031,0.00000000000000000000,1.67032349258729517771,1.00000000000000000000,-0.0005523899245112957,0.99999847954164544638,0.00165401927701125427,100.000000000000000000,0.99999984743225656114,0.00000000000000000000,0.00055239068012143599,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.993910075777989732,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +139.000000000000000000,0.00000000000000000000,-0.5122060777761603400,0.00000000000000000000,-1.7054535968306798743,1.00000000000000000000,-0.0005194447268289061,0.99999831733777166942,-0.0017594029672487699,100.000000000000000000,0.99999986508816129937,0.00000000000000000000,0.00051944553080103734,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.920444309644494751,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +140.000000000000000000,0.00000000000000000000,-2.2998120460417958987,0.00000000000000000000,1.84475737879524737117,1.00000000000000000000,-0.0022388042909037716,0.99999566845220433375,0.00191071509547904232,100.000000000000000000,0.99999749386538372419,0.00000000000000000000,0.00223880837766433221,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.16772799547175054,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +141.000000000000000000,0.00000000000000000000,0.87809365492342916770,0.00000000000000000000,-1.0874219316685163061,1.00000000000000000000,0.00087560637382764680,0.99999905092966778763,-0.0010636979090274795,100.000000000000000000,0.99999961665623182671,0.00000000000000000000,-0.0008756068691819022,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.691074331518620965,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +142.000000000000000000,0.00000000000000000000,1.17294337967185335891,0.00000000000000000000,-0.4060547722081593868,1.00000000000000000000,0.00113714893279738007,0.99999928650336000757,-0.0003659030960984761,100.000000000000000000,0.99999935344585688667,0.00000000000000000000,-0.0011371490089210232,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.02913732793024337,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +143.000000000000000000,0.00000000000000000000,0.80490734205957281677,0.00000000000000000000,-1.8632321568375183051,1.00000000000000000000,0.00079057540889227741,0.99999795121690926436,-0.0018634786037395746,100.000000000000000000,0.99999968749412737611,0.00000000000000000000,-0.0007905767815531613,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.537020924138346344,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +144.000000000000000000,0.00000000000000000000,1.01209888758879862358,0.00000000000000000000,0.08382509522847159111,1.00000000000000000000,0.00100519304958020618,0.99999948535237281888,0.00013741150855588654,100.000000000000000000,0.99999949479332927992,0.00000000000000000000,-0.0010051930590701948,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.43401861004849706,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +145.000000000000000000,0.00000000000000000000,0.87243440763819013472,0.00000000000000000000,-0.5105776814637036364,1.00000000000000000000,0.00086518587207238975,0.99999947553916579412,-0.0005480645946984032,100.000000000000000000,0.99999962572652090209,0.00000000000000000000,-0.0008651860020124356,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.705256997936885454,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +146.000000000000000000,0.00000000000000000000,-0.5303079211674113224,0.00000000000000000000,-0.9505139623341494203,1.00000000000000000000,-0.0005784653185793286,0.99999937861207410794,-0.0009529707974413657,100.000000000000000000,0.99999983268877179476,0.00000000000000000000,0.00057846558124711338,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.835424063477603340,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +147.000000000000000000,0.00000000000000000000,1.09975504878559982024,0.00000000000000000000,0.26697717018781080833,1.00000000000000000000,0.00112839324811603064,0.99999932147887282685,0.00028943128983041329,100.000000000000000000,0.99999936336408279391,0.00000000000000000000,-0.0011283932953790507,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.684078868843698728,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +148.000000000000000000,0.00000000000000000000,-1.1075701713126493430,0.00000000000000000000,0.97623855959239469459,1.00000000000000000000,-0.0010504439730581712,0.99999891109537197841,0.00103652087768188981,100.000000000000000000,0.99999944828298470422,0.00000000000000000000,0.00105044453734427583,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.753479253986824915,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +149.000000000000000000,0.00000000000000000000,-0.9590031313109312893,0.00000000000000000000,-0.1124766118144636950,1.00000000000000000000,-0.0009358249929737988,0.99999956042010273993,-0.0000582338713146863,100.000000000000000000,0.99999956211569407393,0.00000000000000000000,0.00093582499456057628,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.956886697174468281,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +150.000000000000000000,0.00000000000000000000,0.86958353310342051400,0.00000000000000000000,0.50516188875780887457,1.00000000000000000000,0.00099211273074085743,0.99999937666461791163,0.00051223305761451034,100.000000000000000000,0.99999950785591451563,0.00000000000000000000,-0.0009921128608974942,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.872915206994093750,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +151.000000000000000000,0.00000000000000000000,0.72102636353709592675,0.00000000000000000000,0.38538567169104409604,1.00000000000000000000,0.00068912931584655520,0.99999967245431686801,0.00042449033566020169,100.000000000000000000,0.99999976255032219096,0.00000000000000000000,-0.0006891293779343740,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.966866443830326716,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +152.000000000000000000,0.00000000000000000000,0.73625883515161893999,0.00000000000000000000,-0.4949540857609284194,1.00000000000000000000,0.00073416782473513303,0.99999961600540332451,-0.0004785254966934466,100.000000000000000000,0.99999973049870460872,0.00000000000000000000,-0.0007341679087924632,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.25189495632014313,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +153.000000000000000000,0.00000000000000000000,-0.6263524085509930561,0.00000000000000000000,-1.1980117384462851681,1.00000000000000000000,-0.0006111498823232647,0.99999912995215689548,-0.0011690127246862180,100.000000000000000000,0.99999981324763809187,0.00000000000000000000,0.00061115029991958100,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.624104083398606235,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +154.000000000000000000,0.00000000000000000000,-0.7510724184302914885,0.00000000000000000000,1.33685438994740724005,1.00000000000000000000,-0.0006520965043689225,0.99999886448021368945,0.00135860532607777494,100.000000000000000000,0.99999978738465933325,0.00000000000000000000,0.00065209710619236872,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.37364728085321985,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +155.000000000000000000,0.00000000000000000000,-0.8941736353637003142,0.00000000000000000000,-0.8656612108649162085,1.00000000000000000000,-0.0007681781898507246,0.99999937842486230632,-0.0008081164258645607,100.000000000000000000,0.99999970495089807176,0.00000000000000000000,0.00076817844068105968,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.778368872006012679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +156.000000000000000000,0.00000000000000000000,1.73592983449858406785,0.00000000000000000000,-0.6858358870394097861,1.00000000000000000000,0.00178640585047315329,0.99999817565765158899,-0.0006763397859771539,100.000000000000000000,0.99999840437506593016,0.00000000000000000000,-0.0017864062590560256,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.25002574165023361,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +157.000000000000000000,0.00000000000000000000,-0.2626041840059393228,0.00000000000000000000,0.29928702777356908093,1.00000000000000000000,-0.0002469378147658386,0.99999992647838642501,0.00029336826224570796,100.000000000000000000,0.99999996951085468044,0.00000000000000000000,0.00024693782539218311,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.09922211357775267,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +158.000000000000000000,0.00000000000000000000,-0.3167609494714722084,0.00000000000000000000,0.06400787546781350201,1.00000000000000000000,-0.0004238190662400125,0.99999990948628469933,0.00003748094959009653,100.000000000000000000,0.99999991018869538450,0.00000000000000000000,0.00042381906653770766,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.994201828187215141,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +159.000000000000000000,0.00000000000000000000,0.36908190689264908090,0.00000000000000000000,-0.1998650961692860772,1.00000000000000000000,0.00039747276604974192,0.99999989855923376858,-0.0002118889387020046,100.000000000000000000,0.99999992100769341529,0.00000000000000000000,-0.0003974727749723942,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.934968256595311686,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +160.000000000000000000,0.00000000000000000000,1.12668363282676353698,0.00000000000000000000,-0.8970225128427929961,1.00000000000000000000,0.00115819362913016556,0.99999891759187353734,-0.0009074153397321589,100.000000000000000000,0.99999932929298140926,0.00000000000000000000,-0.0011581941059602819,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.924793962925264168,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +161.000000000000000000,0.00000000000000000000,0.22483569004246750644,0.00000000000000000000,-0.8964250664117614508,1.00000000000000000000,0.00018459310523905755,0.99999957368396441559,-0.0009047415515184491,100.000000000000000000,0.99999998296267866848,0.00000000000000000000,-0.0001845931807891185,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.574857623563957531,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +162.000000000000000000,0.00000000000000000000,-0.1931323151243086455,0.00000000000000000000,0.20974211374092832649,1.00000000000000000000,-0.0001988089006670074,0.99999996015107972535,0.00020043168407771737,100.000000000000000000,0.99999998023750946707,0.00000000000000000000,0.00019880890466036861,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.37537718399676123,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +163.000000000000000000,0.00000000000000000000,0.41790482346332769036,0.00000000000000000000,0.05513614526546858907,1.00000000000000000000,0.00040732352448121688,0.99999991325350301440,0.00008706625596953004,100.000000000000000000,0.99999991704376922641,0.00000000000000000000,-0.0004073235260250816,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.10108404947209237,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +164.000000000000000000,0.00000000000000000000,0.73944978209545098035,0.00000000000000000000,1.06189627253040508314,1.00000000000000000000,0.00072919568824619199,0.99999905439460978762,0.00116596892517173054,100.000000000000000000,0.99999973413642728736,0.00000000000000000000,-0.0007291961839114631,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.16744659094842972,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +165.000000000000000000,0.00000000000000000000,-1.0526156847951111394,0.00000000000000000000,-0.7371665148604780171,1.00000000000000000000,-0.0010759665801535641,0.99999918983897351232,-0.0006801597715372904,100.000000000000000000,0.99999942114752382593,0.00000000000000000000,0.00107596682903403568,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.15385708332269132,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +166.000000000000000000,0.00000000000000000000,0.70764957455189481105,0.00000000000000000000,1.68917335263883572338,1.00000000000000000000,0.00059748215510562277,0.99999846753222509931,0.00164558447850564424,100.000000000000000000,0.99999982150703792260,0.00000000000000000000,-0.0005974829640826515,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.36067599774526115,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +167.000000000000000000,0.00000000000000000000,0.26268498720822108793,0.00000000000000000000,0.17351716657381893726,1.00000000000000000000,0.00017885175482876348,0.99999996783304079261,0.00017984984618626666,100.000000000000000000,0.99999998400602430059,0.00000000000000000000,-0.0001788517577213300,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.13763827427544583,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +168.000000000000000000,0.00000000000000000000,-1.7833910721284178535,0.00000000000000000000,0.23652686230887559615,1.00000000000000000000,-0.0018272706020346287,0.99999829341062396181,0.00027250318638620649,100.000000000000000000,0.99999833053955600181,0.00000000000000000000,0.00182727066987935053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.32367118070999367,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +169.000000000000000000,0.00000000000000000000,-0.3190867513532914534,0.00000000000000000000,0.27307757631366502693,1.00000000000000000000,-0.0003745147221899521,0.99999986512228344892,0.00035985293913503972,100.000000000000000000,0.99999992986934971295,0.00000000000000000000,0.00037451474643868494,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.503260553494442319,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +170.000000000000000000,0.00000000000000000000,-1.8658197946872976391,0.00000000000000000000,0.24401852596303333364,1.00000000000000000000,-0.0017445823091439059,0.99999844145955307794,0.00027112917851608076,100.000000000000000000,0.99999847821501353095,0.00000000000000000000,0.00174458237326693206,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.29165340176132303,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +171.000000000000000000,0.00000000000000000000,-0.7212577688069411463,0.00000000000000000000,0.83752651953835688392,1.00000000000000000000,-0.0006375530281022329,0.99999938134714172477,0.00091149957211580879,100.000000000000000000,0.99999979676287875651,0.00000000000000000000,0.00063755329295195784,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.02855172478257372,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +172.000000000000000000,0.00000000000000000000,-1.3624272544388280614,0.00000000000000000000,1.22142138540378653033,1.00000000000000000000,-0.0013520803212153666,0.99999827820333075933,0.00127101108527204469,100.000000000000000000,0.99999908593750796992,0.00000000000000000000,0.00135208141333873280,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.977331491938230101,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +173.000000000000000000,0.00000000000000000000,0.01353739544861685614,0.00000000000000000000,-0.4237527656726442493,1.00000000000000000000,0.00000678829595763770,0.99999988226791469703,-0.0004851990063404724,100.000000000000000000,0.99999999997695954156,0.00000000000000000000,-0.0000067882967566816,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.31818964149988460,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +174.000000000000000000,0.00000000000000000000,2.67371116717622214764,0.00000000000000000000,-0.3676033882395243201,1.00000000000000000000,0.00268683260780566875,0.99999630252966864585,-0.0004193537040725902,100.000000000000000000,0.99999639045811961057,0.00000000000000000000,-0.0026868328440555712,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.859697409074328788,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +175.000000000000000000,0.00000000000000000000,0.02459844599824614896,0.00000000000000000000,2.56731284750729882304,1.00000000000000000000,-0.0000423874168204936,0.99999675859848935477,0.00254578000255407553,100.000000000000000000,0.99999999910164760752,0.00000000000000000000,0.00004238755417749698,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.844316951336281817,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +176.000000000000000000,0.00000000000000000000,-0.5689354848898595662,0.00000000000000000000,1.09642598622943476804,1.00000000000000000000,-0.0006055999232185845,0.99999917644128277771,0.00113153236326868291,100.000000000000000000,0.99999981662411496774,0.00000000000000000000,0.00060560031091357784,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.48111341509763860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +177.000000000000000000,0.00000000000000000000,1.76961319770709546439,0.00000000000000000000,-0.7666202034943433440,1.00000000000000000000,0.00167744068256197339,0.99999832532722765510,-0.0007318029083495808,100.000000000000000000,0.99999859309463512424,0.00000000000000000000,-0.0016774411317266684,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.26349233504447511,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +178.000000000000000000,0.00000000000000000000,0.52580761212979276741,0.00000000000000000000,-1.2686540527361578334,1.00000000000000000000,0.00056778664841427033,0.99999902359403725071,-0.0012768826469575216,100.000000000000000000,0.99999983880888509979,0.00000000000000000000,-0.0005677871112828284,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.670756224570936865,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +179.000000000000000000,0.00000000000000000000,-0.2923529042405514921,0.00000000000000000000,1.94438582133221027348,1.00000000000000000000,-0.0001961528976255865,0.99999803388739905152,0.00197325755463025661,100.000000000000000000,0.99999998076194529517,0.00000000000000000000,0.00019615327951142097,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.605629515649411587,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +180.000000000000000000,0.00000000000000000000,-0.3086215062055968627,0.00000000000000000000,0.72476563901371560127,1.00000000000000000000,-0.0003751187601797995,0.99999972014531290920,0.00064729839471593022,100.000000000000000000,0.99999992964292594432,0.00000000000000000000,0.00037511883876630643,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.31884450879601899,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +181.000000000000000000,0.00000000000000000000,-0.8814667034052865446,0.00000000000000000000,-0.7648785614257627152,1.00000000000000000000,-0.0009075395184941109,0.99999930934989755826,-0.0007467742297933565,100.000000000000000000,0.99999958818569678609,0.00000000000000000000,0.00090753977154879280,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.15887340612948719,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +182.000000000000000000,0.00000000000000000000,-0.6439925250011044877,0.00000000000000000000,-0.1678659957010294467,1.00000000000000000000,-0.0007092832525992437,0.99999972857972330153,-0.0001993934485842573,100.000000000000000000,0.99999974845859196381,0.00000000000000000000,0.00070928326669899622,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.876122480299954986,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +183.000000000000000000,0.00000000000000000000,1.54655297447042738845,0.00000000000000000000,-0.1245570105420309020,1.00000000000000000000,0.00149341283062951434,0.99999887553856381394,-0.0001365273799193438,100.000000000000000000,0.99999888485841603724,0.00000000000000000000,-0.0014934128445479167,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.552670654085886781,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +184.000000000000000000,0.00000000000000000000,-1.3329193804921237731,0.00000000000000000000,-0.2286652937479626834,1.00000000000000000000,-0.0013018178875449034,0.99999911440162614351,-0.0002765251364048309,100.000000000000000000,0.99999915263467009651,0.00000000000000000000,0.00130181793731740818,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.606333023123511338,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +185.000000000000000000,0.00000000000000000000,0.15000362360782232284,0.00000000000000000000,0.77853052941398070974,1.00000000000000000000,0.00032855782265182767,0.99999964030303556405,0.00078194856397054233,100.000000000000000000,0.99999994602484409966,0.00000000000000000000,-0.0003285579230991555,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.958725470908120769,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +186.000000000000000000,0.00000000000000000000,-0.7563893916945210182,0.00000000000000000000,-0.9405955851449695481,1.00000000000000000000,-0.0006776593335579426,0.99999934731498674178,-0.0009198627224375874,100.000000000000000000,0.99999977038869314327,0.00000000000000000000,0.00067765962025797567,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.516250188631261153,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +187.000000000000000000,0.00000000000000000000,-1.0917483323401608874,0.00000000000000000000,-0.7719766219255629335,1.00000000000000000000,-0.0010494489394910616,0.99999911138906971697,-0.0008221179929434755,100.000000000000000000,0.99999944932793782825,0.00000000000000000000,0.00104944929414096358,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.586589436784038298,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +188.000000000000000000,0.00000000000000000000,1.48797525363940508214,0.00000000000000000000,0.07771899093101181099,1.00000000000000000000,0.00139277864426614900,0.99999902361723780330,0.00011371991506157912,100.000000000000000000,0.99999903008334112275,0.00000000000000000000,-0.0013927786532720084,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.849555845486065663,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +189.000000000000000000,0.00000000000000000000,0.11976349854686918483,0.00000000000000000000,0.05112685162775232328,1.00000000000000000000,-0.0000046598493032417,0.99999999830713015569,0.00005800022031752912,100.000000000000000000,0.99999999998914290699,0.00000000000000000000,0.00000465984931107966,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.599983046532656771,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +190.000000000000000000,0.00000000000000000000,-1.1327254351856947955,0.00000000000000000000,-0.2585808753439884921,1.00000000000000000000,-0.0010883746343630003,0.99999938298866075658,-0.0002224026824093203,100.000000000000000000,0.99999940772012307910,0.00000000000000000000,0.00108837466128011315,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.32524593622986230,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +191.000000000000000000,0.00000000000000000000,0.32431671587864419059,0.00000000000000000000,-1.8718525438505440039,1.00000000000000000000,0.00031237875729571358,0.99999827567672594508,-0.0018305909119021180,100.000000000000000000,0.99999995120959117578,0.00000000000000000000,-0.0003123792806974903,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.45475913605855566,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +192.000000000000000000,0.00000000000000000000,-1.3331937119878278785,0.00000000000000000000,-0.7095084348704514543,1.00000000000000000000,-0.0014551620659826831,0.99999868591431750886,-0.0007146138818031683,100.000000000000000000,0.99999894125057986471,0.00000000000000000000,0.00145516243753881450,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.25596530699226605,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +193.000000000000000000,0.00000000000000000000,-0.8899978158793553362,0.00000000000000000000,-1.0186073360776866092,1.00000000000000000000,-0.0009703997640205161,0.99999901646109012887,-0.0010126209311497776,100.000000000000000000,0.99999952916155532278,0.00000000000000000000,0.00097040026154541591,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.20386202687450349,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +194.000000000000000000,0.00000000000000000000,-2.4944757955006613414,0.00000000000000000000,0.22830832438270431961,1.00000000000000000000,-0.0025514864183554890,0.99999672101590530992,0.00021880240996159563,100.000000000000000000,0.99999674495307500077,0.00000000000000000000,0.00255148647943105252,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,999.770706137535967172,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +195.000000000000000000,0.00000000000000000000,0.62889122764706384405,0.00000000000000000000,-1.1154250979477626781,1.00000000000000000000,0.00057279140119570969,0.99999918947733468232,-0.0011370816524773541,100.000000000000000000,0.99999983595477981435,0.00000000000000000000,-0.0005727917714927314,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.44938507738390853,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +196.000000000000000000,0.00000000000000000000,-0.7489040295563595961,0.00000000000000000000,1.32717851469182956947,1.00000000000000000000,-0.0006798817059735764,0.99999885070319882718,0.00135512108206687644,100.000000000000000000,0.99999976887998176522,0.00000000000000000000,0.00067988233022589147,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.39455149500849984,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +197.000000000000000000,0.00000000000000000000,0.53632557043256889883,0.00000000000000000000,-1.5151579779707224915,1.00000000000000000000,0.00055781382481424077,0.99999873901888780558,-0.0014868773894378588,100.000000000000000000,0.99999984442151246266,0.00000000000000000000,-0.0005578144414238843,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.06643372750829712,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +198.000000000000000000,0.00000000000000000000,-0.5202647065843338802,0.00000000000000000000,-0.7856201136795475381,1.00000000000000000000,-0.0005636253851618358,0.99999950588520825078,-0.0008188746940756027,100.000000000000000000,0.99999984116309348358,0.00000000000000000000,0.00056362557413305641,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.22834908361619454,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +199.000000000000000000,0.00000000000000000000,-1.2096803958756046082,0.00000000000000000000,0.13276527669827409283,1.00000000000000000000,-0.0012594018072288333,0.99999920015856635924,0.00011657322022616087,100.000000000000000000,0.99999920695321886654,0.00000000000000000000,0.00125940181578603773,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,1000.36398150097716097,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 diff --git a/Intern/rayx-core/tests/input/slit1_seeded.correct.csv b/Intern/rayx-core/tests/input/slit1_seeded.correct.csv index dcefd030..a890944b 100644 --- a/Intern/rayx-core/tests/input/slit1_seeded.correct.csv +++ b/Intern/rayx-core/tests/input/slit1_seeded.correct.csv @@ -1,217 +1,217 @@ -Ray-ID ,Event-ID ,X-position ,Y-position ,Z-position ,Event-type ,X-direction ,Y-direction ,Z-direction ,Energy ,Stokes0 ,Stokes1 ,Stokes2 ,Stokes3 ,pathLength ,order ,lastElement ,lightSourceIndex -0.00000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -1.00000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -2.00000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -3.00000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -4.00000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -5.00000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -6.00000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -7.00000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -8.00000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -9.00000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -10.0000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -11.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -12.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -13.0000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -14.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -15.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -16.0000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -17.0000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -18.0000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -19.0000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -20.0000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -21.0000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -22.0000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -23.0000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -24.0000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -25.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -26.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -27.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -28.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -29.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -30.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,3.46153880718027107121,3.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -31.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,3.46153872525035710694,3.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -32.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -33.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -34.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -35.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -36.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -37.0000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -38.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,3.46153872525035710694,3.00000000000000000000,0.00026923074984827827,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -39.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,3.46153880718027107121,3.00000000000000000000,0.00034615381850250414,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -40.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -41.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -42.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -43.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -44.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,2.69230791865803187334,3.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -45.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,2.69230785493476654224,3.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -46.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,2.69230780714231876515,3.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -47.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,2.69230777528068809800,3.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -48.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,2.69230775934987276443,3.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -49.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,2.69230775934987276443,3.00000000000000000000,0.00003846153705810951,0.99999996301775162521,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -50.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,2.69230777528068809800,3.00000000000000000000,0.00011538461094674560,0.99999995710059208509,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -51.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,2.69230780714231876515,3.00000000000000000000,0.00019230768415263250,0.99999994526627311586,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -52.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,2.69230785493476654224,3.00000000000000000000,0.00026923075622060400,0.99999992751479460650,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -53.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,2.69230791865803187334,3.00000000000000000000,0.00034615382669549426,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -54.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -55.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -56.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -57.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -58.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -59.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.92307701648081041945,3.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -60.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.92307698234334822906,3.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -61.0000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,1.92307695958504076827,3.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -62.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -63.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -64.0000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,1.92307695958504076827,3.00000000000000000000,0.00011538461299499319,0.99999997485207114955,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -65.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.92307698234334822906,3.00000000000000000000,0.00019230768756637849,0.99999996301775195828,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -66.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.92307701648081041945,3.00000000000000000000,0.00026923076099984833,0.99999994526627311586,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -67.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -68.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -69.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -70.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -71.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -72.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -73.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.15384620078516308971,3.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -74.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.15384618030268581989,3.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -75.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,1.15384616664770156546,1.00000000000000000000,-0.0001154820839442817,0.99999998678627821657,0.00011441735651760849,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -75.0000000000000000000,1.00000000000000000000,-1.2693282444370028727,0.00000000000000000000,1.26826352467718916905,1.00000000000000000000,-0.0001154820839442817,0.99999998678627821657,0.00011441735651760849,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001463498174416,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -76.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.15384615982020943825,1.00000000000000000000,-0.0000385585513015160,0.99999999269039097082,0.00011459692936946305,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -76.0000000000000000000,1.00000000000000000000,-0.4231739363884007287,0.00000000000000000000,1.26844309002733135471,1.00000000000000000000,-0.0000385585513015160,0.99999999269039097082,0.00011459692936946305,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000812741072877,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -77.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.15384615982020943825,1.00000000000000000000,0.00003843007481959632,0.99999999261514416204,0.00011529458190969960,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -77.0000000000000000000,1.00000000000000000000,0.42304545990843372971,0.00000000000000000000,1.26914074258134301764,1.00000000000000000000,0.00003843007481959632,0.99999999261514416204,0.00011529458190969960,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813493534224,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -78.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,1.15384616664770156546,1.00000000000000000000,0.00011522184566996068,0.99999998676565182709,0.00011485914141359134,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -78.0000000000000000000,1.00000000000000000000,1.26906800616161974382,0.00000000000000000000,1.26870530958137894828,1.00000000000000000000,0.00011522184566996068,0.99999998676565182709,0.00011485914141359134,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001463704447814,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -79.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.15384618030268581989,3.00000000000000000000,0.00019230768984220914,0.99999997485207114955,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -80.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.15384620078516308971,3.00000000000000000000,0.00026923076418601120,0.99999995710059208509,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -81.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -82.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -83.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -84.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -85.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -86.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -87.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,0.38461539874450018094,3.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -88.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -89.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,0.38461538736534633953,1.00000000000000000000,-0.0001168699164631558,0.99999999244822623811,0.00003801275939874131,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -89.0000000000000000000,1.00000000000000000000,-1.2707160763125038283,0.00000000000000000000,0.42262814705115137048,1.00000000000000000000,-0.0001168699164631558,0.99999999244822623811,0.00003801275939874131,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000815162711660,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -90.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,0.38461538508951564896,1.00000000000000000000,-0.0000383759249363439,0.99999999852311294290,0.00003848457415010861,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -90.0000000000000000000,1.00000000000000000000,-0.4229913097980576575,0.00000000000000000000,0.42309995929646160295,1.00000000000000000000,-0.0000383759249363439,0.99999999852311294290,0.00003848457415010861,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162697870109,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -91.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,0.38461538508951564896,1.00000000000000000000,0.00003830273338425239,0.99999999852728460592,0.00003844907402729350,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -91.0000000000000000000,1.00000000000000000000,0.42291811824569824906,0.00000000000000000000,0.42306445917343371565,1.00000000000000000000,0.00003830273338425239,0.99999999852728460592,0.00003844907402729350,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162656160682,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -92.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,0.38461538736534633953,1.00000000000000000000,0.00011582080801016253,0.99999999254360794065,0.00003870819350675153,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -92.0000000000000000000,1.00000000000000000000,1.26966696784054100533,0.00000000000000000000,0.42332358116072132947,1.00000000000000000000,0.00011582080801016253,0.99999999254360794065,0.00003870819350675153,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000814208906376,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -93.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -94.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,0.38461539874450018094,3.00000000000000000000,0.00026923076577909266,0.99999996301775162521,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -95.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -96.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -97.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -98.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -99.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -100.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -101.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-0.3846153987445001809,3.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -102.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -103.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-0.3846153873653463395,1.00000000000000000000,-0.0001156486083869762,0.99999999256154425975,-0.0000387596489163242,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -103.000000000000000000,1.00000000000000000000,-1.2694947682139963163,0.00000000000000000000,-0.4233750365699825435,1.00000000000000000000,-0.0001156486083869762,0.99999999256154425975,-0.0000387596489163242,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000814029535831,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -104.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-0.3846153850895156489,1.00000000000000000000,-0.0000387536781003866,0.99999999851625498425,-0.0000382837075978769,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -104.000000000000000000,1.00000000000000000000,-0.4233690629629240365,0.00000000000000000000,-0.4228990927441957925,1.00000000000000000000,-0.0000387536781003866,0.99999999851625498425,-0.0000382837075978769,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162766446010,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -105.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-0.3846153850895156489,1.00000000000000000000,0.00003819513621387518,0.99999999852483334450,-0.0000386194839379165,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -105.000000000000000000,1.00000000000000000000,0.42281052107525618488,0.00000000000000000000,-0.4232348690844023320,1.00000000000000000000,0.00003819513621387518,0.99999999852483334450,-0.0000386194839379165,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162680662469,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -106.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-0.3846153873653463395,1.00000000000000000000,0.00011539990873768394,0.99999999260423078073,-0.0000383979065070109,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -106.000000000000000000,1.00000000000000000000,1.26924606855792809767,0.00000000000000000000,-0.4230132941563393145,1.00000000000000000000,0.00011539990873768394,0.99999999260423078073,-0.0000383979065070109,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813602673588,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -107.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -108.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-0.3846153987445001809,3.00000000000000000000,0.00026923076577909266,0.99999996301775162521,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -109.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -110.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -111.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -112.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -113.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -114.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -115.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.1538462007851630897,3.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -116.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.1538461803026858198,3.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -117.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-1.1538461666477015654,1.00000000000000000000,-0.0001157093021605022,0.99999998663611833205,-0.0001154951082520170,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -117.000000000000000000,1.00000000000000000000,-1.2695554626736005321,0.00000000000000000000,-1.2693412764431817318,1.00000000000000000000,-0.0001157093021605022,0.99999998663611833205,-0.0001154951082520170,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001464999786549,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -118.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.1538461598202094382,1.00000000000000000000,-0.0000392836977971758,0.99999999256924299029,-0.0001154049609900742,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -118.000000000000000000,1.00000000000000000000,-0.4238990828941202604,0.00000000000000000000,-1.2692511216678299401,1.00000000000000000000,-0.0000392836977971758,0.99999999256924299029,-0.0001154049609900742,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813952556200,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -119.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.1538461598202094382,1.00000000000000000000,0.00003613869813290306,0.99999999272441997266,-0.0001150875940239208,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -119.000000000000000000,1.00000000000000000000,0.42075408320086987723,0.00000000000000000000,-1.2689337546814591917,1.00000000000000000000,0.00003613869813290306,0.99999999272441997266,-0.0001150875940239208,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000812400776339,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -120.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-1.1538461666477015654,1.00000000000000000000,0.00011582333048881175,0.99999998666739209340,-0.0001151093898864466,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -120.000000000000000000,1.00000000000000000000,1.26966949099981185611,0.00000000000000000000,-1.2689555580688567371,1.00000000000000000000,0.00011582333048881175,0.99999998666739209340,-0.0001151093898864466,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001464687047700,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -121.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.1538461803026858198,3.00000000000000000000,0.00019230768984220914,0.99999997485207114955,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -122.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.1538462007851630897,3.00000000000000000000,0.00026923076418601120,0.99999995710059208509,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -123.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -124.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -125.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -126.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -127.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -128.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -129.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.9230770164808110855,3.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -130.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.9230769823433486731,3.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -131.000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,-1.9230769595850412123,3.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -132.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -133.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -134.000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,-1.9230769595850412123,3.00000000000000000000,0.00011538461299499319,0.99999997485207114955,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -135.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.9230769823433486731,3.00000000000000000000,0.00019230768756637849,0.99999996301775195828,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -136.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.9230770164808110855,3.00000000000000000000,0.00026923076099984833,0.99999994526627311586,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -137.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -138.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -139.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -140.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -141.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -142.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-2.6923079186580318733,3.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -143.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-2.6923078549347665422,3.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -144.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-2.6923078071423187651,3.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -145.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-2.6923077752806880980,3.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -146.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-2.6923077593498727644,3.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -147.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-2.6923077593498727644,3.00000000000000000000,0.00003846153705810951,0.99999996301775162521,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -148.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-2.6923077752806880980,3.00000000000000000000,0.00011538461094674560,0.99999995710059208509,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -149.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-2.6923078071423187651,3.00000000000000000000,0.00019230768415263250,0.99999994526627311586,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -150.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-2.6923078549347665422,3.00000000000000000000,0.00026923075622060400,0.99999992751479460650,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -151.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-2.6923079186580318733,3.00000000000000000000,0.00034615382669549426,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -152.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -153.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -154.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -155.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -156.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-3.4615388071802710712,3.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -157.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-3.4615387252503571069,3.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -158.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -159.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -160.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -161.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -162.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -163.000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -164.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-3.4615387252503571069,3.00000000000000000000,0.00026923074984827827,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -165.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-3.4615388071802710712,3.00000000000000000000,0.00034615381850250414,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -166.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -167.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -168.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -169.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -170.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -171.000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -172.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -173.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -174.000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -175.000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -176.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -177.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -178.000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -179.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -180.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -181.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -182.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -183.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -184.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -185.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -186.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -187.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -188.000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -189.000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -190.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -191.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -192.000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -193.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -194.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -195.000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -196.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -197.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -198.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -199.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +Ray-ID ,Event-ID ,X-position ,Y-position ,Z-position ,Event-type ,X-direction ,Y-direction ,Z-direction ,Energy ,ElectricField-x-real ,ElectricField-x-imag ,ElectricField-y-real ,ElectricField-y-imag ,ElectricField-z-real ,ElectricField-z-imag ,pathLength ,order ,lastElement ,lightSourceIndex +0.00000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +1.00000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +2.00000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +3.00000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +4.00000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +5.00000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +6.00000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +7.00000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +8.00000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +9.00000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +10.0000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +11.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +12.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +13.0000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +14.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +15.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +16.0000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +17.0000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +18.0000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +19.0000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +20.0000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +21.0000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +22.0000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +23.0000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +24.0000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +25.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +26.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +27.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +28.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +29.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +30.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,3.46153880718027107121,3.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +31.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,3.46153872525035710694,3.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822780,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +32.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +33.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +34.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +35.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +36.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +37.0000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +38.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,3.46153872525035710694,3.00000000000000000000,0.00026923074984827827,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +39.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,3.46153880718027107121,3.00000000000000000000,0.00034615381850250414,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +40.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +41.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +42.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +43.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +44.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,2.69230791865803187334,3.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +45.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,2.69230785493476654224,3.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,0.00026923076597822786,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +46.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,2.69230780714231876515,3.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,0.00026923076597822786,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +47.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,2.69230777528068809800,3.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,0.00026923076597822786,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +48.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,2.69230775934987276443,3.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,0.00026923076597822786,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +49.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,2.69230775934987276443,3.00000000000000000000,0.00003846153705810951,0.99999996301775162521,0.00026923076597822786,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +50.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,2.69230777528068809800,3.00000000000000000000,0.00011538461094674560,0.99999995710059208509,0.00026923076597822786,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +51.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,2.69230780714231876515,3.00000000000000000000,0.00019230768415263250,0.99999994526627311586,0.00026923076597822786,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +52.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,2.69230785493476654224,3.00000000000000000000,0.00026923075622060400,0.99999992751479460650,0.00026923076597822786,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +53.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,2.69230791865803187334,3.00000000000000000000,0.00034615382669549426,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +54.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +55.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +56.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +57.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +58.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +59.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.92307701648081041945,3.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,0.00019230769112236383,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +60.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.92307698234334822906,3.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,0.00019230769112236383,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +61.0000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,1.92307695958504076827,3.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,0.00019230769112236383,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +62.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +63.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +64.0000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,1.92307695958504076827,3.00000000000000000000,0.00011538461299499319,0.99999997485207114955,0.00019230769112236383,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +65.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.92307698234334822906,3.00000000000000000000,0.00019230768756637849,0.99999996301775195828,0.00019230769112236383,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +66.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.92307701648081041945,3.00000000000000000000,0.00026923076099984833,0.99999994526627311586,0.00019230769112236383,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +67.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +68.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +69.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +70.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +71.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +72.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +73.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.15384620078516308971,3.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,0.00011538461512858444,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +74.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.15384618030268581989,3.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,0.00011538461512858444,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +75.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,1.15384616664770156546,1.00000000000000000000,-0.0001154820839444342,0.99999998678627821657,0.00011441735651764090,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +75.0000000000000000000,1.00000000000000000000,-1.2693282444371554174,0.00000000000000000000,1.26826352467722158756,1.00000000000000000000,-0.0001154820839444342,0.99999998678627821657,0.00011441735651764090,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001463498174416,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +76.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.15384615982020943825,1.00000000000000000000,-0.0000385585513016470,0.99999999269039097082,0.00011459692936945851,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +76.0000000000000000000,1.00000000000000000000,-0.4231739363885317906,0.00000000000000000000,1.26844309002732669178,1.00000000000000000000,-0.0000385585513016470,0.99999999269039097082,0.00011459692936945851,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000812741072877,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +77.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.15384615982020943825,1.00000000000000000000,0.00003843007481958899,0.99999999261514438408,0.00011529458190977321,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +77.0000000000000000000,1.00000000000000000000,0.42304545990842634672,0.00000000000000000000,1.26914074258141651441,1.00000000000000000000,0.00003843007481958899,0.99999999261514438408,0.00011529458190977321,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813493534224,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +78.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,1.15384616664770156546,1.00000000000000000000,0.00011522184566990385,0.99999998676565182709,0.00011485914141355163,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +78.0000000000000000000,1.00000000000000000000,1.26906800616156290040,0.00000000000000000000,1.26870530958133920229,1.00000000000000000000,0.00011522184566990385,0.99999998676565182709,0.00011485914141355163,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001463704447814,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +79.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.15384618030268581989,3.00000000000000000000,0.00019230768984220914,0.99999997485207114955,0.00011538461512858444,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +80.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.15384620078516308971,3.00000000000000000000,0.00026923076418601120,0.99999995710059208509,0.00011538461512858444,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +81.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +82.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +83.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +84.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +85.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +86.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +87.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,0.38461539874450018094,3.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,0.00003846153845205580,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +88.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +89.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,0.38461538736534633953,1.00000000000000000000,-0.0001168699164632243,0.99999999244822634913,0.00003801275939869937,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +89.0000000000000000000,1.00000000000000000000,-1.2707160763125724400,0.00000000000000000000,0.42262814705110945956,1.00000000000000000000,-0.0001168699164632243,0.99999999244822634913,0.00003801275939869937,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000815162711660,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +90.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,0.38461538508951564896,1.00000000000000000000,-0.0000383759249364372,0.99999999852311305392,0.00003848457415021780,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +90.0000000000000000000,1.00000000000000000000,-0.4229913097981509717,0.00000000000000000000,0.42309995929657079338,1.00000000000000000000,-0.0000383759249364372,0.99999999852311305392,0.00003848457415021780,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162697870109,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +91.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,0.38461538508951564896,1.00000000000000000000,0.00003830273338429726,0.99999999852728471694,0.00003844907402737710,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +91.0000000000000000000,1.00000000000000000000,0.42291811824574310207,0.00000000000000000000,0.42306445917351731544,1.00000000000000000000,0.00003830273338429726,0.99999999852728471694,0.00003844907402737710,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162656160682,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +92.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,0.38461538736534633953,1.00000000000000000000,0.00011582080801010150,0.99999999254360805167,0.00003870819350673453,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +92.0000000000000000000,1.00000000000000000000,1.26966696784047994306,0.00000000000000000000,0.42332358116070434306,1.00000000000000000000,0.00011582080801010150,0.99999999254360805167,0.00003870819350673453,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000814208906376,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +93.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +94.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,0.38461539874450018094,3.00000000000000000000,0.00026923076577909266,0.99999996301775162521,0.00003846153845205580,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +95.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +96.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +97.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +98.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +99.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +100.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +101.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-0.3846153987445001809,3.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,-0.0000384615384520558,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +102.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +103.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-0.3846153873653463395,1.00000000000000000000,-0.0001156486083869899,0.99999999256154448179,-0.0000387596489162040,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +103.000000000000000000,1.00000000000000000000,-1.2694947682140100830,0.00000000000000000000,-0.4233750365698623063,1.00000000000000000000,-0.0001156486083869899,0.99999999256154448179,-0.0000387596489162040,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000814029535831,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +104.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-0.3846153850895156489,1.00000000000000000000,-0.0000387536781005057,0.99999999851625509528,-0.0000382837075977132,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +104.000000000000000000,1.00000000000000000000,-0.4233690629630430524,0.00000000000000000000,-0.4228990927440321456,1.00000000000000000000,-0.0000387536781005057,0.99999999851625509528,-0.0000382837075977132,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162766446010,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +105.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-0.3846153850895156489,1.00000000000000000000,0.00003819513621371589,0.99999999852483356654,-0.0000386194839379186,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +105.000000000000000000,1.00000000000000000000,0.42281052107509686788,0.00000000000000000000,-0.4232348690844044969,1.00000000000000000000,0.00003819513621371589,0.99999999852483356654,-0.0000386194839379186,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162680662469,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +106.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-0.3846153873653463395,1.00000000000000000000,0.00011539990873770338,0.99999999260423089175,-0.0000383979065069982,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +106.000000000000000000,1.00000000000000000000,1.26924606855794741555,0.00000000000000000000,-0.4230132941563266579,1.00000000000000000000,0.00011539990873770338,0.99999999260423089175,-0.0000383979065069982,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813602673588,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +107.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +108.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-0.3846153987445001809,3.00000000000000000000,0.00026923076577909266,0.99999996301775162521,-0.0000384615384520558,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +109.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +110.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +111.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +112.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +113.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +114.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +115.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.1538462007851630897,3.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,-0.0001153846151285844,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +116.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.1538461803026858198,3.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,-0.0001153846151285844,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +117.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-1.1538461666477015654,1.00000000000000000000,-0.0001157093021606554,0.99999998663611855409,-0.0001154951082520545,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +117.000000000000000000,1.00000000000000000000,-1.2695554626737537429,0.00000000000000000000,-1.2693412764432190353,1.00000000000000000000,-0.0001157093021606554,0.99999998663611855409,-0.0001154951082520545,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001464999786549,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +118.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.1538461598202094382,1.00000000000000000000,-0.0000392836977972695,0.99999999256924299029,-0.0001154049609899504,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +118.000000000000000000,1.00000000000000000000,-0.4238990828942139632,0.00000000000000000000,-1.2692511216677060392,1.00000000000000000000,-0.0000392836977972695,0.99999999256924299029,-0.0001154049609899504,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813952556200,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +119.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.1538461598202094382,1.00000000000000000000,0.00003613869813277658,0.99999999272442008368,-0.0001150875940239665,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +119.000000000000000000,1.00000000000000000000,0.42075408320074336732,0.00000000000000000000,-1.2689337546815049329,1.00000000000000000000,0.00003613869813277658,0.99999999272442008368,-0.0001150875940239665,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000812400776339,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +120.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-1.1538461666477015654,1.00000000000000000000,0.00011582333048864257,0.99999998666739209340,-0.0001151093898863204,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +120.000000000000000000,1.00000000000000000000,1.26966949099964265812,0.00000000000000000000,-1.2689555580687303937,1.00000000000000000000,0.00011582333048864257,0.99999998666739209340,-0.0001151093898863204,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001464687047700,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +121.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.1538461803026858198,3.00000000000000000000,0.00019230768984220914,0.99999997485207114955,-0.0001153846151285844,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +122.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.1538462007851630897,3.00000000000000000000,0.00026923076418601120,0.99999995710059208509,-0.0001153846151285844,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +123.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +124.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +125.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +126.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +127.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +128.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +129.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.9230770164808110855,3.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,-0.0001923076911223638,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +130.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.9230769823433486731,3.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,-0.0001923076911223638,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +131.000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,-1.9230769595850412123,3.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,-0.0001923076911223638,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +132.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +133.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +134.000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,-1.9230769595850412123,3.00000000000000000000,0.00011538461299499319,0.99999997485207114955,-0.0001923076911223638,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +135.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.9230769823433486731,3.00000000000000000000,0.00019230768756637849,0.99999996301775195828,-0.0001923076911223638,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +136.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.9230770164808110855,3.00000000000000000000,0.00026923076099984833,0.99999994526627311586,-0.0001923076911223638,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +137.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +138.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +139.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +140.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +141.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +142.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-2.6923079186580318733,3.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +143.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-2.6923078549347665422,3.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,-0.0002692307659782278,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +144.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-2.6923078071423187651,3.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,-0.0002692307659782278,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +145.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-2.6923077752806880980,3.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,-0.0002692307659782278,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +146.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-2.6923077593498727644,3.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,-0.0002692307659782278,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +147.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-2.6923077593498727644,3.00000000000000000000,0.00003846153705810951,0.99999996301775162521,-0.0002692307659782278,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +148.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-2.6923077752806880980,3.00000000000000000000,0.00011538461094674560,0.99999995710059208509,-0.0002692307659782278,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +149.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-2.6923078071423187651,3.00000000000000000000,0.00019230768415263250,0.99999994526627311586,-0.0002692307659782278,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +150.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-2.6923078549347665422,3.00000000000000000000,0.00026923075622060400,0.99999992751479460650,-0.0002692307659782278,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +151.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-2.6923079186580318733,3.00000000000000000000,0.00034615382669549426,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +152.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +153.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +154.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +155.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +156.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-3.4615388071802710712,3.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +157.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-3.4615387252503571069,3.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822780,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +158.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +159.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +160.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +161.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +162.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +163.000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +164.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-3.4615387252503571069,3.00000000000000000000,0.00026923074984827827,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +165.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-3.4615388071802710712,3.00000000000000000000,0.00034615381850250414,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +166.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +167.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +168.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +169.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +170.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +171.000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +172.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +173.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +174.000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +175.000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +176.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +177.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +178.000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +179.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +180.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +181.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +182.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +183.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +184.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +185.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +186.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +187.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +188.000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +189.000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +190.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +191.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +192.000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +193.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +194.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +195.000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +196.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +197.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +198.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +199.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 diff --git a/Intern/rayx-core/tests/input/slit2_seeded.correct.csv b/Intern/rayx-core/tests/input/slit2_seeded.correct.csv index 55b0c139..63f06de6 100644 --- a/Intern/rayx-core/tests/input/slit2_seeded.correct.csv +++ b/Intern/rayx-core/tests/input/slit2_seeded.correct.csv @@ -1,213 +1,213 @@ -Ray-ID ,Event-ID ,X-position ,Y-position ,Z-position ,Event-type ,X-direction ,Y-direction ,Z-direction ,Energy ,Stokes0 ,Stokes1 ,Stokes2 ,Stokes3 ,pathLength ,order ,lastElement ,lightSourceIndex -0.00000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -1.00000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -2.00000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -3.00000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -4.00000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -5.00000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -6.00000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -7.00000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -8.00000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -9.00000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -10.0000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -11.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -12.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -13.0000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -14.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -15.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -16.0000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -17.0000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -18.0000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -19.0000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -20.0000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -21.0000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -22.0000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -23.0000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -24.0000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -25.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -26.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -27.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -28.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -29.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -30.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,3.46153880718027107121,3.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -31.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,3.46153872525035710694,3.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -32.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -33.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -34.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -35.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -36.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -37.0000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -38.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,3.46153872525035710694,3.00000000000000000000,0.00026923074984827827,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -39.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,3.46153880718027107121,3.00000000000000000000,0.00034615381850250414,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -40.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -41.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -42.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -43.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -44.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,2.69230791865803187334,3.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -45.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,2.69230785493476654224,3.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -46.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,2.69230780714231876515,3.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -47.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,2.69230777528068809800,3.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -48.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,2.69230775934987276443,3.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -49.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,2.69230775934987276443,3.00000000000000000000,0.00003846153705810951,0.99999996301775162521,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -50.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,2.69230777528068809800,3.00000000000000000000,0.00011538461094674560,0.99999995710059208509,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -51.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,2.69230780714231876515,3.00000000000000000000,0.00019230768415263250,0.99999994526627311586,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -52.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,2.69230785493476654224,3.00000000000000000000,0.00026923075622060400,0.99999992751479460650,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -53.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,2.69230791865803187334,3.00000000000000000000,0.00034615382669549426,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -54.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -55.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -56.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -57.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -58.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -59.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.92307701648081041945,3.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -60.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.92307698234334822906,3.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -61.0000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,1.92307695958504076827,3.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -62.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -63.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -64.0000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,1.92307695958504076827,3.00000000000000000000,0.00011538461299499319,0.99999997485207114955,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -65.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.92307698234334822906,3.00000000000000000000,0.00019230768756637849,0.99999996301775195828,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -66.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.92307701648081041945,3.00000000000000000000,0.00026923076099984833,0.99999994526627311586,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -67.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -68.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -69.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -70.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -71.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -72.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -73.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.15384620078516308971,3.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -74.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.15384618030268581989,3.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -75.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,1.15384616664770156546,3.00000000000000000000,-0.0001153846143604915,0.99999998668639045185,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -76.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.15384615982020943825,1.00000000000000000000,-0.0000383561803323650,0.99999999264655137221,0.00011504651533206670,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -76.0000000000000000000,1.00000000000000000000,-0.4229715654194521334,0.00000000000000000000,1.26889267599826460752,1.00000000000000000000,-0.0000383561803323650,0.99999999264655137221,0.00011504651533206670,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813179467513,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -77.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.15384615982020943825,1.00000000000000000000,0.00003823438136863019,0.99999999253347193750,0.00011606544697498478,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -77.0000000000000000000,1.00000000000000000000,0.42284976645914507109,0.00000000000000000000,1.26991160766180000152,1.00000000000000000000,0.00003823438136863019,0.99999999253347193750,0.00011606544697498478,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000814310260466,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -78.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,1.15384616664770156546,3.00000000000000000000,0.00011538461436049158,0.99999998668639045185,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -79.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.15384618030268581989,3.00000000000000000000,0.00019230768984220914,0.99999997485207114955,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -80.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.15384620078516308971,3.00000000000000000000,0.00026923076418601120,0.99999995710059208509,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -81.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -82.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -83.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -84.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -85.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -86.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -87.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,0.38461539874450018094,3.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -88.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -89.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,0.38461538736534633953,1.00000000000000000000,-0.0001160798937701057,0.99999999248718274280,0.00003938391086896673,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -89.0000000000000000000,1.00000000000000000000,-1.2699260536089655992,0.00000000000000000000,0.42399929853019718839,1.00000000000000000000,-0.0001160798937701057,0.99999999248718274280,0.00003938391086896673,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000814773156889,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -90.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,0.38461538508951564896,1.00000000000000000000,-0.0000385998196320783,0.99999999851894383340,0.00003836881460801995,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -90.0000000000000000000,1.00000000000000000000,-0.4232152044942837365,0.00000000000000000000,0.42298419975436196693,1.00000000000000000000,-0.0000385998196320783,0.99999999851894383340,0.00003836881460801995,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162739561346,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -91.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,0.38461538508951564896,1.00000000000000000000,0.00003833216057651929,0.99999999852802834432,0.00003840037043683554,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -91.0000000000000000000,1.00000000000000000000,0.42294754543797996593,0.00000000000000000000,0.42301575558287546341,1.00000000000000000000,0.00003833216057651929,0.99999999852802834432,0.00003840037043683554,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162648721016,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -92.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,0.38461538736534633953,1.00000000000000000000,0.00011515406530102297,0.99999999262695837831,0.00003854379536977061,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -92.0000000000000000000,1.00000000000000000000,1.26900022511683174819,0.00000000000000000000,0.42315918301930194322,1.00000000000000000000,0.00011515406530102297,0.99999999262695837831,0.00003854379536977061,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813375390862,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -93.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -94.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,0.38461539874450018094,3.00000000000000000000,0.00026923076577909266,0.99999996301775162521,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -95.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -96.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -97.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -98.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -99.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -100.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -101.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-0.3846153987445001809,3.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -102.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -103.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-0.3846153873653463395,1.00000000000000000000,-0.0001154282727597822,0.99999999258527771939,-0.0000388040991344637,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -103.000000000000000000,1.00000000000000000000,-1.2692744325824238948,0.00000000000000000000,-0.4234194867875317180,1.00000000000000000000,-0.0001154282727597822,0.99999999258527771939,-0.0000388040991344637,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813792212284,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -104.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-0.3846153850895156489,1.00000000000000000000,-0.0000379508083592782,0.99999999854592291903,-0.0000383130547407934,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -104.000000000000000000,1.00000000000000000000,-0.4225661932194984538,0.00000000000000000000,-0.4229284398860191918,1.00000000000000000000,-0.0000379508083592782,0.99999999854592291903,-0.0000383130547407934,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162469768838,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -105.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-0.3846153850895156489,1.00000000000000000000,0.00003812259648415328,0.99999999853793097859,-0.0000383510838399685,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -105.000000000000000000,1.00000000000000000000,0.42273798134492795997,0.00000000000000000000,-0.4229664689855560655,1.00000000000000000000,0.00003812259648415328,0.99999999853793097859,-0.0000383510838399685,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162549695232,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -106.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-0.3846153873653463395,1.00000000000000000000,0.00011517195582250618,0.99999999261811056694,-0.0000387194944303958,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -106.000000000000000000,1.00000000000000000000,1.26901811563946576022,0.00000000000000000000,-0.4233348820815652224,1.00000000000000000000,0.00011517195582250618,0.99999999261811056694,-0.0000387194944303958,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813463884696,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -107.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -108.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-0.3846153987445001809,3.00000000000000000000,0.00026923076577909266,0.99999996301775162521,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -109.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -110.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -111.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -112.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -113.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -114.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -115.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.1538462007851630897,3.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -116.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.1538461803026858198,3.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -117.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-1.1538461666477015654,3.00000000000000000000,-0.0001153846143604915,0.99999998668639045185,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -118.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.1538461598202094382,1.00000000000000000000,-0.0000383460970069977,0.99999999260234584408,-0.0001154334644534737,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -118.000000000000000000,1.00000000000000000000,-0.4229614820957057208,0.00000000000000000000,-1.2692796251276199370,1.00000000000000000000,-0.0000383460970069977,0.99999999260234584408,-0.0001154334644534737,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813621518318,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -119.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.1538461598202094382,1.00000000000000000000,0.00003832373897870499,0.99999999259054594968,-0.0001155430597813330,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -119.000000000000000000,1.00000000000000000000,0.42293912406769978984,0.00000000000000000000,-1.2693892204576535664,1.00000000000000000000,0.00003832373897870499,0.99999999259054594968,-0.0001155430597813330,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813739516161,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -120.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-1.1538461666477015654,3.00000000000000000000,0.00011538461436049158,0.99999998668639045185,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -121.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.1538461803026858198,3.00000000000000000000,0.00019230768984220914,0.99999997485207114955,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -122.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.1538462007851630897,3.00000000000000000000,0.00026923076418601120,0.99999995710059208509,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -123.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -124.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -125.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -126.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -127.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -128.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -129.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.9230770164808110855,3.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -130.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.9230769823433486731,3.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -131.000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,-1.9230769595850412123,3.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -132.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -133.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -134.000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,-1.9230769595850412123,3.00000000000000000000,0.00011538461299499319,0.99999997485207114955,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -135.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.9230769823433486731,3.00000000000000000000,0.00019230768756637849,0.99999996301775195828,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -136.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.9230770164808110855,3.00000000000000000000,0.00026923076099984833,0.99999994526627311586,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -137.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -138.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -139.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -140.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -141.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -142.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-2.6923079186580318733,3.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -143.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-2.6923078549347665422,3.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -144.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-2.6923078071423187651,3.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -145.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-2.6923077752806880980,3.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -146.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-2.6923077593498727644,3.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -147.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-2.6923077593498727644,3.00000000000000000000,0.00003846153705810951,0.99999996301775162521,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -148.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-2.6923077752806880980,3.00000000000000000000,0.00011538461094674560,0.99999995710059208509,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -149.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-2.6923078071423187651,3.00000000000000000000,0.00019230768415263250,0.99999994526627311586,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -150.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-2.6923078549347665422,3.00000000000000000000,0.00026923075622060400,0.99999992751479460650,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -151.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-2.6923079186580318733,3.00000000000000000000,0.00034615382669549426,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -152.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -153.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -154.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -155.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -156.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-3.4615388071802710712,3.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -157.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-3.4615387252503571069,3.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -158.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -159.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -160.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -161.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -162.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -163.000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -164.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-3.4615387252503571069,3.00000000000000000000,0.00026923074984827827,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -165.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-3.4615388071802710712,3.00000000000000000000,0.00034615381850250414,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -166.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -167.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -168.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -169.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -170.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -171.000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -172.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -173.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -174.000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -175.000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -176.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -177.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -178.000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -179.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -180.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -181.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -182.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -183.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -184.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -185.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -186.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -187.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -188.000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -189.000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -190.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -191.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -192.000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -193.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -194.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -195.000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -196.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -197.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -198.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -199.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +Ray-ID ,Event-ID ,X-position ,Y-position ,Z-position ,Event-type ,X-direction ,Y-direction ,Z-direction ,Energy ,ElectricField-x-real ,ElectricField-x-imag ,ElectricField-y-real ,ElectricField-y-imag ,ElectricField-z-real ,ElectricField-z-imag ,pathLength ,order ,lastElement ,lightSourceIndex +0.00000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +1.00000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +2.00000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +3.00000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +4.00000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +5.00000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +6.00000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +7.00000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +8.00000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +9.00000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +10.0000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +11.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +12.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +13.0000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +14.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +15.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +16.0000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +17.0000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +18.0000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +19.0000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +20.0000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +21.0000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +22.0000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +23.0000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +24.0000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +25.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +26.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +27.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +28.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +29.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +30.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,3.46153880718027107121,3.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +31.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,3.46153872525035710694,3.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822780,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +32.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +33.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +34.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +35.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +36.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +37.0000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +38.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,3.46153872525035710694,3.00000000000000000000,0.00026923074984827827,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +39.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,3.46153880718027107121,3.00000000000000000000,0.00034615381850250414,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +40.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +41.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +42.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +43.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +44.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,2.69230791865803187334,3.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +45.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,2.69230785493476654224,3.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,0.00026923076597822786,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +46.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,2.69230780714231876515,3.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,0.00026923076597822786,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +47.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,2.69230777528068809800,3.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,0.00026923076597822786,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +48.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,2.69230775934987276443,3.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,0.00026923076597822786,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +49.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,2.69230775934987276443,3.00000000000000000000,0.00003846153705810951,0.99999996301775162521,0.00026923076597822786,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +50.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,2.69230777528068809800,3.00000000000000000000,0.00011538461094674560,0.99999995710059208509,0.00026923076597822786,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +51.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,2.69230780714231876515,3.00000000000000000000,0.00019230768415263250,0.99999994526627311586,0.00026923076597822786,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +52.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,2.69230785493476654224,3.00000000000000000000,0.00026923075622060400,0.99999992751479460650,0.00026923076597822786,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +53.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,2.69230791865803187334,3.00000000000000000000,0.00034615382669549426,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +54.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +55.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +56.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +57.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +58.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +59.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.92307701648081041945,3.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,0.00019230769112236383,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +60.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.92307698234334822906,3.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,0.00019230769112236383,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +61.0000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,1.92307695958504076827,3.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,0.00019230769112236383,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +62.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +63.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +64.0000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,1.92307695958504076827,3.00000000000000000000,0.00011538461299499319,0.99999997485207114955,0.00019230769112236383,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +65.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.92307698234334822906,3.00000000000000000000,0.00019230768756637849,0.99999996301775195828,0.00019230769112236383,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +66.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.92307701648081041945,3.00000000000000000000,0.00026923076099984833,0.99999994526627311586,0.00019230769112236383,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +67.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +68.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +69.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +70.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +71.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +72.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +73.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.15384620078516308971,3.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,0.00011538461512858444,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +74.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.15384618030268581989,3.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,0.00011538461512858444,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +75.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,1.15384616664770156546,3.00000000000000000000,-0.0001153846143604915,0.99999998668639045185,0.00011538461512858444,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +76.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.15384615982020943825,1.00000000000000000000,-0.0000383561803323530,0.99999999264655137221,0.00011504651533214227,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +76.0000000000000000000,1.00000000000000000000,-0.4229715654194400320,0.00000000000000000000,1.26889267599834032473,1.00000000000000000000,-0.0000383561803323530,0.99999999264655137221,0.00011504651533214227,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813179467513,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +77.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.15384615982020943825,1.00000000000000000000,0.00003823438136848036,0.99999999253347204852,0.00011606544697501711,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +77.0000000000000000000,1.00000000000000000000,0.42284976645899524649,0.00000000000000000000,1.26991160766183242003,1.00000000000000000000,0.00003823438136848036,0.99999999253347204852,0.00011606544697501711,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000814310260466,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +78.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,1.15384616664770156546,3.00000000000000000000,0.00011538461436049158,0.99999998668639045185,0.00011538461512858444,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +79.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.15384618030268581989,3.00000000000000000000,0.00019230768984220914,0.99999997485207114955,0.00011538461512858444,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +80.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.15384620078516308971,3.00000000000000000000,0.00026923076418601120,0.99999995710059208509,0.00011538461512858444,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +81.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +82.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +83.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +84.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +85.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +86.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +87.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,0.38461539874450018094,3.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,0.00003846153845205580,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +88.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +89.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,0.38461538736534633953,1.00000000000000000000,-0.0001160798937701925,0.99999999248718296485,0.00003938391086906161,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +89.0000000000000000000,1.00000000000000000000,-1.2699260536090524187,0.00000000000000000000,0.42399929853029205695,1.00000000000000000000,-0.0001160798937701925,0.99999999248718296485,0.00003938391086906161,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000814773156889,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +90.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,0.38461538508951564896,1.00000000000000000000,-0.0000385998196320810,0.99999999851894394442,0.00003836881460804837,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +90.0000000000000000000,1.00000000000000000000,-0.4232152044942864010,0.00000000000000000000,0.42298419975439038864,1.00000000000000000000,-0.0000385998196320810,0.99999999851894394442,0.00003836881460804837,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162739561346,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +91.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,0.38461538508951564896,1.00000000000000000000,0.00003833216057636855,0.99999999852802845534,0.00003840037043699642,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +91.0000000000000000000,1.00000000000000000000,0.42294754543782919764,0.00000000000000000000,0.42301575558303633473,1.00000000000000000000,0.00003833216057636855,0.99999999852802845534,0.00003840037043699642,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162648721016,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +92.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,0.38461538736534633953,1.00000000000000000000,0.00011515406530106205,0.99999999262695860036,0.00003854379536984479,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +92.0000000000000000000,1.00000000000000000000,1.26900022511687082804,0.00000000000000000000,0.42315918301937610612,1.00000000000000000000,0.00011515406530106205,0.99999999262695860036,0.00003854379536984479,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813375390862,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +93.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +94.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,0.38461539874450018094,3.00000000000000000000,0.00026923076577909266,0.99999996301775162521,0.00003846153845205580,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +95.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +96.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +97.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +98.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +99.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +100.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +101.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-0.3846153987445001809,3.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,-0.0000384615384520558,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +102.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +103.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-0.3846153873653463395,1.00000000000000000000,-0.0001154282727598991,0.99999999258527783041,-0.0000388040991344508,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +103.000000000000000000,1.00000000000000000000,-1.2692744325825406903,0.00000000000000000000,-0.4234194867875188394,1.00000000000000000000,-0.0001154282727598991,0.99999999258527783041,-0.0000388040991344508,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813792212284,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +104.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-0.3846153850895156489,1.00000000000000000000,-0.0000379508083594117,0.99999999854592291903,-0.0000383130547407890,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +104.000000000000000000,1.00000000000000000000,-0.4225661932196319581,0.00000000000000000000,-0.4229284398860148619,1.00000000000000000000,-0.0000379508083594117,0.99999999854592291903,-0.0000383130547407890,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162469768838,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +105.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-0.3846153850895156489,1.00000000000000000000,0.00003812259648419130,0.99999999853793097859,-0.0000383510838399693,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +105.000000000000000000,1.00000000000000000000,0.42273798134496598510,0.00000000000000000000,-0.4229664689855568981,1.00000000000000000000,0.00003812259648419130,0.99999999853793097859,-0.0000383510838399693,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162549695232,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +106.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-0.3846153873653463395,1.00000000000000000000,0.00011517195582246757,0.99999999261811067796,-0.0000387194944303667,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +106.000000000000000000,1.00000000000000000000,1.26901811563942712446,0.00000000000000000000,-0.4233348820815360791,1.00000000000000000000,0.00011517195582246757,0.99999999261811067796,-0.0000387194944303667,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813463884696,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +107.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +108.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-0.3846153987445001809,3.00000000000000000000,0.00026923076577909266,0.99999996301775162521,-0.0000384615384520558,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +109.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +110.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +111.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +112.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +113.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +114.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +115.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.1538462007851630897,3.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,-0.0001153846151285844,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +116.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.1538461803026858198,3.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,-0.0001153846151285844,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +117.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-1.1538461666477015654,3.00000000000000000000,-0.0001153846143604915,0.99999998668639045185,-0.0001153846151285844,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +118.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.1538461598202094382,1.00000000000000000000,-0.0000383460970070681,0.99999999260234606612,-0.0001154334644533119,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +118.000000000000000000,1.00000000000000000000,-0.4229614820957761089,0.00000000000000000000,-1.2692796251274580665,1.00000000000000000000,-0.0000383460970070681,0.99999999260234606612,-0.0001154334644533119,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813621518318,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +119.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.1538461598202094382,1.00000000000000000000,0.00003832373897862439,0.99999999259054617173,-0.0001155430597812107,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +119.000000000000000000,1.00000000000000000000,0.42293912406761918765,0.00000000000000000000,-1.2693892204575312199,1.00000000000000000000,0.00003832373897862439,0.99999999259054617173,-0.0001155430597812107,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813739516161,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +120.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-1.1538461666477015654,3.00000000000000000000,0.00011538461436049158,0.99999998668639045185,-0.0001153846151285844,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +121.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.1538461803026858198,3.00000000000000000000,0.00019230768984220914,0.99999997485207114955,-0.0001153846151285844,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +122.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.1538462007851630897,3.00000000000000000000,0.00026923076418601120,0.99999995710059208509,-0.0001153846151285844,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +123.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +124.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +125.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +126.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +127.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +128.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +129.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.9230770164808110855,3.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,-0.0001923076911223638,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +130.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.9230769823433486731,3.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,-0.0001923076911223638,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +131.000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,-1.9230769595850412123,3.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,-0.0001923076911223638,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +132.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +133.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +134.000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,-1.9230769595850412123,3.00000000000000000000,0.00011538461299499319,0.99999997485207114955,-0.0001923076911223638,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +135.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.9230769823433486731,3.00000000000000000000,0.00019230768756637849,0.99999996301775195828,-0.0001923076911223638,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +136.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.9230770164808110855,3.00000000000000000000,0.00026923076099984833,0.99999994526627311586,-0.0001923076911223638,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +137.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +138.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +139.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +140.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +141.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +142.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-2.6923079186580318733,3.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +143.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-2.6923078549347665422,3.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,-0.0002692307659782278,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +144.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-2.6923078071423187651,3.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,-0.0002692307659782278,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +145.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-2.6923077752806880980,3.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,-0.0002692307659782278,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +146.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-2.6923077593498727644,3.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,-0.0002692307659782278,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +147.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-2.6923077593498727644,3.00000000000000000000,0.00003846153705810951,0.99999996301775162521,-0.0002692307659782278,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +148.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-2.6923077752806880980,3.00000000000000000000,0.00011538461094674560,0.99999995710059208509,-0.0002692307659782278,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +149.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-2.6923078071423187651,3.00000000000000000000,0.00019230768415263250,0.99999994526627311586,-0.0002692307659782278,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +150.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-2.6923078549347665422,3.00000000000000000000,0.00026923075622060400,0.99999992751479460650,-0.0002692307659782278,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +151.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-2.6923079186580318733,3.00000000000000000000,0.00034615382669549426,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +152.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +153.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +154.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +155.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +156.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-3.4615388071802710712,3.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +157.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-3.4615387252503571069,3.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822780,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +158.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +159.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +160.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +161.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +162.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +163.000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +164.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-3.4615387252503571069,3.00000000000000000000,0.00026923074984827827,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +165.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-3.4615388071802710712,3.00000000000000000000,0.00034615381850250414,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +166.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +167.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +168.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +169.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +170.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +171.000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +172.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +173.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +174.000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +175.000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +176.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +177.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +178.000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +179.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +180.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +181.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +182.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +183.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +184.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +185.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +186.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +187.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +188.000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +189.000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +190.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +191.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +192.000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +193.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +194.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +195.000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +196.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +197.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +198.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +199.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 diff --git a/Intern/rayx-core/tests/input/slit3_seeded.correct.csv b/Intern/rayx-core/tests/input/slit3_seeded.correct.csv index 62313e37..e59ae51c 100644 --- a/Intern/rayx-core/tests/input/slit3_seeded.correct.csv +++ b/Intern/rayx-core/tests/input/slit3_seeded.correct.csv @@ -1,213 +1,213 @@ -Ray-ID ,Event-ID ,X-position ,Y-position ,Z-position ,Event-type ,X-direction ,Y-direction ,Z-direction ,Energy ,Stokes0 ,Stokes1 ,Stokes2 ,Stokes3 ,pathLength ,order ,lastElement ,lightSourceIndex -0.00000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -1.00000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -2.00000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -3.00000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -4.00000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -5.00000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -6.00000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -7.00000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -8.00000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -9.00000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -10.0000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -11.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -12.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -13.0000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -14.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -15.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -16.0000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -17.0000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -18.0000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -19.0000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -20.0000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -21.0000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -22.0000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -23.0000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -24.0000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -25.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -26.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -27.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -28.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -29.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -30.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,3.46153880718027107121,3.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -31.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,3.46153872525035710694,3.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -32.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -33.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -34.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -35.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -36.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -37.0000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -38.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,3.46153872525035710694,3.00000000000000000000,0.00026923074984827827,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -39.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,3.46153880718027107121,3.00000000000000000000,0.00034615381850250414,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -40.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -41.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -42.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -43.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -44.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,2.69230791865803187334,3.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -45.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,2.69230785493476654224,3.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -46.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,2.69230780714231876515,3.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -47.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,2.69230777528068809800,3.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -48.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,2.69230775934987276443,3.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -49.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,2.69230775934987276443,3.00000000000000000000,0.00003846153705810951,0.99999996301775162521,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -50.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,2.69230777528068809800,3.00000000000000000000,0.00011538461094674560,0.99999995710059208509,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -51.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,2.69230780714231876515,3.00000000000000000000,0.00019230768415263250,0.99999994526627311586,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -52.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,2.69230785493476654224,3.00000000000000000000,0.00026923075622060400,0.99999992751479460650,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -53.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,2.69230791865803187334,3.00000000000000000000,0.00034615382669549426,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -54.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -55.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -56.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -57.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -58.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -59.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.92307701648081041945,3.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -60.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.92307698234334822906,3.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -61.0000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,1.92307695958504076827,3.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -62.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -63.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -64.0000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,1.92307695958504076827,3.00000000000000000000,0.00011538461299499319,0.99999997485207114955,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -65.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.92307698234334822906,3.00000000000000000000,0.00019230768756637849,0.99999996301775195828,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -66.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.92307701648081041945,3.00000000000000000000,0.00026923076099984833,0.99999994526627311586,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -67.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -68.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -69.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -70.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -71.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -72.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -73.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.15384620078516308971,3.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -74.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.15384618030268581989,3.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -75.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,1.15384616664770156546,1.00000000000000000000,-0.0001154820839442817,0.99999998678627821657,0.00011441735651760849,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -75.0000000000000000000,1.00000000000000000000,-1.2693282444370028727,0.00000000000000000000,1.26826352467718916905,1.00000000000000000000,-0.0001154820839442817,0.99999998678627821657,0.00011441735651760849,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001463498174416,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -76.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.15384615982020943825,1.00000000000000000000,-0.0000385585513015160,0.99999999269039097082,0.00011459692936946305,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -76.0000000000000000000,1.00000000000000000000,-0.4231739363884007287,0.00000000000000000000,1.26844309002733135471,1.00000000000000000000,-0.0000385585513015160,0.99999999269039097082,0.00011459692936946305,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000812741072877,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -77.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.15384615982020943825,1.00000000000000000000,0.00003843007481959632,0.99999999261514416204,0.00011529458190969960,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -77.0000000000000000000,1.00000000000000000000,0.42304545990843372971,0.00000000000000000000,1.26914074258134301764,1.00000000000000000000,0.00003843007481959632,0.99999999261514416204,0.00011529458190969960,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813493534224,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -78.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,1.15384616664770156546,1.00000000000000000000,0.00011522184566996068,0.99999998676565182709,0.00011485914141359134,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -78.0000000000000000000,1.00000000000000000000,1.26906800616161974382,0.00000000000000000000,1.26870530958137894828,1.00000000000000000000,0.00011522184566996068,0.99999998676565182709,0.00011485914141359134,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001463704447814,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -79.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.15384618030268581989,3.00000000000000000000,0.00019230768984220914,0.99999997485207114955,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -80.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.15384620078516308971,3.00000000000000000000,0.00026923076418601120,0.99999995710059208509,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -81.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -82.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -83.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -84.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -85.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -86.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -87.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,0.38461539874450018094,3.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -88.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -89.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,0.38461538736534633953,1.00000000000000000000,-0.0001168699164631558,0.99999999244822623811,0.00003801275939874131,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -89.0000000000000000000,1.00000000000000000000,-1.2707160763125038283,0.00000000000000000000,0.42262814705115137048,1.00000000000000000000,-0.0001168699164631558,0.99999999244822623811,0.00003801275939874131,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000815162711660,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -90.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,0.38461538508951564896,3.00000000000000000000,-0.0000384615384236079,0.99999999852070997619,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -91.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,0.38461538508951564896,3.00000000000000000000,0.00003846153842360791,0.99999999852070997619,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -92.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,0.38461538736534633953,1.00000000000000000000,0.00011582080801016253,0.99999999254360794065,0.00003870819350675153,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -92.0000000000000000000,1.00000000000000000000,1.26966696784054100533,0.00000000000000000000,0.42332358116072132947,1.00000000000000000000,0.00011582080801016253,0.99999999254360794065,0.00003870819350675153,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000814208906376,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -93.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -94.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,0.38461539874450018094,3.00000000000000000000,0.00026923076577909266,0.99999996301775162521,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -95.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -96.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -97.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -98.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -99.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -100.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -101.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-0.3846153987445001809,3.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -102.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -103.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-0.3846153873653463395,1.00000000000000000000,-0.0001156486083869762,0.99999999256154425975,-0.0000387596489163242,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -103.000000000000000000,1.00000000000000000000,-1.2694947682139963163,0.00000000000000000000,-0.4233750365699825435,1.00000000000000000000,-0.0001156486083869762,0.99999999256154425975,-0.0000387596489163242,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000814029535831,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -104.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-0.3846153850895156489,3.00000000000000000000,-0.0000384615384236079,0.99999999852070997619,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -105.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-0.3846153850895156489,3.00000000000000000000,0.00003846153842360791,0.99999999852070997619,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -106.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-0.3846153873653463395,1.00000000000000000000,0.00011539990873768394,0.99999999260423078073,-0.0000383979065070109,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -106.000000000000000000,1.00000000000000000000,1.26924606855792809767,0.00000000000000000000,-0.4230132941563393145,1.00000000000000000000,0.00011539990873768394,0.99999999260423078073,-0.0000383979065070109,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813602673588,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -107.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -108.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-0.3846153987445001809,3.00000000000000000000,0.00026923076577909266,0.99999996301775162521,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -109.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -110.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -111.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -112.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -113.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -114.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -115.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.1538462007851630897,3.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -116.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.1538461803026858198,3.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -117.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-1.1538461666477015654,1.00000000000000000000,-0.0001157093021605022,0.99999998663611833205,-0.0001154951082520170,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -117.000000000000000000,1.00000000000000000000,-1.2695554626736005321,0.00000000000000000000,-1.2693412764431817318,1.00000000000000000000,-0.0001157093021605022,0.99999998663611833205,-0.0001154951082520170,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001464999786549,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -118.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.1538461598202094382,1.00000000000000000000,-0.0000392836977971758,0.99999999256924299029,-0.0001154049609900742,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -118.000000000000000000,1.00000000000000000000,-0.4238990828941202604,0.00000000000000000000,-1.2692511216678299401,1.00000000000000000000,-0.0000392836977971758,0.99999999256924299029,-0.0001154049609900742,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813952556200,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -119.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.1538461598202094382,1.00000000000000000000,0.00003613869813290306,0.99999999272441997266,-0.0001150875940239208,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -119.000000000000000000,1.00000000000000000000,0.42075408320086987723,0.00000000000000000000,-1.2689337546814591917,1.00000000000000000000,0.00003613869813290306,0.99999999272441997266,-0.0001150875940239208,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000812400776339,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -120.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-1.1538461666477015654,1.00000000000000000000,0.00011582333048881175,0.99999998666739209340,-0.0001151093898864466,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -120.000000000000000000,1.00000000000000000000,1.26966949099981185611,0.00000000000000000000,-1.2689555580688567371,1.00000000000000000000,0.00011582333048881175,0.99999998666739209340,-0.0001151093898864466,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001464687047700,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -121.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.1538461803026858198,3.00000000000000000000,0.00019230768984220914,0.99999997485207114955,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -122.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.1538462007851630897,3.00000000000000000000,0.00026923076418601120,0.99999995710059208509,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -123.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -124.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -125.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -126.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -127.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -128.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -129.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.9230770164808110855,3.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -130.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.9230769823433486731,3.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -131.000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,-1.9230769595850412123,3.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -132.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -133.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -134.000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,-1.9230769595850412123,3.00000000000000000000,0.00011538461299499319,0.99999997485207114955,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -135.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.9230769823433486731,3.00000000000000000000,0.00019230768756637849,0.99999996301775195828,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -136.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.9230770164808110855,3.00000000000000000000,0.00026923076099984833,0.99999994526627311586,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -137.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -138.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -139.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -140.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -141.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -142.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-2.6923079186580318733,3.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -143.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-2.6923078549347665422,3.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -144.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-2.6923078071423187651,3.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -145.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-2.6923077752806880980,3.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -146.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-2.6923077593498727644,3.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -147.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-2.6923077593498727644,3.00000000000000000000,0.00003846153705810951,0.99999996301775162521,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -148.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-2.6923077752806880980,3.00000000000000000000,0.00011538461094674560,0.99999995710059208509,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -149.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-2.6923078071423187651,3.00000000000000000000,0.00019230768415263250,0.99999994526627311586,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -150.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-2.6923078549347665422,3.00000000000000000000,0.00026923075622060400,0.99999992751479460650,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -151.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-2.6923079186580318733,3.00000000000000000000,0.00034615382669549426,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -152.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -153.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -154.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -155.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -156.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-3.4615388071802710712,3.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -157.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-3.4615387252503571069,3.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -158.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -159.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -160.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -161.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -162.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -163.000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -164.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-3.4615387252503571069,3.00000000000000000000,0.00026923074984827827,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -165.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-3.4615388071802710712,3.00000000000000000000,0.00034615381850250414,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -166.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -167.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -168.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -169.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -170.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -171.000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -172.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -173.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -174.000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -175.000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -176.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -177.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -178.000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -179.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -180.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -181.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -182.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -183.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -184.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -185.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -186.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -187.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -188.000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -189.000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -190.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -191.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -192.000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -193.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -194.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -195.000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -196.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -197.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -198.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -199.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +Ray-ID ,Event-ID ,X-position ,Y-position ,Z-position ,Event-type ,X-direction ,Y-direction ,Z-direction ,Energy ,ElectricField-x-real ,ElectricField-x-imag ,ElectricField-y-real ,ElectricField-y-imag ,ElectricField-z-real ,ElectricField-z-imag ,pathLength ,order ,lastElement ,lightSourceIndex +0.00000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +1.00000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +2.00000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +3.00000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +4.00000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +5.00000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +6.00000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +7.00000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +8.00000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +9.00000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +10.0000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +11.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +12.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +13.0000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +14.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +15.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +16.0000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +17.0000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +18.0000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +19.0000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +20.0000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +21.0000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +22.0000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +23.0000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +24.0000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +25.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +26.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +27.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +28.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +29.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +30.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,3.46153880718027107121,3.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +31.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,3.46153872525035710694,3.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822780,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +32.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +33.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +34.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +35.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +36.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +37.0000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +38.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,3.46153872525035710694,3.00000000000000000000,0.00026923074984827827,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +39.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,3.46153880718027107121,3.00000000000000000000,0.00034615381850250414,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +40.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +41.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +42.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +43.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +44.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,2.69230791865803187334,3.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +45.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,2.69230785493476654224,3.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,0.00026923076597822786,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +46.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,2.69230780714231876515,3.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,0.00026923076597822786,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +47.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,2.69230777528068809800,3.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,0.00026923076597822786,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +48.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,2.69230775934987276443,3.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,0.00026923076597822786,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +49.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,2.69230775934987276443,3.00000000000000000000,0.00003846153705810951,0.99999996301775162521,0.00026923076597822786,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +50.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,2.69230777528068809800,3.00000000000000000000,0.00011538461094674560,0.99999995710059208509,0.00026923076597822786,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +51.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,2.69230780714231876515,3.00000000000000000000,0.00019230768415263250,0.99999994526627311586,0.00026923076597822786,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +52.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,2.69230785493476654224,3.00000000000000000000,0.00026923075622060400,0.99999992751479460650,0.00026923076597822786,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +53.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,2.69230791865803187334,3.00000000000000000000,0.00034615382669549426,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +54.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +55.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +56.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +57.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +58.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +59.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.92307701648081041945,3.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,0.00019230769112236383,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +60.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.92307698234334822906,3.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,0.00019230769112236383,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +61.0000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,1.92307695958504076827,3.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,0.00019230769112236383,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +62.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +63.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +64.0000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,1.92307695958504076827,3.00000000000000000000,0.00011538461299499319,0.99999997485207114955,0.00019230769112236383,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +65.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.92307698234334822906,3.00000000000000000000,0.00019230768756637849,0.99999996301775195828,0.00019230769112236383,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +66.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.92307701648081041945,3.00000000000000000000,0.00026923076099984833,0.99999994526627311586,0.00019230769112236383,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +67.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +68.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +69.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +70.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +71.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +72.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +73.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.15384620078516308971,3.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,0.00011538461512858444,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +74.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.15384618030268581989,3.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,0.00011538461512858444,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +75.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,1.15384616664770156546,1.00000000000000000000,-0.0001154820839444342,0.99999998678627821657,0.00011441735651764090,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +75.0000000000000000000,1.00000000000000000000,-1.2693282444371554174,0.00000000000000000000,1.26826352467722158756,1.00000000000000000000,-0.0001154820839444342,0.99999998678627821657,0.00011441735651764090,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001463498174416,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +76.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.15384615982020943825,1.00000000000000000000,-0.0000385585513016470,0.99999999269039097082,0.00011459692936945851,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +76.0000000000000000000,1.00000000000000000000,-0.4231739363885317906,0.00000000000000000000,1.26844309002732669178,1.00000000000000000000,-0.0000385585513016470,0.99999999269039097082,0.00011459692936945851,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000812741072877,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +77.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.15384615982020943825,1.00000000000000000000,0.00003843007481958899,0.99999999261514438408,0.00011529458190977321,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +77.0000000000000000000,1.00000000000000000000,0.42304545990842634672,0.00000000000000000000,1.26914074258141651441,1.00000000000000000000,0.00003843007481958899,0.99999999261514438408,0.00011529458190977321,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813493534224,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +78.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,1.15384616664770156546,1.00000000000000000000,0.00011522184566990385,0.99999998676565182709,0.00011485914141355163,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +78.0000000000000000000,1.00000000000000000000,1.26906800616156290040,0.00000000000000000000,1.26870530958133920229,1.00000000000000000000,0.00011522184566990385,0.99999998676565182709,0.00011485914141355163,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001463704447814,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +79.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.15384618030268581989,3.00000000000000000000,0.00019230768984220914,0.99999997485207114955,0.00011538461512858444,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +80.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.15384620078516308971,3.00000000000000000000,0.00026923076418601120,0.99999995710059208509,0.00011538461512858444,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +81.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +82.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +83.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +84.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +85.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +86.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +87.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,0.38461539874450018094,3.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,0.00003846153845205580,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +88.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +89.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,0.38461538736534633953,1.00000000000000000000,-0.0001168699164632243,0.99999999244822634913,0.00003801275939869937,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +89.0000000000000000000,1.00000000000000000000,-1.2707160763125724400,0.00000000000000000000,0.42262814705110945956,1.00000000000000000000,-0.0001168699164632243,0.99999999244822634913,0.00003801275939869937,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000815162711660,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +90.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,0.38461538508951564896,3.00000000000000000000,-0.0000384615384236079,0.99999999852070997619,0.00003846153845205580,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +91.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,0.38461538508951564896,3.00000000000000000000,0.00003846153842360791,0.99999999852070997619,0.00003846153845205580,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +92.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,0.38461538736534633953,1.00000000000000000000,0.00011582080801010150,0.99999999254360805167,0.00003870819350673453,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +92.0000000000000000000,1.00000000000000000000,1.26966696784047994306,0.00000000000000000000,0.42332358116070434306,1.00000000000000000000,0.00011582080801010150,0.99999999254360805167,0.00003870819350673453,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000814208906376,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +93.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +94.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,0.38461539874450018094,3.00000000000000000000,0.00026923076577909266,0.99999996301775162521,0.00003846153845205580,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +95.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +96.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +97.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +98.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +99.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +100.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +101.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-0.3846153987445001809,3.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,-0.0000384615384520558,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +102.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +103.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-0.3846153873653463395,1.00000000000000000000,-0.0001156486083869899,0.99999999256154448179,-0.0000387596489162040,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +103.000000000000000000,1.00000000000000000000,-1.2694947682140100830,0.00000000000000000000,-0.4233750365698623063,1.00000000000000000000,-0.0001156486083869899,0.99999999256154448179,-0.0000387596489162040,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000814029535831,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +104.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-0.3846153850895156489,3.00000000000000000000,-0.0000384615384236079,0.99999999852070997619,-0.0000384615384520558,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +105.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-0.3846153850895156489,3.00000000000000000000,0.00003846153842360791,0.99999999852070997619,-0.0000384615384520558,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +106.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-0.3846153873653463395,1.00000000000000000000,0.00011539990873770338,0.99999999260423089175,-0.0000383979065069982,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +106.000000000000000000,1.00000000000000000000,1.26924606855794741555,0.00000000000000000000,-0.4230132941563266579,1.00000000000000000000,0.00011539990873770338,0.99999999260423089175,-0.0000383979065069982,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813602673588,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +107.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +108.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-0.3846153987445001809,3.00000000000000000000,0.00026923076577909266,0.99999996301775162521,-0.0000384615384520558,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +109.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +110.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +111.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +112.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +113.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +114.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +115.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.1538462007851630897,3.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,-0.0001153846151285844,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +116.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.1538461803026858198,3.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,-0.0001153846151285844,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +117.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-1.1538461666477015654,1.00000000000000000000,-0.0001157093021606554,0.99999998663611855409,-0.0001154951082520545,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +117.000000000000000000,1.00000000000000000000,-1.2695554626737537429,0.00000000000000000000,-1.2693412764432190353,1.00000000000000000000,-0.0001157093021606554,0.99999998663611855409,-0.0001154951082520545,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001464999786549,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +118.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.1538461598202094382,1.00000000000000000000,-0.0000392836977972695,0.99999999256924299029,-0.0001154049609899504,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +118.000000000000000000,1.00000000000000000000,-0.4238990828942139632,0.00000000000000000000,-1.2692511216677060392,1.00000000000000000000,-0.0000392836977972695,0.99999999256924299029,-0.0001154049609899504,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813952556200,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +119.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.1538461598202094382,1.00000000000000000000,0.00003613869813277658,0.99999999272442008368,-0.0001150875940239665,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +119.000000000000000000,1.00000000000000000000,0.42075408320074336732,0.00000000000000000000,-1.2689337546815049329,1.00000000000000000000,0.00003613869813277658,0.99999999272442008368,-0.0001150875940239665,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000812400776339,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +120.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-1.1538461666477015654,1.00000000000000000000,0.00011582333048864257,0.99999998666739209340,-0.0001151093898863204,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +120.000000000000000000,1.00000000000000000000,1.26966949099964265812,0.00000000000000000000,-1.2689555580687303937,1.00000000000000000000,0.00011582333048864257,0.99999998666739209340,-0.0001151093898863204,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001464687047700,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +121.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.1538461803026858198,3.00000000000000000000,0.00019230768984220914,0.99999997485207114955,-0.0001153846151285844,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +122.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.1538462007851630897,3.00000000000000000000,0.00026923076418601120,0.99999995710059208509,-0.0001153846151285844,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +123.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +124.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +125.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +126.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +127.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +128.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +129.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.9230770164808110855,3.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,-0.0001923076911223638,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +130.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.9230769823433486731,3.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,-0.0001923076911223638,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +131.000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,-1.9230769595850412123,3.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,-0.0001923076911223638,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +132.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +133.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +134.000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,-1.9230769595850412123,3.00000000000000000000,0.00011538461299499319,0.99999997485207114955,-0.0001923076911223638,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +135.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.9230769823433486731,3.00000000000000000000,0.00019230768756637849,0.99999996301775195828,-0.0001923076911223638,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +136.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.9230770164808110855,3.00000000000000000000,0.00026923076099984833,0.99999994526627311586,-0.0001923076911223638,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +137.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +138.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +139.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +140.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +141.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +142.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-2.6923079186580318733,3.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +143.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-2.6923078549347665422,3.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,-0.0002692307659782278,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +144.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-2.6923078071423187651,3.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,-0.0002692307659782278,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +145.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-2.6923077752806880980,3.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,-0.0002692307659782278,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +146.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-2.6923077593498727644,3.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,-0.0002692307659782278,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +147.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-2.6923077593498727644,3.00000000000000000000,0.00003846153705810951,0.99999996301775162521,-0.0002692307659782278,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +148.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-2.6923077752806880980,3.00000000000000000000,0.00011538461094674560,0.99999995710059208509,-0.0002692307659782278,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +149.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-2.6923078071423187651,3.00000000000000000000,0.00019230768415263250,0.99999994526627311586,-0.0002692307659782278,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +150.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-2.6923078549347665422,3.00000000000000000000,0.00026923075622060400,0.99999992751479460650,-0.0002692307659782278,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +151.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-2.6923079186580318733,3.00000000000000000000,0.00034615382669549426,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +152.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +153.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +154.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +155.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +156.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-3.4615388071802710712,3.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +157.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-3.4615387252503571069,3.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822780,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +158.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +159.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +160.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +161.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +162.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +163.000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +164.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-3.4615387252503571069,3.00000000000000000000,0.00026923074984827827,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +165.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-3.4615388071802710712,3.00000000000000000000,0.00034615381850250414,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +166.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +167.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +168.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +169.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +170.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +171.000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +172.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +173.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +174.000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +175.000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +176.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +177.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +178.000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +179.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +180.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +181.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +182.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +183.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +184.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +185.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +186.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +187.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +188.000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +189.000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +190.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +191.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +192.000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +193.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +194.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +195.000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +196.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +197.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +198.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +199.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 diff --git a/Intern/rayx-core/tests/input/slit4_seeded.correct.csv b/Intern/rayx-core/tests/input/slit4_seeded.correct.csv index 244551c8..9ede066e 100644 --- a/Intern/rayx-core/tests/input/slit4_seeded.correct.csv +++ b/Intern/rayx-core/tests/input/slit4_seeded.correct.csv @@ -1,241 +1,241 @@ -Ray-ID ,Event-ID ,X-position ,Y-position ,Z-position ,Event-type ,X-direction ,Y-direction ,Z-direction ,Energy ,Stokes0 ,Stokes1 ,Stokes2 ,Stokes3 ,pathLength ,order ,lastElement ,lightSourceIndex -0.00000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -1.00000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -2.00000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -3.00000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -4.00000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -5.00000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -6.00000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -7.00000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -8.00000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -9.00000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -10.0000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -11.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -12.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -13.0000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -14.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -15.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -16.0000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -17.0000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -18.0000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -19.0000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -20.0000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -21.0000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -22.0000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -23.0000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -24.0000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -25.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -26.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -27.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -28.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -29.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -30.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,3.46153880718027107121,3.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -31.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,3.46153872525035710694,3.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -32.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -33.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -34.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -35.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -36.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -37.0000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -38.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,3.46153872525035710694,3.00000000000000000000,0.00026923074984827827,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -39.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,3.46153880718027107121,3.00000000000000000000,0.00034615381850250414,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -40.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -41.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -42.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -43.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -44.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,2.69230791865803187334,3.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -45.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,2.69230785493476654224,1.00000000000000000000,-0.0002692409644252768,0.99999992751430055726,0.00026922239266812181,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -45.0000000000000000000,1.00000000000000000000,-2.9615487412999188521,0.00000000000000000000,2.96153026711766331757,1.00000000000000000000,-0.0002692409644252768,0.99999992751430055726,0.00026922239266812181,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0007973378105816,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -46.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,2.69230780714231876515,1.00000000000000000000,-0.0001927226128288288,0.99999994523194479789,0.00026906151995613469,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -46.0000000000000000000,1.00000000000000000000,-2.1157995701673648625,0.00000000000000000000,2.96136934183443045753,1.00000000000000000000,-0.0001927226128288288,0.99999994523194479789,0.00026906151995613469,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0006021053559379,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -47.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,2.69230777528068809800,1.00000000000000000000,-0.0001155150227252248,0.99999995709299827062,0.00026920304774160719,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -47.0000000000000000000,1.00000000000000000000,-1.2693611866484011407,0.00000000000000000000,2.96151083457299124646,1.00000000000000000000,-0.0001155150227252248,0.99999995709299827062,0.00026920304774160719,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004719011012639,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -48.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,2.69230775934987276443,1.00000000000000000000,-0.0000384736113476776,0.99999996298708637709,0.00026934291671249323,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -48.0000000000000000000,1.00000000000000000000,-0.4230889975767349597,0.00000000000000000000,2.96165068603153214255,1.00000000000000000000,-0.0000384736113476776,0.99999996298708637709,0.00026934291671249323,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004068354119226,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -49.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,2.69230775934987276443,1.00000000000000000000,0.00003852996927118085,0.99999996299719928760,0.00026929731017515747,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -49.0000000000000000000,1.00000000000000000000,0.42314535550193449475,0.00000000000000000000,2.96160507948978546366,1.00000000000000000000,0.00003852996927118085,0.99999996299719928760,0.00026929731017515747,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004068253001605,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -50.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,2.69230777528068809800,1.00000000000000000000,0.00011550701343899530,0.99999995707166544622,0.00026928571561249045,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -50.0000000000000000000,1.00000000000000000000,1.26935317736429209567,0.00000000000000000000,2.96159350245316632666,1.00000000000000000000,0.00011550701343899530,0.99999995707166544622,0.00026928571561249045,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004719224325526,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -51.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,2.69230780714231876515,1.00000000000000000000,0.00019209503526153407,0.99999994536496028540,0.00026901593546671374,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -51.0000000000000000000,1.00000000000000000000,2.11517199254014798270,0.00000000000000000000,2.96132375730672947611,1.00000000000000000000,0.00019209503526153407,0.99999994536496028540,0.00026901593546671374,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0006019723405188,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -52.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,2.69230785493476654224,1.00000000000000000000,0.00026918369601633521,0.99999992753349997709,0.00026920834373705731,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -52.0000000000000000000,1.00000000000000000000,2.96149147288165792701,0.00000000000000000000,2.96151621818041155265,1.00000000000000000000,0.00026918369601633521,0.99999992753349997709,0.00026920834373705731,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0007973186111485,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -53.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,2.69230791865803187334,3.00000000000000000000,0.00034615382669549426,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -54.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -55.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -56.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -57.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -58.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -59.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.92307701648081041945,1.00000000000000000000,-0.0002691521530891123,0.99999994532354163911,0.00019211983792135793,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -59.0000000000000000000,1.00000000000000000000,-2.9614599251639206478,0.00000000000000000000,2.11519686490660108191,1.00000000000000000000,-0.0002691521530891123,0.99999994532354163911,0.00019211983792135793,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0006020137589075,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -60.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.92307698234334822906,1.00000000000000000000,-0.0001924173825379351,0.99999996301855487157,0.00019219375551426094,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -60.0000000000000000000,1.00000000000000000000,-2.1154943364373011149,0.00000000000000000000,2.11527074496521239055,1.00000000000000000000,-0.0001924173825379351,0.99999996301855487157,0.00019219375551426094,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004068039397679,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -61.0000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,1.92307695958504076827,1.00000000000000000000,-0.0001155951274376256,0.99999997478543611872,0.00019252764345182113,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -61.0000000000000000000,1.00000000000000000000,-1.2694412893190791802,0.00000000000000000000,2.11560460789136239867,1.00000000000000000000,-0.0001155951274376256,0.99999997478543611872,0.00019252764345182113,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0002766938578133,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -62.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -63.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -64.0000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,1.92307695958504076827,1.00000000000000000000,0.00011537984594422716,0.99999997486911873512,0.00019222188450065887,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -64.0000000000000000000,1.00000000000000000000,1.26922600781059724539,0.00000000000000000000,2.11529884891640485022,1.00000000000000000000,0.00011537984594422716,0.99999997486911873512,0.00019222188450065887,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0002766101752058,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -65.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.92307698234334822906,1.00000000000000000000,0.00019232420115958812,0.99999996300545934690,0.00019235509254745395,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -65.0000000000000000000,1.00000000000000000000,2.11540115505802717166,0.00000000000000000000,2.11543208200689036857,1.00000000000000000000,0.00019232420115958812,0.99999996300545934690,0.00019235509254745395,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004068170364917,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -66.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.92307701648081041945,1.00000000000000000000,0.00026938787153387810,0.99999994525062074757,0.00019216901407382181,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -66.0000000000000000000,1.00000000000000000000,2.96169564364121873367,0.00000000000000000000,2.11524604107576674749,1.00000000000000000000,0.00026938787153387810,0.99999994525062074757,0.00019216901407382181,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0006020866803737,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -67.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -68.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -69.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -70.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -71.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -72.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -73.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.15384620078516308971,1.00000000000000000000,-0.0002691421255607594,0.99999995713671596675,0.00011527828103382556,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -73.0000000000000000000,1.00000000000000000000,-2.9614498944555958104,0.00000000000000000000,1.26912448676019451454,1.00000000000000000000,-0.0002691421255607594,0.99999995713671596675,0.00011527828103382556,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004718573836726,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -74.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.15384618030268581989,1.00000000000000000000,-0.0001922238362132199,0.99999997487156144782,0.00011535542061026099,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -74.0000000000000000000,1.00000000000000000000,-2.1153007878269978192,0.00000000000000000000,1.26920160381164848217,1.00000000000000000000,-0.0001922238362132199,0.99999997487156144782,0.00011535542061026099,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0002766077341220,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -75.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,1.15384616664770156546,3.00000000000000000000,-0.0001153846143604915,0.99999998668639045185,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -76.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.15384615982020943825,3.00000000000000000000,-0.0000384615381960248,0.99999999260355021402,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -77.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.15384615982020943825,3.00000000000000000000,0.00003846153819602484,0.99999999260355021402,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -78.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,1.15384616664770156546,3.00000000000000000000,0.00011538461436049158,0.99999998668639045185,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -79.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.15384618030268581989,1.00000000000000000000,0.00019240687167209740,0.99999997483817593124,0.00011533968567367872,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -79.0000000000000000000,1.00000000000000000000,2.11548382329689887981,0.00000000000000000000,1.26918586887852158362,1.00000000000000000000,0.00019240687167209740,0.99999997483817593124,0.00011533968567367872,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0002766411180346,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -80.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.15384620078516308971,1.00000000000000000000,0.00026931209560648438,0.99999995709084654738,0.00011527922528738352,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -80.0000000000000000000,1.00000000000000000000,2.96161986452095948862,0.00000000000000000000,1.26912543101908070752,1.00000000000000000000,0.00026931209560648438,0.99999995709084654738,0.00011527922528738352,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004719032513094,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -81.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -82.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -83.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -84.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -85.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -86.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -87.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,0.38461539874450018094,1.00000000000000000000,-0.0002688010803090143,0.99999996314016303955,0.00003828383127238041,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -87.0000000000000000000,1.00000000000000000000,-2.9611088475754994142,0.00000000000000000000,0.42289923142801638666,1.00000000000000000000,-0.0002688010803090143,0.99999996314016303955,0.00003828383127238041,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004066823330504,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -88.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -89.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,0.38461538736534633953,3.00000000000000000000,-0.0001153846150432407,0.99999999260355021402,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -90.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,0.38461538508951564896,3.00000000000000000000,-0.0000384615384236079,0.99999999852070997619,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -91.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,0.38461538508951564896,3.00000000000000000000,0.00003846153842360791,0.99999999852070997619,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -92.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,0.38461538736534633953,3.00000000000000000000,0.00011538461504324078,0.99999999260355021402,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -93.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -94.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,0.38461539874450018094,1.00000000000000000000,0.00026936175449216251,0.99999996298271298655,0.00003845539707004488,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -94.0000000000000000000,1.00000000000000000000,2.96166952182172504848,0.00000000000000000000,0.42307079723805957049,1.00000000000000000000,0.00026936175449216251,0.99999996298271298655,0.00003845539707004488,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004068397829541,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -95.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -96.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -97.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -98.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -99.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -100.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -101.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-0.3846153987445001809,1.00000000000000000000,-0.0002691117220862386,0.99999996304157945381,-0.0000386745398197288,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -101.000000000000000000,1.00000000000000000000,-2.9614194893907042072,0.00000000000000000000,-0.4232899399935790563,1.00000000000000000000,-0.0002691117220862386,0.99999996304157945381,-0.0000386745398197288,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004067809168191,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -102.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -103.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-0.3846153873653463395,3.00000000000000000000,-0.0001153846150432407,0.99999999260355021402,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -104.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-0.3846153850895156489,3.00000000000000000000,-0.0000384615384236079,0.99999999852070997619,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -105.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-0.3846153850895156489,3.00000000000000000000,0.00003846153842360791,0.99999999852070997619,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -106.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-0.3846153873653463395,3.00000000000000000000,0.00011538461504324078,0.99999999260355021402,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -107.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -108.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-0.3846153987445001809,1.00000000000000000000,0.00026922733922890340,0.99999996302062221786,-0.0000384108546615499,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -108.000000000000000000,1.00000000000000000000,2.96153510654328400164,0.00000000000000000000,-0.4230262548264596134,1.00000000000000000000,0.00026922733922890340,0.99999996302062221786,-0.0000384108546615499,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004068018752150,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -109.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -110.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -111.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -112.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -113.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -114.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -115.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.1538462007851630897,1.00000000000000000000,-0.0002692322626699718,0.99999995708430111651,-0.0001155222250359876,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -115.000000000000000000,1.00000000000000000000,-2.9615400315827837829,0.00000000000000000000,-1.2693684307788679621,1.00000000000000000000,-0.0002692322626699718,0.99999995708430111651,-0.0001155222250359876,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004719097978522,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -116.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.1538461803026858198,1.00000000000000000000,-0.0001922202029753193,0.99999997496089920723,-0.0001145844415178038,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -116.000000000000000000,1.00000000000000000000,-2.1152971545718335377,0.00000000000000000000,-1.2684306246895808989,1.00000000000000000000,-0.0001922202029753193,0.99999997496089920723,-0.0001145844415178038,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0002765183962765,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -117.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-1.1538461666477015654,3.00000000000000000000,-0.0001153846143604915,0.99999998668639045185,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -118.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.1538461598202094382,3.00000000000000000000,-0.0000384615381960248,0.99999999260355021402,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -119.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.1538461598202094382,3.00000000000000000000,0.00003846153819602484,0.99999999260355021402,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -120.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-1.1538461666477015654,3.00000000000000000000,0.00011538461436049158,0.99999998668639045185,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -121.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.1538461803026858198,1.00000000000000000000,0.00019117852302514445,0.99999997506999993568,-0.0001153723164791972,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -121.000000000000000000,1.00000000000000000000,2.11425547457471862955,0.00000000000000000000,-1.2692184996581150624,1.00000000000000000000,0.00019117852302514445,0.99999997506999993568,-0.0001153723164791972,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0002764092951110,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -122.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.1538462007851630897,1.00000000000000000000,0.00026927961022567362,0.99999995714396472390,-0.0001148936881021068,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -122.000000000000000000,1.00000000000000000000,2.96158737912445158002,0.00000000000000000000,-1.2687398938111580370,1.00000000000000000000,0.00026927961022567362,0.99999995714396472390,-0.0001148936881021068,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004718501331808,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -123.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -124.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -125.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -126.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -127.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -128.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -129.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.9230770164808110855,1.00000000000000000000,-0.0002693891723113105,0.99999994525985869131,-0.0001921191117339393,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -129.000000000000000000,1.00000000000000000000,-2.9616969444162331015,0.00000000000000000000,-2.1151961387313784612,1.00000000000000000000,-0.0002693891723113105,0.99999994525985869131,-0.0001921191117339393,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0006020774417265,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -130.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.9230769823433486731,1.00000000000000000000,-0.0001922123896310133,0.99999996302407301307,-0.0001923700851409101,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -130.000000000000000000,1.00000000000000000000,-2.1152893435217379192,0.00000000000000000000,-2.1154470745973212864,1.00000000000000000000,-0.0001922123896310133,0.99999996302407301307,-0.0001923700851409101,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004067984227731,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -131.000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,-1.9230769595850412123,1.00000000000000000000,-0.0001152210686120258,0.99999997488058700589,-0.0001922574595055099,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -131.000000000000000000,1.00000000000000000000,-1.2690672304730843400,0.00000000000000000000,-2.1153344239199460830,1.00000000000000000000,-0.0001152210686120258,0.99999997488058700589,-0.0001922574595055099,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0002765987082966,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -132.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -133.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -134.000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,-1.9230769595850412123,1.00000000000000000000,0.00011545862683035524,0.99999997486450364903,-0.0001921985883755165,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -134.000000000000000000,1.00000000000000000000,1.26930478869923790696,0.00000000000000000000,-2.1152755527915645394,1.00000000000000000000,0.00011545862683035524,0.99999997486450364903,-0.0001921985883755165,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0002766147918009,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -135.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.9230769823433486731,1.00000000000000000000,0.00019224468560696797,0.99999996302722193863,-0.0001923214372896189,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -135.000000000000000000,1.00000000000000000000,2.11532163949828166948,0.00000000000000000000,-2.1153984267436256594,1.00000000000000000000,0.00019224468560696797,0.99999996302722193863,-0.0001923214372896189,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004067952722834,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -136.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.9230770164808110855,1.00000000000000000000,0.00026875499660079321,0.99999994539148184813,-0.0001923220860686374,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -136.000000000000000000,1.00000000000000000000,2.96106276863562678514,0.00000000000000000000,-2.1153991130518732255,1.00000000000000000000,0.00026875499660079321,0.99999994539148184813,-0.0001923220860686374,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0006019458196533,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -137.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -138.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -139.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -140.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -141.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -142.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-2.6923079186580318733,3.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -143.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-2.6923078549347665422,1.00000000000000000000,-0.0002692409345845270,0.99999992751282440472,-0.0002692279053599031,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -143.000000000000000000,1.00000000000000000000,-2.9615487114595642204,0.00000000000000000000,-2.9615357798102412978,1.00000000000000000000,-0.0002692409345845270,0.99999992751282440472,-0.0002692279053599031,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0007973392857820,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -144.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-2.6923078071423187651,1.00000000000000000000,-0.0001921172751030299,0.99999994529700220180,-0.0002692525672093489,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -144.000000000000000000,1.00000000000000000000,-2.1151942323959143088,0.00000000000000000000,-2.9615603890805912712,1.00000000000000000000,-0.0001921172751030299,0.99999994529700220180,-0.0002692525672093489,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0006020402997819,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -145.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-2.6923077752806880980,1.00000000000000000000,-0.0001153696074595979,0.99999995713252398665,-0.0002691185684296909,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -145.000000000000000000,1.00000000000000000000,-1.2692157713719751654,0.00000000000000000000,-2.9614263552468131912,1.00000000000000000000,-0.0001153696074595979,0.99999995713252398665,-0.0002691185684296909,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004718615746241,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -146.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-2.6923077593498727644,1.00000000000000000000,-0.0000383102103565628,0.99999996304012317427,-0.0002691692395997807,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -146.000000000000000000,1.00000000000000000000,-0.4229255965775403636,0.00000000000000000000,-2.9614770088981154927,1.00000000000000000000,-0.0000383102103565628,0.99999996304012317427,-0.0002691692395997807,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004067823756486,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -147.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-2.6923077593498727644,1.00000000000000000000,0.00003835970863912767,0.99999996301855587077,-0.0002692423060062783,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -147.000000000000000000,1.00000000000000000000,0.42297509486276196888,0.00000000000000000000,-2.9615500753131209776,1.00000000000000000000,0.00003835970863912767,0.99999996301855587077,-0.0002692423060062783,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004068039434059,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -148.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-2.6923077752806880980,1.00000000000000000000,0.00011554053451002235,0.99999995711865785619,-0.0002690967610994285,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -148.000000000000000000,1.00000000000000000000,1.26938669843132867498,0.00000000000000000000,-2.9614045479193471521,1.00000000000000000000,0.00011554053451002235,0.99999995711865785619,-0.0002690967610994285,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004718754407804,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -149.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-2.6923078071423187651,1.00000000000000000000,0.00019220529042418516,0.99999994528435498519,-0.0002692367240364833,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -149.000000000000000000,1.00000000000000000000,2.11528224772431538980,0.00000000000000000000,-2.9615445459102636149,1.00000000000000000000,0.00019220529042418516,0.99999994528435498519,-0.0002692367240364833,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0006020529472152,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -150.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-2.6923078549347665422,1.00000000000000000000,0.00026913751885851921,0.99999992739923826423,-0.0002697526907333218,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -150.000000000000000000,1.00000000000000000000,2.96144529575663018050,0.00000000000000000000,-2.9620605652523406270,1.00000000000000000000,0.00026913751885851921,0.99999992739923826423,-0.0002697526907333218,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0007974528725753,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -151.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-2.6923079186580318733,3.00000000000000000000,0.00034615382669549426,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -152.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -153.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -154.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -155.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -156.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-3.4615388071802710712,3.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -157.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-3.4615387252503571069,3.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -158.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -159.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -160.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -161.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -162.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -163.000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -164.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-3.4615387252503571069,3.00000000000000000000,0.00026923074984827827,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -165.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-3.4615388071802710712,3.00000000000000000000,0.00034615381850250414,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -166.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -167.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -168.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -169.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -170.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -171.000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -172.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -173.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -174.000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -175.000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -176.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -177.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -178.000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -179.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -180.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -181.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -182.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -183.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -184.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -185.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -186.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -187.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -188.000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -189.000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -190.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -191.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -192.000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -193.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -194.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -195.000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -196.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -197.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -198.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -199.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +Ray-ID ,Event-ID ,X-position ,Y-position ,Z-position ,Event-type ,X-direction ,Y-direction ,Z-direction ,Energy ,ElectricField-x-real ,ElectricField-x-imag ,ElectricField-y-real ,ElectricField-y-imag ,ElectricField-z-real ,ElectricField-z-imag ,pathLength ,order ,lastElement ,lightSourceIndex +0.00000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +1.00000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +2.00000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +3.00000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +4.00000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +5.00000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +6.00000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +7.00000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +8.00000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +9.00000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +10.0000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +11.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +12.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +13.0000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +14.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +15.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +16.0000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +17.0000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +18.0000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +19.0000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +20.0000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +21.0000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +22.0000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +23.0000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +24.0000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +25.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +26.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +27.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +28.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +29.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +30.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,3.46153880718027107121,3.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +31.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,3.46153872525035710694,3.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822780,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +32.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +33.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +34.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +35.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +36.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +37.0000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +38.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,3.46153872525035710694,3.00000000000000000000,0.00026923074984827827,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +39.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,3.46153880718027107121,3.00000000000000000000,0.00034615381850250414,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +40.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +41.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +42.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +43.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +44.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,2.69230791865803187334,3.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +45.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,2.69230785493476654224,1.00000000000000000000,-0.0002692409644252430,0.99999992751430055726,0.00026922239266815158,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +45.0000000000000000000,1.00000000000000000000,-2.9615487412998851013,0.00000000000000000000,2.96153026711769307155,1.00000000000000000000,-0.0002692409644252430,0.99999992751430055726,0.00026922239266815158,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0007973378105816,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +46.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,2.69230780714231876515,1.00000000000000000000,-0.0001927226128289306,0.99999994523194490891,0.00026906151995610715,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +46.0000000000000000000,1.00000000000000000000,-2.1157995701674665589,0.00000000000000000000,2.96136934183440292400,1.00000000000000000000,-0.0001927226128289306,0.99999994523194490891,0.00026906151995610715,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0006021053559379,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +47.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,2.69230777528068809800,1.00000000000000000000,-0.0001155150227252578,0.99999995709299838164,0.00026920304774158670,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +47.0000000000000000000,1.00000000000000000000,-1.2693611866484342254,0.00000000000000000000,2.96151083457297037426,1.00000000000000000000,-0.0001155150227252578,0.99999995709299838164,0.00026920304774158670,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004719011012639,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +48.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,2.69230775934987276443,1.00000000000000000000,-0.0000384736113477023,0.99999996298708648811,0.00026934291671261033,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +48.0000000000000000000,1.00000000000000000000,-0.4230889975767596622,0.00000000000000000000,2.96165068603164938210,1.00000000000000000000,-0.0000384736113477023,0.99999996298708648811,0.00026934291671261033,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004068354119226,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +49.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,2.69230775934987276443,1.00000000000000000000,0.00003852996927107160,0.99999996299719939862,0.00026929731017515443,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +49.0000000000000000000,1.00000000000000000000,0.42314535550182519330,0.00000000000000000000,2.96160507948978235504,1.00000000000000000000,0.00003852996927107160,0.99999996299719939862,0.00026929731017515443,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004068253001605,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +50.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,2.69230777528068809800,1.00000000000000000000,0.00011550701343901151,0.99999995707166566827,0.00026928571561251322,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +50.0000000000000000000,1.00000000000000000000,1.26935317736430830493,0.00000000000000000000,2.96159350245318897520,1.00000000000000000000,0.00011550701343901151,0.99999995707166566827,0.00026928571561251322,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004719224325526,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +51.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,2.69230780714231876515,1.00000000000000000000,0.00019209503526156039,0.99999994536496050745,0.00026901593546685182,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +51.0000000000000000000,1.00000000000000000000,2.11517199254017418397,0.00000000000000000000,2.96132375730686758785,1.00000000000000000000,0.00019209503526156039,0.99999994536496050745,0.00026901593546685182,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0006019723405188,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +52.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,2.69230785493476654224,1.00000000000000000000,0.00026918369601629525,0.99999992753350008811,0.00026920834373708225,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +52.0000000000000000000,1.00000000000000000000,2.96149147288161795898,0.00000000000000000000,2.96151621818043642164,1.00000000000000000000,0.00026918369601629525,0.99999992753350008811,0.00026920834373708225,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0007973186111485,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +53.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,2.69230791865803187334,3.00000000000000000000,0.00034615382669549426,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +54.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +55.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +56.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +57.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +58.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +59.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.92307701648081041945,1.00000000000000000000,-0.0002691521530892430,0.99999994532354175014,0.00019211983792141224,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +59.0000000000000000000,1.00000000000000000000,-2.9614599251640512100,0.00000000000000000000,2.11519686490665570488,1.00000000000000000000,-0.0002691521530892430,0.99999994532354175014,0.00019211983792141224,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0006020137589075,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +60.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.92307698234334822906,1.00000000000000000000,-0.0001924173825379328,0.99999996301855487157,0.00019219375551422332,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +60.0000000000000000000,1.00000000000000000000,-2.1154943364372988945,0.00000000000000000000,2.11527074496517464297,1.00000000000000000000,-0.0001924173825379328,0.99999996301855487157,0.00019219375551422332,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004068039397679,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +61.0000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,1.92307695958504076827,1.00000000000000000000,-0.0001155951274377801,0.99999997478543622975,0.00019252764345193429,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +61.0000000000000000000,1.00000000000000000000,-1.2694412893192337232,0.00000000000000000000,2.11560460789147564142,1.00000000000000000000,-0.0001155951274377801,0.99999997478543622975,0.00019252764345193429,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0002766938578133,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +62.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +63.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +64.0000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,1.92307695958504076827,1.00000000000000000000,0.00011537984594410054,0.99999997486911884614,0.00019222188450075290,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +64.0000000000000000000,1.00000000000000000000,1.26922600781047067997,0.00000000000000000000,2.11529884891649899714,1.00000000000000000000,0.00011537984594410054,0.99999997486911884614,0.00019222188450075290,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0002766101752058,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +65.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.92307698234334822906,1.00000000000000000000,0.00019232420115942861,0.99999996300545934690,0.00019235509254756318,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +65.0000000000000000000,1.00000000000000000000,2.11540115505786774363,0.00000000000000000000,2.11543208200699961452,1.00000000000000000000,0.00019232420115942861,0.99999996300545934690,0.00019235509254756318,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004068170364917,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +66.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.92307701648081041945,1.00000000000000000000,0.00026938787153380492,0.99999994525062085859,0.00019216901407380463,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +66.0000000000000000000,1.00000000000000000000,2.96169564364114545895,0.00000000000000000000,2.11524604107574987210,1.00000000000000000000,0.00026938787153380492,0.99999994525062085859,0.00019216901407380463,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0006020866803737,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +67.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +68.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +69.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +70.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +71.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +72.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +73.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.15384620078516308971,1.00000000000000000000,-0.0002691421255608025,0.99999995713671618879,0.00011527828103379168,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +73.0000000000000000000,1.00000000000000000000,-2.9614498944556388870,0.00000000000000000000,1.26912448676016054172,1.00000000000000000000,-0.0002691421255608025,0.99999995713671618879,0.00011527828103379168,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004718573836726,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +74.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.15384618030268581989,1.00000000000000000000,-0.0001922238362132145,0.99999997487156155884,0.00011535542061038534,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +74.0000000000000000000,1.00000000000000000000,-2.1153007878269924901,0.00000000000000000000,1.26920160381177282715,1.00000000000000000000,-0.0001922238362132145,0.99999997487156155884,0.00011535542061038534,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0002766077341220,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +75.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,1.15384616664770156546,3.00000000000000000000,-0.0001153846143604915,0.99999998668639045185,0.00011538461512858444,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +76.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.15384615982020943825,3.00000000000000000000,-0.0000384615381960248,0.99999999260355021402,0.00011538461512858444,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +77.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.15384615982020943825,3.00000000000000000000,0.00003846153819602484,0.99999999260355021402,0.00011538461512858444,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +78.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,1.15384616664770156546,3.00000000000000000000,0.00011538461436049158,0.99999998668639045185,0.00011538461512858444,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +79.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.15384618030268581989,1.00000000000000000000,0.00019240687167209949,0.99999997483817593124,0.00011533968567382738,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +79.0000000000000000000,1.00000000000000000000,2.11548382329690110026,0.00000000000000000000,1.26918586887867013146,1.00000000000000000000,0.00019240687167209949,0.99999997483817593124,0.00011533968567382738,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0002766411180346,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +80.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.15384620078516308971,1.00000000000000000000,0.00026931209560639434,0.99999995709084676942,0.00011527922528743336,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +80.0000000000000000000,1.00000000000000000000,2.96161986452086933852,0.00000000000000000000,1.26912543101913044552,1.00000000000000000000,0.00026931209560639434,0.99999995709084676942,0.00011527922528743336,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004719032513094,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +81.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +82.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +83.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +84.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +85.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +86.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +87.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,0.38461539874450018094,1.00000000000000000000,-0.0002688010803090864,0.99999996314016303955,0.00003828383127251092,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +87.0000000000000000000,1.00000000000000000000,-2.9611088475755713567,0.00000000000000000000,0.42289923142814689338,1.00000000000000000000,-0.0002688010803090864,0.99999996314016303955,0.00003828383127251092,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004066823330504,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +88.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +89.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,0.38461538736534633953,3.00000000000000000000,-0.0001153846150432407,0.99999999260355021402,0.00003846153845205580,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +90.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,0.38461538508951564896,3.00000000000000000000,-0.0000384615384236079,0.99999999852070997619,0.00003846153845205580,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +91.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,0.38461538508951564896,3.00000000000000000000,0.00003846153842360791,0.99999999852070997619,0.00003846153845205580,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +92.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,0.38461538736534633953,3.00000000000000000000,0.00011538461504324078,0.99999999260355021402,0.00003846153845205580,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +93.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +94.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,0.38461539874450018094,1.00000000000000000000,0.00026936175449212380,0.99999996298271309758,0.00003845539707008649,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +94.0000000000000000000,1.00000000000000000000,2.96166952182168641272,0.00000000000000000000,0.42307079723810120386,1.00000000000000000000,0.00026936175449212380,0.99999996298271309758,0.00003845539707008649,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004068397829541,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +95.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +96.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +97.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +98.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +99.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +100.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +101.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-0.3846153987445001809,1.00000000000000000000,-0.0002691117220862153,0.99999996304157978688,-0.0000386745398197159,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +101.000000000000000000,1.00000000000000000000,-2.9614194893906806704,0.00000000000000000000,-0.4232899399935661222,1.00000000000000000000,-0.0002691117220862153,0.99999996304157978688,-0.0000386745398197159,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004067809168191,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +102.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +103.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-0.3846153873653463395,3.00000000000000000000,-0.0001153846150432407,0.99999999260355021402,-0.0000384615384520558,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +104.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-0.3846153850895156489,3.00000000000000000000,-0.0000384615384236079,0.99999999852070997619,-0.0000384615384520558,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +105.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-0.3846153850895156489,3.00000000000000000000,0.00003846153842360791,0.99999999852070997619,-0.0000384615384520558,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +106.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-0.3846153873653463395,3.00000000000000000000,0.00011538461504324078,0.99999999260355021402,-0.0000384615384520558,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +107.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +108.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-0.3846153987445001809,1.00000000000000000000,0.00026922733922881146,0.99999996302062232889,-0.0000384108546614249,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +108.000000000000000000,1.00000000000000000000,2.96153510654319207517,0.00000000000000000000,-0.4230262548263346022,1.00000000000000000000,0.00026922733922881146,0.99999996302062232889,-0.0000384108546614249,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004068018752150,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +109.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +110.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +111.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +112.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +113.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +114.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +115.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.1538462007851630897,1.00000000000000000000,-0.0002692322626699663,0.99999995708430111651,-0.0001155222250360185,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +115.000000000000000000,1.00000000000000000000,-2.9615400315827784538,0.00000000000000000000,-1.2693684307788988263,1.00000000000000000000,-0.0002692322626699663,0.99999995708430111651,-0.0001155222250360185,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004719097978522,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +116.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.1538461803026858198,1.00000000000000000000,-0.0001922202029754720,0.99999997496089931825,-0.0001145844415177322,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +116.000000000000000000,1.00000000000000000000,-2.1152971545719863044,0.00000000000000000000,-1.2684306246895094005,1.00000000000000000000,-0.0001922202029754720,0.99999997496089931825,-0.0001145844415177322,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0002765183962765,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +117.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-1.1538461666477015654,3.00000000000000000000,-0.0001153846143604915,0.99999998668639045185,-0.0001153846151285844,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +118.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.1538461598202094382,3.00000000000000000000,-0.0000384615381960248,0.99999999260355021402,-0.0001153846151285844,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +119.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.1538461598202094382,3.00000000000000000000,0.00003846153819602484,0.99999999260355021402,-0.0001153846151285844,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +120.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-1.1538461666477015654,3.00000000000000000000,0.00011538461436049158,0.99999998668639045185,-0.0001153846151285844,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +121.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.1538461803026858198,1.00000000000000000000,0.00019117852302511246,0.99999997507000015772,-0.0001153723164792105,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +121.000000000000000000,1.00000000000000000000,2.11425547457468665513,0.00000000000000000000,-1.2692184996581283851,1.00000000000000000000,0.00019117852302511246,0.99999997507000015772,-0.0001153723164792105,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0002764092951110,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +122.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.1538462007851630897,1.00000000000000000000,0.00026927961022563812,0.99999995714396505697,-0.0001148936881020093,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +122.000000000000000000,1.00000000000000000000,2.96158737912441560879,0.00000000000000000000,-1.2687398938110605595,1.00000000000000000000,0.00026927961022563812,0.99999995714396505697,-0.0001148936881020093,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004718501331808,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +123.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +124.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +125.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +126.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +127.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +128.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +129.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.9230770164808110855,1.00000000000000000000,-0.0002693891723113607,0.99999994525985880233,-0.0001921191117338292,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +129.000000000000000000,1.00000000000000000000,-2.9616969444162832836,0.00000000000000000000,-2.1151961387312683271,1.00000000000000000000,-0.0002693891723113607,0.99999994525985880233,-0.0001921191117338292,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0006020774417265,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +130.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.9230769823433486731,1.00000000000000000000,-0.0001922123896311106,0.99999996302407312409,-0.0001923700851408126,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +130.000000000000000000,1.00000000000000000000,-2.1152893435218351747,0.00000000000000000000,-2.1154470745972240308,1.00000000000000000000,-0.0001922123896311106,0.99999996302407312409,-0.0001923700851408126,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004067984227731,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +131.000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,-1.9230769595850412123,1.00000000000000000000,-0.0001152210686121552,0.99999997488058689487,-0.0001922574595055010,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +131.000000000000000000,1.00000000000000000000,-1.2690672304732137920,0.00000000000000000000,-2.1153344239199372012,1.00000000000000000000,-0.0001152210686121552,0.99999997488058689487,-0.0001922574595055010,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0002765987082966,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +132.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +133.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +134.000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,-1.9230769595850412123,1.00000000000000000000,0.00011545862683037218,0.99999997486450376005,-0.0001921985883754554,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +134.000000000000000000,1.00000000000000000000,1.26930478869925478235,0.00000000000000000000,-2.1152755527915036992,1.00000000000000000000,0.00011545862683037218,0.99999997486450376005,-0.0001921985883754554,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0002766147918009,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +135.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.9230769823433486731,1.00000000000000000000,0.00019224468560699690,0.99999996302722216068,-0.0001923214372894579,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +135.000000000000000000,1.00000000000000000000,2.11532163949831053528,0.00000000000000000000,-2.1153984267434648991,1.00000000000000000000,0.00019224468560699690,0.99999996302722216068,-0.0001923214372894579,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004067952722834,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +136.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.9230770164808110855,1.00000000000000000000,0.00026875499660066875,0.99999994539148207017,-0.0001923220860686534,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +136.000000000000000000,1.00000000000000000000,2.96106276863550199607,0.00000000000000000000,-2.1153991130518892127,1.00000000000000000000,0.00026875499660066875,0.99999994539148207017,-0.0001923220860686534,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0006019458196533,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +137.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +138.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +139.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +140.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +141.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +142.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-2.6923079186580318733,3.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +143.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-2.6923078549347665422,1.00000000000000000000,-0.0002692409345846584,0.99999992751282440472,-0.0002692279053599452,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +143.000000000000000000,1.00000000000000000000,-2.9615487114596956708,0.00000000000000000000,-2.9615357798102834863,1.00000000000000000000,-0.0002692409345846584,0.99999992751282440472,-0.0002692279053599452,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0007973392857820,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +144.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-2.6923078071423187651,1.00000000000000000000,-0.0001921172751031864,0.99999994529700231282,-0.0002692525672093907,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +144.000000000000000000,1.00000000000000000000,-2.1151942323960706282,0.00000000000000000000,-2.9615603890806330156,1.00000000000000000000,-0.0001921172751031864,0.99999994529700231282,-0.0002692525672093907,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0006020402997819,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +145.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-2.6923077752806880980,1.00000000000000000000,-0.0001153696074597206,0.99999995713252387563,-0.0002691185684295547,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +145.000000000000000000,1.00000000000000000000,-1.2692157713720977341,0.00000000000000000000,-2.9614263552466768558,1.00000000000000000000,-0.0001153696074597206,0.99999995713252387563,-0.0002691185684295547,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004718615746241,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +146.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-2.6923077593498727644,1.00000000000000000000,-0.0000383102103565935,0.99999996304012339631,-0.0002691692395996669,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +146.000000000000000000,1.00000000000000000000,-0.4229255965775710612,0.00000000000000000000,-2.9614770088980018059,1.00000000000000000000,-0.0000383102103565935,0.99999996304012339631,-0.0002691692395996669,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004067823756486,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +147.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-2.6923077593498727644,1.00000000000000000000,0.00003835970863909812,0.99999996301855598179,-0.0002692423060061400,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +147.000000000000000000,1.00000000000000000000,0.42297509486273238143,0.00000000000000000000,-2.9615500753129824218,1.00000000000000000000,0.00003835970863909812,0.99999996301855598179,-0.0002692423060061400,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004068039434059,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +148.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-2.6923077752806880980,1.00000000000000000000,0.00011554053451003388,0.99999995711865807823,-0.0002690967610994217,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +148.000000000000000000,1.00000000000000000000,1.26938669843134022130,0.00000000000000000000,-2.9614045479193404908,1.00000000000000000000,0.00011554053451003388,0.99999995711865807823,-0.0002690967610994217,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0004718754407804,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +149.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-2.6923078071423187651,1.00000000000000000000,0.00019220529042416497,0.99999994528435487417,-0.0002692367240364972,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +149.000000000000000000,1.00000000000000000000,2.11528224772429540578,0.00000000000000000000,-2.9615445459102778258,1.00000000000000000000,0.00019220529042416497,0.99999994528435487417,-0.0002692367240364972,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0006020529472152,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +150.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-2.6923078549347665422,1.00000000000000000000,0.00026913751885855916,0.99999992739923826423,-0.0002697526907331927,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +150.000000000000000000,1.00000000000000000000,2.96144529575667014853,0.00000000000000000000,-2.9620605652522113970,1.00000000000000000000,0.00026913751885855916,0.99999992739923826423,-0.0002697526907331927,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0007974528725753,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +151.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-2.6923079186580318733,3.00000000000000000000,0.00034615382669549426,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +152.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +153.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +154.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +155.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +156.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-3.4615388071802710712,3.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +157.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-3.4615387252503571069,3.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822780,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +158.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +159.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +160.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +161.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +162.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +163.000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +164.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-3.4615387252503571069,3.00000000000000000000,0.00026923074984827827,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0009615385242796,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +165.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-3.4615388071802710712,3.00000000000000000000,0.00034615381850250414,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0011982249488937,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +166.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +167.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +168.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +169.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +170.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +171.000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +172.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +173.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +174.000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +175.000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +176.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +177.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +178.000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +179.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +180.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +181.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +182.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +183.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +184.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +185.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +186.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +187.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +188.000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +189.000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +190.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +191.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +192.000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +193.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +194.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +195.000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +196.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +197.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +198.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +199.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 diff --git a/Intern/rayx-core/tests/input/slit5_seeded.correct.csv b/Intern/rayx-core/tests/input/slit5_seeded.correct.csv index 6fc817b1..ed02f8b2 100644 --- a/Intern/rayx-core/tests/input/slit5_seeded.correct.csv +++ b/Intern/rayx-core/tests/input/slit5_seeded.correct.csv @@ -1,217 +1,217 @@ -Ray-ID ,Event-ID ,X-position ,Y-position ,Z-position ,Event-type ,X-direction ,Y-direction ,Z-direction ,Energy ,Stokes0 ,Stokes1 ,Stokes2 ,Stokes3 ,pathLength ,order ,lastElement ,lightSourceIndex -0.00000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -1.00000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -2.00000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -3.00000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -4.00000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -5.00000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -6.00000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -7.00000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -8.00000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -9.00000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -10.0000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -11.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -12.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -13.0000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -14.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -15.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -16.0000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -17.0000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -18.0000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -19.0000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -20.0000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -21.0000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -22.0000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -23.0000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -24.0000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -25.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -26.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -27.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -28.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -29.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -30.0000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,3.80769268789829817833,1.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013180474416003,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -31.0000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,3.80769259777539259559,1.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -32.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -33.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -34.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -35.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -36.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -37.0000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -38.0000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,3.80769259777539259559,1.00000000000000000000,0.00026923074984827827,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -39.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,3.80769268789829817833,1.00000000000000000000,0.00034615381850250414,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013180474416003,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -40.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -41.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -42.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -43.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -44.0000000000000000000,0.00000000000000000000,-3.8076924597746999445,0.00000000000000000000,2.96153871052383488304,1.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -45.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,2.69230785493476654224,3.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -46.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,2.69230780714231876515,3.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -47.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,2.69230777528068809800,3.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -48.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,2.69230775934987276443,3.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -49.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,2.69230775934987276443,3.00000000000000000000,0.00003846153705810951,0.99999996301775162521,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -50.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,2.69230777528068809800,3.00000000000000000000,0.00011538461094674560,0.99999995710059208509,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -51.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,2.69230780714231876515,3.00000000000000000000,0.00019230768415263250,0.99999994526627311586,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -52.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,2.69230785493476654224,3.00000000000000000000,0.00026923075622060400,0.99999992751479460650,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -53.0000000000000000000,0.00000000000000000000,3.80769245977469994457,0.00000000000000000000,2.96153871052383488304,1.00000000000000000000,0.00034615382669549426,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -54.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -55.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -56.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -57.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -58.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -59.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.92307701648081041945,3.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -60.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.92307698234334822906,3.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -61.0000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,1.92307695958504076827,3.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -62.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -63.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -64.0000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,1.92307695958504076827,3.00000000000000000000,0.00011538461299499319,0.99999997485207114955,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -65.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.92307698234334822906,3.00000000000000000000,0.00019230768756637849,0.99999996301775195828,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -66.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.92307701648081041945,3.00000000000000000000,0.00026923076099984833,0.99999994526627311586,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -67.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -68.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -69.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -70.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -71.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -72.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -73.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.15384620078516308971,3.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -74.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.15384618030268581989,3.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -75.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,1.15384616664770156546,1.00000000000000000000,-0.0001154820847316520,0.99999998678627899373,0.00011441734870385890,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -75.0000000000000000000,1.00000000000000000000,-1.2693282452243730418,0.00000000000000000000,1.26826351686343929969,1.00000000000000000000,-0.0001154820847316520,0.99999998678627899373,0.00011441734870385890,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001463498174416,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -76.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.15384615982020943825,1.00000000000000000000,-0.0000385585520853334,0.99999999269039141491,0.00011459692300633085,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -76.0000000000000000000,1.00000000000000000000,-0.4231739371722182396,0.00000000000000000000,1.26844308366419888933,1.00000000000000000000,-0.0000385585520853334,0.99999999269039141491,0.00011459692300633085,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000812741072877,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -77.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.15384615982020943825,1.00000000000000000000,0.00003843007456557729,0.99999999261514438408,0.00011529458118250352,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -77.0000000000000000000,1.00000000000000000000,0.42304545965441464616,0.00000000000000000000,1.26914074185414693651,1.00000000000000000000,0.00003843007456557729,0.99999999261514438408,0.00011529458118250352,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813493534224,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -78.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,1.15384616664770156546,1.00000000000000000000,0.00011522184435501262,0.99999998676565249322,0.00011485913716854261,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -78.0000000000000000000,1.00000000000000000000,1.26906800484667159345,0.00000000000000000000,1.26870530533632996927,1.00000000000000000000,0.00011522184435501262,0.99999998676565249322,0.00011485913716854261,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001463704447814,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -79.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.15384618030268581989,3.00000000000000000000,0.00019230768984220914,0.99999997485207114955,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -80.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.15384620078516308971,3.00000000000000000000,0.00026923076418601120,0.99999995710059208509,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -81.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -82.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -83.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -84.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -85.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -86.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -87.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,0.38461539874450018094,3.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -88.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -89.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,0.38461538736534633953,1.00000000000000000000,-0.0001168699284617800,0.99999999244822479482,0.00003801275577341905,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -89.0000000000000000000,1.00000000000000000000,-1.2707160883111283666,0.00000000000000000000,0.42262814342582916138,1.00000000000000000000,-0.0001168699284617800,0.99999999244822479482,0.00003801275577341905,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000815162729850,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -90.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,0.38461538508951564896,1.00000000000000000000,-0.0000383759242446750,0.99999999852311294290,0.00003848457433618199,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -90.0000000000000000000,1.00000000000000000000,-0.4229913091063887131,0.00000000000000000000,0.42309995948253498188,1.00000000000000000000,-0.0000383759242446750,0.99999999852311294290,0.00003848457433618199,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162697870109,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -91.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,0.38461538508951564896,1.00000000000000000000,0.00003830273210150070,0.99999999852728460592,0.00003844907392670730,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -91.0000000000000000000,1.00000000000000000000,0.42291811696294656641,0.00000000000000000000,0.42306445907284750962,1.00000000000000000000,0.00003830273210150070,0.99999999852728460592,0.00003844907392670730,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162656160682,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -92.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,0.38461538736534633953,1.00000000000000000000,0.00011582081153378832,0.99999999254360749656,0.00003870819549915777,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -92.0000000000000000000,1.00000000000000000000,1.26966697136416684088,0.00000000000000000000,0.42332358315312762497,1.00000000000000000000,0.00011582081153378832,0.99999999254360749656,0.00003870819549915777,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000814208906376,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -93.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -94.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,0.38461539874450018094,3.00000000000000000000,0.00026923076577909266,0.99999996301775162521,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -95.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -96.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -97.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -98.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -99.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -100.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -101.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-0.3846153987445001809,3.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -102.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -103.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-0.3846153873653463395,1.00000000000000000000,-0.0001156486105194926,0.99999999256154392668,-0.0000387596513243979,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -103.000000000000000000,1.00000000000000000000,-1.2694947703465127020,0.00000000000000000000,-0.4233750389780562839,1.00000000000000000000,-0.0001156486105194926,0.99999999256154392668,-0.0000387596513243979,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000814029535831,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -104.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-0.3846153850895156489,1.00000000000000000000,-0.0000387536804604987,0.99999999851625498425,-0.0000382837061612483,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -104.000000000000000000,1.00000000000000000000,-0.4233690653230361422,0.00000000000000000000,-0.4228990913075672541,1.00000000000000000000,-0.0000387536804604987,0.99999999851625498425,-0.0000382837061612483,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162766446010,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -105.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-0.3846153850895156489,1.00000000000000000000,0.00003819513406181887,0.99999999852483334450,-0.0000386194852137848,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -105.000000000000000000,1.00000000000000000000,0.42281051892319987395,0.00000000000000000000,-0.4232348703602706319,1.00000000000000000000,0.00003819513406181887,0.99999999852483334450,-0.0000386194852137848,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162680662469,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -106.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-0.3846153873653463395,1.00000000000000000000,0.00011539990886136279,0.99999999260423089175,-0.0000383979059929776,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -106.000000000000000000,1.00000000000000000000,1.26924606868160694261,0.00000000000000000000,-0.4230132936423059986,1.00000000000000000000,0.00011539990886136279,0.99999999260423089175,-0.0000383979059929776,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813602673588,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -107.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -108.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-0.3846153987445001809,3.00000000000000000000,0.00026923076577909266,0.99999996301775162521,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -109.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -110.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -111.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -112.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -113.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -114.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -115.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.1538462007851630897,3.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -116.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.1538461803026858198,3.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -117.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-1.1538461666477015654,1.00000000000000000000,-0.0001157093047835151,0.99999998663611799898,-0.0001154951091446364,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -117.000000000000000000,1.00000000000000000000,-1.2695554652966134501,0.00000000000000000000,-1.2693412773358010436,1.00000000000000000000,-0.0001157093047835151,0.99999998663611799898,-0.0001154951091446364,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001464999786549,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -118.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.1538461598202094382,1.00000000000000000000,-0.0000392837044387519,0.99999999256924254620,-0.0001154049611543872,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -118.000000000000000000,1.00000000000000000000,-0.4238990895356964383,0.00000000000000000000,-1.2692511218321429478,1.00000000000000000000,-0.0000392837044387519,0.99999999256924254620,-0.0001154049611543872,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813952556200,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -119.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.1538461598202094382,1.00000000000000000000,0.00003613867936857978,0.99999999272442074982,-0.0001150875916247288,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -119.000000000000000000,1.00000000000000000000,0.42075406443654644883,0.00000000000000000000,-1.2689337522822670134,1.00000000000000000000,0.00003613867936857978,0.99999999272442074982,-0.0001150875916247288,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000812400776339,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -120.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-1.1538461666477015654,1.00000000000000000000,0.00011582333403264363,0.99999998666739198238,-0.0001151093876631140,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -120.000000000000000000,1.00000000000000000000,1.26966949454364375071,0.00000000000000000000,-1.2689555558455241079,1.00000000000000000000,0.00011582333403264363,0.99999998666739198238,-0.0001151093876631140,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001464687047700,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -121.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.1538461803026858198,3.00000000000000000000,0.00019230768984220914,0.99999997485207114955,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -122.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.1538462007851630897,3.00000000000000000000,0.00026923076418601120,0.99999995710059208509,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -123.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -124.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -125.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -126.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -127.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -128.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -129.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.9230770164808110855,3.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -130.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.9230769823433486731,3.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -131.000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,-1.9230769595850412123,3.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -132.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -133.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -134.000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,-1.9230769595850412123,3.00000000000000000000,0.00011538461299499319,0.99999997485207114955,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -135.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.9230769823433486731,3.00000000000000000000,0.00019230768756637849,0.99999996301775195828,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -136.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.9230770164808110855,3.00000000000000000000,0.00026923076099984833,0.99999994526627311586,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -137.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -138.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -139.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -140.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -141.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -142.000000000000000000,0.00000000000000000000,-3.8076924597746999445,0.00000000000000000000,-2.9615387105238348830,1.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -143.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-2.6923078549347665422,3.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -144.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-2.6923078071423187651,3.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -145.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-2.6923077752806880980,3.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -146.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-2.6923077593498727644,3.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -147.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-2.6923077593498727644,3.00000000000000000000,0.00003846153705810951,0.99999996301775162521,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -148.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-2.6923077752806880980,3.00000000000000000000,0.00011538461094674560,0.99999995710059208509,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -149.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-2.6923078071423187651,3.00000000000000000000,0.00019230768415263250,0.99999994526627311586,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -150.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-2.6923078549347665422,3.00000000000000000000,0.00026923075622060400,0.99999992751479460650,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -151.000000000000000000,0.00000000000000000000,3.80769245977469994457,0.00000000000000000000,-2.9615387105238348830,1.00000000000000000000,0.00034615382669549426,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -152.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -153.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -154.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -155.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -156.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-3.8076926878982981783,1.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013180474416003,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -157.000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,-3.8076925977753925955,1.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -158.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -159.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -160.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -161.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -162.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -163.000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 -164.000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,-3.8076925977753925955,1.00000000000000000000,0.00026923074984827827,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -165.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-3.8076926878982981783,1.00000000000000000000,0.00034615381850250414,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013180474416003,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -166.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -167.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -168.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -169.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -170.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -171.000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -172.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -173.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -174.000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -175.000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -176.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -177.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -178.000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -179.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -180.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -181.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -182.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -183.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -184.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -185.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -186.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -187.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -188.000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -189.000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -190.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -191.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -192.000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -193.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -194.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -195.000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -196.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -197.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -198.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 -199.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,1.00000000000000000000,1.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +Ray-ID ,Event-ID ,X-position ,Y-position ,Z-position ,Event-type ,X-direction ,Y-direction ,Z-direction ,Energy ,ElectricField-x-real ,ElectricField-x-imag ,ElectricField-y-real ,ElectricField-y-imag ,ElectricField-z-real ,ElectricField-z-imag ,pathLength ,order ,lastElement ,lightSourceIndex +0.00000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +1.00000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +2.00000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +3.00000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +4.00000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +5.00000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +6.00000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +7.00000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,5.50000046240142648201,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,0.00049999997916666690,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +8.00000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,5.50000049494580878217,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,0.00049999997916666690,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +9.00000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,5.50000056003457160613,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,0.00049999997916666690,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +10.0000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +11.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +12.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +13.0000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +14.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +15.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +16.0000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +17.0000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +18.0000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +19.0000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +20.0000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +21.0000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,4.65384643495867589280,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,0.00042307691045554557,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +22.0000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,4.65384646249622857538,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,0.00042307691045554557,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +23.0000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,4.65384651757133571692,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,0.00042307691045554557,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +24.0000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,4.65384660018399820557,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,0.00042307691045554557,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +25.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,4.65384671033421870589,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,0.00042307691045554557,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +26.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,4.65384684802199988240,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,0.00042307691045554557,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +27.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,4.65384701324734617600,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,0.00042307691045554557,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +28.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +29.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +30.0000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,3.80769268789829817833,1.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013180474416003,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +31.0000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,3.80769259777539259559,1.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822780,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +32.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +33.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +34.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +35.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,3.46153860235549215573,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,0.00034615383924101053,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +36.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,3.46153862283796831533,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,0.00034615383924101053,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +37.0000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,3.46153866380292329907,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,0.00034615383924101053,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +38.0000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,3.80769259777539259559,1.00000000000000000000,0.00026923074984827827,0.99999990384615689009,0.00034615383924101053,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +39.0000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,3.80769268789829817833,1.00000000000000000000,0.00034615381850250414,0.99999988017751961777,0.00034615383924101053,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013180474416003,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +40.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,3.80769280055193570788,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,0.00034615383924101053,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +41.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,3.80769293573630696059,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,0.00034615383924101053,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +42.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +43.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +44.0000000000000000000,0.00000000000000000000,-3.8076924597746999445,0.00000000000000000000,2.96153871052383488304,1.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +45.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,2.69230785493476654224,3.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,0.00026923076597822786,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +46.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,2.69230780714231876515,3.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,0.00026923076597822786,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +47.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,2.69230777528068809800,3.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,0.00026923076597822786,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +48.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,2.69230775934987276443,3.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,0.00026923076597822786,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +49.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,2.69230775934987276443,3.00000000000000000000,0.00003846153705810951,0.99999996301775162521,0.00026923076597822786,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +50.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,2.69230777528068809800,3.00000000000000000000,0.00011538461094674560,0.99999995710059208509,0.00026923076597822786,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +51.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,2.69230780714231876515,3.00000000000000000000,0.00019230768415263250,0.99999994526627311586,0.00026923076597822786,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +52.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,2.69230785493476654224,3.00000000000000000000,0.00026923075622060400,0.99999992751479460650,0.00026923076597822786,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +53.0000000000000000000,0.00000000000000000000,3.80769245977469994457,0.00000000000000000000,2.96153871052383488304,1.00000000000000000000,0.00034615382669549426,0.99999990384615689009,0.00026923076597822786,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +54.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,2.96153879814332920972,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,0.00026923076597822786,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +55.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.96153890328672808607,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,0.00026923076597822786,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +56.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +57.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +58.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +59.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.92307701648081041945,3.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,0.00019230769112236383,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +60.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.92307698234334822906,3.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,0.00019230769112236383,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +61.0000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,1.92307695958504076827,3.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,0.00019230769112236383,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +62.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +63.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.92307694820588737094,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,0.00019230769112236383,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +64.0000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,1.92307695958504076827,3.00000000000000000000,0.00011538461299499319,0.99999997485207114955,0.00019230769112236383,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +65.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.92307698234334822906,3.00000000000000000000,0.00019230768756637849,0.99999996301775195828,0.00019230769112236383,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +66.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.92307701648081041945,3.00000000000000000000,0.00026923076099984833,0.99999994526627311586,0.00019230769112236383,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +67.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.92307706199742822761,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,0.00019230769112236383,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +68.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,2.11538483078252292912,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,0.00019230769112236383,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +69.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,2.11538490588494987321,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,0.00019230769112236383,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +70.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +71.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +72.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +73.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,1.15384620078516308971,3.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,0.00011538461512858444,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +74.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,1.15384618030268581989,3.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,0.00011538461512858444,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +75.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,1.15384616664770156546,1.00000000000000000000,-0.0001154820839444342,0.99999998678627821657,0.00011441735651764090,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +75.0000000000000000000,1.00000000000000000000,-1.2693282444371554174,0.00000000000000000000,1.26826352467722158756,1.00000000000000000000,-0.0001154820839444342,0.99999998678627821657,0.00011441735651764090,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001463498174416,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +76.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,1.15384615982020943825,1.00000000000000000000,-0.0000385585513016470,0.99999999269039097082,0.00011459692936945851,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +76.0000000000000000000,1.00000000000000000000,-0.4231739363885317906,0.00000000000000000000,1.26844309002732669178,1.00000000000000000000,-0.0000385585513016470,0.99999999269039097082,0.00011459692936945851,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000812741072877,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +77.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,1.15384615982020943825,1.00000000000000000000,0.00003843007481958899,0.99999999261514438408,0.00011529458190977321,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +77.0000000000000000000,1.00000000000000000000,0.42304545990842634672,0.00000000000000000000,1.26914074258141651441,1.00000000000000000000,0.00003843007481958899,0.99999999261514438408,0.00011529458190977321,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813493534224,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +78.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,1.15384616664770156546,1.00000000000000000000,0.00011522184566990385,0.99999998676565182709,0.00011485914141355163,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +78.0000000000000000000,1.00000000000000000000,1.26906800616156290040,0.00000000000000000000,1.26870530958133920229,1.00000000000000000000,0.00011522184566990385,0.99999998676565182709,0.00011485914141355163,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001463704447814,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +79.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,1.15384618030268581989,3.00000000000000000000,0.00019230768984220914,0.99999997485207114955,0.00011538461512858444,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +80.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,1.15384620078516308971,3.00000000000000000000,0.00026923076418601120,0.99999995710059208509,0.00011538461512858444,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +81.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,1.15384622809513337493,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,0.00011538461512858444,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +82.0000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,1.26923088845585807504,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,0.00011538461512858444,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +83.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,1.26923093351731375300,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,0.00011538461512858444,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +84.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +85.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +86.0000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +87.0000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,0.38461539874450018094,3.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,0.00003846153845205580,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +88.0000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +89.0000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,0.38461538736534633953,1.00000000000000000000,-0.0001168699164632243,0.99999999244822634913,0.00003801275939869937,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +89.0000000000000000000,1.00000000000000000000,-1.2707160763125724400,0.00000000000000000000,0.42262814705110945956,1.00000000000000000000,-0.0001168699164632243,0.99999999244822634913,0.00003801275939869937,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000815162711660,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +90.0000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,0.38461538508951564896,1.00000000000000000000,-0.0000383759249364372,0.99999999852311305392,0.00003848457415021780,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +90.0000000000000000000,1.00000000000000000000,-0.4229913097981509717,0.00000000000000000000,0.42309995929657079338,1.00000000000000000000,-0.0000383759249364372,0.99999999852311305392,0.00003848457415021780,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162697870109,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +91.0000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,0.38461538508951564896,1.00000000000000000000,0.00003830273338429726,0.99999999852728471694,0.00003844907402737710,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +91.0000000000000000000,1.00000000000000000000,0.42291811824574310207,0.00000000000000000000,0.42306445917351731544,1.00000000000000000000,0.00003830273338429726,0.99999999852728471694,0.00003844907402737710,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162656160682,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +92.0000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,0.38461538736534633953,1.00000000000000000000,0.00011582080801010150,0.99999999254360805167,0.00003870819350673453,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +92.0000000000000000000,1.00000000000000000000,1.26966696784047994306,0.00000000000000000000,0.42332358116070434306,1.00000000000000000000,0.00011582080801010150,0.99999999254360805167,0.00003870819350673453,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000814208906376,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +93.0000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,0.38461539191700783169,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,0.00003846153845205580,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +94.0000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,0.38461539874450018094,3.00000000000000000000,0.00026923076577909266,0.99999996301775162521,0.00003846153845205580,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +95.0000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,0.38461540784782360935,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,0.00003846153845205580,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +96.0000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,0.42307696114967624501,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,0.00003846153845205580,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +97.0000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,0.42307697617016143398,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,0.00003846153845205580,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +98.0000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,-0.0004999999787968444,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +99.0000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,-0.0004230769101426188,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +100.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,-0.0003461538389849795,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +101.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-0.3846153987445001809,3.00000000000000000000,-0.0002692307657790926,0.99999996301775162521,-0.0000384615384520558,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +102.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,-0.0001923076909801243,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +103.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-0.3846153873653463395,1.00000000000000000000,-0.0001156486083869899,0.99999999256154448179,-0.0000387596489162040,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +103.000000000000000000,1.00000000000000000000,-1.2694947682140100830,0.00000000000000000000,-0.4233750365698623063,1.00000000000000000000,-0.0001156486083869899,0.99999999256154448179,-0.0000387596489162040,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,0.00011538461512858446,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000814029535831,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +104.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-0.3846153850895156489,1.00000000000000000000,-0.0000387536781005057,0.99999999851625509528,-0.0000382837075977132,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +104.000000000000000000,1.00000000000000000000,-0.4233690629630430524,0.00000000000000000000,-0.4228990927440321456,1.00000000000000000000,-0.0000387536781005057,0.99999999851625509528,-0.0000382837075977132,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162766446010,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +105.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-0.3846153850895156489,1.00000000000000000000,0.00003819513621371589,0.99999999852483356654,-0.0000386194839379186,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000147929004015,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +105.000000000000000000,1.00000000000000000000,0.42281052107509686788,0.00000000000000000000,-0.4232348690844044969,1.00000000000000000000,0.00003819513621371589,0.99999999852483356654,-0.0000386194839379186,640.000000000000000000,0.99999999926035521014,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000162680662469,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +106.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-0.3846153873653463395,1.00000000000000000000,0.00011539990873770338,0.99999999260423089175,-0.0000383979065069982,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +106.000000000000000000,1.00000000000000000000,1.26924606855794741555,0.00000000000000000000,-0.4230132941563266579,1.00000000000000000000,0.00011539990873770338,0.99999999260423089175,-0.0000383979065069982,640.000000000000000000,0.99999999334319544797,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813602673588,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +107.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-0.3846153919170078316,3.00000000000000000000,0.00019230769098012445,0.99999998076923080070,-0.0000384615384520558,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +108.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-0.3846153987445001809,3.00000000000000000000,0.00026923076577909266,0.99999996301775162521,-0.0000384615384520558,640.000000000000000000,0.99999996375739685916,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224954860,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +109.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-0.3846154078478236093,3.00000000000000000000,0.00034615383898497955,0.99999993934911302062,-0.0000384615384520558,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +110.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-0.4230769611496762450,1.00000000000000000000,0.00042307691014261891,0.99999990976331498693,-0.0000384615384520558,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036236720,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +111.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-0.4230769761701614339,1.00000000000000000000,0.00049999997879684445,0.99999987426035774618,-0.0000384615384520558,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +112.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,-0.0004999999758382646,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +113.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,-0.0004230769076392051,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +114.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,-0.0003461538369367320,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +115.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.1538462007851630897,3.00000000000000000000,-0.0002692307641860112,0.99999995710059208509,-0.0001153846151285844,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +116.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.1538461803026858198,3.00000000000000000000,-0.0001923076898422090,0.99999997485207114955,-0.0001153846151285844,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +117.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-1.1538461666477015654,1.00000000000000000000,-0.0001157093021606554,0.99999998663611855409,-0.0001154951082520545,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +117.000000000000000000,1.00000000000000000000,-1.2695554626737537429,0.00000000000000000000,-1.2693412764432190353,1.00000000000000000000,-0.0001157093021606554,0.99999998663611855409,-0.0001154951082520545,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001464999786549,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +118.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.1538461598202094382,1.00000000000000000000,-0.0000392836977972695,0.99999999256924299029,-0.0001154049609899504,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +118.000000000000000000,1.00000000000000000000,-0.4238990828942139632,0.00000000000000000000,-1.2692511216677060392,1.00000000000000000000,-0.0000392836977972695,0.99999999256924299029,-0.0001154049609899504,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000813952556200,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +119.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.1538461598202094382,1.00000000000000000000,0.00003613869813277658,0.99999999272442008368,-0.0001150875940239665,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0000739644983696,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +119.000000000000000000,1.00000000000000000000,0.42075408320074336732,0.00000000000000000000,-1.2689337546815049329,1.00000000000000000000,0.00003613869813277658,0.99999999272442008368,-0.0001150875940239665,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0000812400776339,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +120.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-1.1538461666477015654,1.00000000000000000000,0.00011582333048864257,0.99999998666739209340,-0.0001151093898863204,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001331360963376,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +120.000000000000000000,1.00000000000000000000,1.26966949099964265812,0.00000000000000000000,-1.2689555580687303937,1.00000000000000000000,0.00011582333048864257,0.99999998666739209340,-0.0001151093898863204,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0001464687047700,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +121.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.1538461803026858198,3.00000000000000000000,0.00019230768984220914,0.99999997485207114955,-0.0001153846151285844,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +122.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.1538462007851630897,3.00000000000000000000,0.00026923076418601120,0.99999995710059208509,-0.0001153846151285844,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +123.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.1538462280951333749,3.00000000000000000000,0.00034615383693673202,0.99999993343195370254,-0.0001153846151285844,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +124.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-1.2692308884558580750,1.00000000000000000000,0.00042307690763920520,0.99999990384615566885,-0.0001153846151285844,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923868939,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +125.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-1.2692309335173137530,1.00000000000000000000,0.00049999997583826468,0.99999986834319865014,-0.0001153846151285844,640.000000000000000000,0.99999987500000264706,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +126.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,-0.0004999999699211052,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +127.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,-0.0004230769026323778,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +128.000000000000000000,0.00000000000000000000,-3.4615385997951819696,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,-0.0003461538328402369,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +129.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-1.9230770164808110855,3.00000000000000000000,-0.0002692307609998483,0.99999994526627311586,-0.0001923076911223638,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +130.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-1.9230769823433486731,3.00000000000000000000,-0.0001923076875663784,0.99999996301775195828,-0.0001923076911223638,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +131.000000000000000000,0.00000000000000000000,-1.1538461589667727835,0.00000000000000000000,-1.9230769595850412123,3.00000000000000000000,-0.0001153846129949931,0.99999997485207114955,-0.0001923076911223638,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +132.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,-0.0000384615377408587,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +133.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-1.9230769482058878150,3.00000000000000000000,0.00003846153774085871,0.99999998076923080070,-0.0001923076911223638,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0001923076961247,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +134.000000000000000000,0.00000000000000000000,1.15384615896677278357,0.00000000000000000000,-1.9230769595850412123,3.00000000000000000000,0.00011538461299499319,0.99999997485207114955,-0.0001923076911223638,640.000000000000000000,0.99999999334319533694,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0002514792940928,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +135.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-1.9230769823433486731,3.00000000000000000000,0.00019230768756637849,0.99999996301775195828,-0.0001923076911223638,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224936670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +136.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-1.9230770164808110855,3.00000000000000000000,0.00026923076099984833,0.99999994526627311586,-0.0001923076911223638,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +137.000000000000000000,0.00000000000000000000,3.46153859979518196965,0.00000000000000000000,-1.9230770619974286717,3.00000000000000000000,0.00034615383284023691,0.99999992159763495536,-0.0001923076911223638,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +138.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-2.1153848307825238173,1.00000000000000000000,0.00042307690263237795,0.99999989201183736575,-0.0001923076911223638,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +139.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.1153849058849503173,1.00000000000000000000,0.00049999996992110523,0.99999985650888079113,-0.0001923076911223638,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +140.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,-0.0004999999610453660,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +141.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,-0.0004230768951221369,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +142.000000000000000000,0.00000000000000000000,-3.8076924597746999445,0.00000000000000000000,-2.9615387105238348830,1.00000000000000000000,-0.0003461538266954942,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101048,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +143.000000000000000000,0.00000000000000000000,-2.6923077573585207922,0.00000000000000000000,-2.6923078549347665422,3.00000000000000000000,-0.0002692307562206040,0.99999992751479460650,-0.0002692307659782278,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +144.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-2.6923078071423187651,3.00000000000000000000,-0.0001923076841526324,0.99999994526627311586,-0.0002692307659782278,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +145.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-2.6923077752806880980,3.00000000000000000000,-0.0001153846109467456,0.99999995710059208509,-0.0002692307659782278,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +146.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-2.6923077593498727644,3.00000000000000000000,-0.0000384615370581095,0.99999996301775162521,-0.0002692307659782278,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +147.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-2.6923077593498727644,3.00000000000000000000,0.00003846153705810951,0.99999996301775162521,-0.0002692307659782278,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0003698224973049,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +148.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-2.6923077752806880980,3.00000000000000000000,0.00011538461094674560,0.99999995710059208509,-0.0002692307659782278,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0004289940970920,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +149.000000000000000000,0.00000000000000000000,1.92307694678349339056,0.00000000000000000000,-2.6923078071423187651,3.00000000000000000000,0.00019230768415263250,0.99999994526627311586,-0.0002692307659782278,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0005473372984852,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +150.000000000000000000,0.00000000000000000000,2.69230775735852079222,0.00000000000000000000,-2.6923078549347665422,3.00000000000000000000,0.00026923075622060400,0.99999992751479460650,-0.0002692307659782278,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007248521051224,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +151.000000000000000000,0.00000000000000000000,3.80769245977469994457,0.00000000000000000000,-2.9615387105238348830,1.00000000000000000000,0.00034615382669549426,0.99999990384615689009,-0.0002692307659782278,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410104,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +152.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-2.9615387981433292097,1.00000000000000000000,0.00042307689512213698,0.99999987426035974458,-0.0002692307659782278,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +153.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-2.9615389032867280860,1.00000000000000000000,0.00049999996104536600,0.99999983875740383609,-0.0002692307659782278,640.000000000000000000,0.99999987500000242501,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +154.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,-0.0004999999492110472,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666690,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +155.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,-0.0004230768851084824,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +156.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-3.8076926878982981783,1.00000000000000000000,-0.0003461538185025041,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013180474416003,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +157.000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,-3.8076925977753925955,1.00000000000000000000,-0.0002692307498482782,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822780,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +158.000000000000000000,0.00000000000000000000,-1.9230769467834929464,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,-0.0001923076796009712,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +159.000000000000000000,0.00000000000000000000,-1.1538461589667730056,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,-0.0001153846082157488,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +160.000000000000000000,0.00000000000000000000,-0.3846153848050368195,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,-0.0000384615361477772,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +161.000000000000000000,0.00000000000000000000,0.38461538480503681958,0.00000000000000000000,-3.4615386023554921557,3.00000000000000000000,0.00003846153614777726,0.99999993934911302062,-0.0003461538392410105,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006065089055482,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +162.000000000000000000,0.00000000000000000000,1.15384615896677300561,0.00000000000000000000,-3.4615386228379683153,3.00000000000000000000,0.00011538460821574884,0.99999993343195370254,-0.0003461538392410105,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0006656805071543,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +163.000000000000000000,0.00000000000000000000,1.92307694678349361261,0.00000000000000000000,-3.4615386638029232990,3.00000000000000000000,0.00019230767960097126,0.99999992159763495536,-0.0003461538392410105,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,10000.0007840237121854,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000 +164.000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,-3.8076925977753925955,1.00000000000000000000,0.00026923074984827827,0.99999990384615689009,-0.0003461538392410105,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923759799,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +165.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-3.8076926878982981783,1.00000000000000000000,0.00034615381850250414,0.99999988017751961777,-0.0003461538392410105,640.000000000000000000,0.99999994008875792150,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013180474416003,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +166.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-3.8076928005519357078,1.00000000000000000000,0.00042307688510848247,0.99999985059172324941,-0.0003461538392410105,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912886325,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +167.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-3.8076929357363069605,1.00000000000000000000,0.00049999994921104721,0.99999981508876811808,-0.0003461538392410105,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666669,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +168.000000000000000000,0.00000000000000000000,-5.5000004583333792496,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,-0.0004999999344181487,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,0.00049999997916666701,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +169.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,-0.0004230768725914143,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,0.00042307691045554563,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +170.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,-0.0003461538082612664,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,0.00034615383924101053,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +171.000000000000000000,0.00000000000000000000,-2.9615385330943726494,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,-0.0002692307418828711,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,0.00026923076597822786,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +172.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,-0.0001923076739113946,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,0.00019230769112236386,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +173.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,-0.0001153846048020029,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858445,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +174.000000000000000000,0.00000000000000000000,-0.4230769232855405292,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,-0.0000384615350098619,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +175.000000000000000000,0.00000000000000000000,0.42307692328554052929,0.00000000000000000000,-4.6538464349586767809,1.00000000000000000000,0.00003846153500986195,0.99999990976331498693,-0.0004230769104555456,640.000000000000000000,0.99999999926035509911,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0009926036254910,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +176.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-4.6538464624962294635,1.00000000000000000000,0.00011538460480200291,0.99999990384615566885,-0.0004230769104555456,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0010576923887128,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +177.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-4.6538465175713357169,1.00000000000000000000,0.00019230767391139474,0.99999989201183736575,-0.0004230769104555456,640.000000000000000000,0.99999998150887592363,0.00000000000000000000,-0.0001923076911223639,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0011878699169756,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +178.000000000000000000,0.00000000000000000000,2.96153853309437264940,0.00000000000000000000,-4.6538466001839982055,1.00000000000000000000,0.00026923074188287118,0.99999987426035974458,-0.0004230769104555456,640.000000000000000000,0.99999996375739674814,0.00000000000000000000,-0.0002692307659782278,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362157361,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +179.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-4.6538467103342187058,1.00000000000000000000,0.00034615380826126648,0.99999985059172324941,-0.0004230769104555456,640.000000000000000000,0.99999994008875814355,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0016434912904514,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +180.000000000000000000,0.00000000000000000000,4.65384643151648269565,0.00000000000000000000,-4.6538468480219998824,1.00000000000000000000,0.00042307687259141442,0.99999982100592776923,-0.0004230769104555456,640.000000000000000000,0.99999991050295999883,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0019689351465785,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +181.000000000000000000,0.00000000000000000000,5.50000045833337924960,0.00000000000000000000,-4.6538470132473461760,1.00000000000000000000,0.00049999993441814875,0.99999978550297374813,-0.0004230769104555456,640.000000000000000000,0.99999987500000275808,0.00000000000000000000,-0.0004999999791666670,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +182.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +183.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +184.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +185.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +186.000000000000000000,0.00000000000000000000,-2.1153846414618420190,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,-0.0001923076670839029,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,0.00019230769112236383,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +187.000000000000000000,0.00000000000000000000,-1.2692307748634503727,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,-0.0001153846007055078,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,0.00011538461512858444,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +188.000000000000000000,0.00000000000000000000,-0.4230769232855405848,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,-0.0000384615336443635,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,0.00003846153845205580,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +189.000000000000000000,0.00000000000000000000,0.42307692328554058480,0.00000000000000000000,-5.5000004624014264820,1.00000000000000000000,0.00003846153364436359,0.99999987426035774618,-0.0004999999791666669,640.000000000000000000,0.99999999926035498809,0.00000000000000000000,-0.0000384615384520558,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0013831362393830,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +190.000000000000000000,0.00000000000000000000,1.26923077486345037279,0.00000000000000000000,-5.5000004949458087821,1.00000000000000000000,0.00011538460070550785,0.99999986834319865014,-0.0004999999791666669,640.000000000000000000,0.99999999334319522592,0.00000000000000000000,-0.0001153846151285844,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0014482250044238,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +191.000000000000000000,0.00000000000000000000,2.11538464146184246317,0.00000000000000000000,-5.5000005600345716061,1.00000000000000000000,0.00019230766708390299,0.99999985650888079113,-0.0004999999791666669,640.000000000000000000,0.99999998150887581260,0.00000000000000000000,-0.0001923076911223638,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0015784025381435,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +192.000000000000000000,0.00000000000000000000,2.96153853309437309349,0.00000000000000000000,-5.5000006576677211711,1.00000000000000000000,0.00026923073232438285,0.99999983875740383609,-0.0004999999791666669,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,-0.0002692307659782279,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +193.000000000000000000,0.00000000000000000000,3.80769245977470038866,0.00000000000000000000,-5.5000007878452565890,1.00000000000000000000,0.00034615379597178157,0.99999981508876811808,-0.0004999999791666669,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,-0.0003461538392410105,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +194.000000000000000000,0.00000000000000000000,4.65384643151648180747,0.00000000000000000000,-5.5000009505671840770,1.00000000000000000000,0.00042307685757093292,0.99999978550297374813,-0.0004999999791666669,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,-0.0004230769104555456,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +195.000000000000000000,0.00000000000000000000,5.50000045833337836143,0.00000000000000000000,-5.5000011458335062997,1.00000000000000000000,0.00049999991666667084,0.99999975000002094827,-0.0004999999791666669,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,-0.0004999999791666667,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +196.000000000000000000,0.00000000000000000000,-5.5000004583333783614,0.00000000000000000000,5.50000114583350629970,1.00000000000000000000,-0.0004999999166666708,0.99999975000002094827,0.00049999997916666690,640.000000000000000000,0.99999987500000253604,0.00000000000000000000,0.00049999997916666679,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0027500004580360,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +197.000000000000000000,0.00000000000000000000,-4.6538464315164818074,0.00000000000000000000,5.50000095056718407704,1.00000000000000000000,-0.0004230768575709328,0.99999978550297374813,0.00049999997916666690,640.000000000000000000,0.99999991050295988781,0.00000000000000000000,0.00042307691045554557,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0023594677950313,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +198.000000000000000000,0.00000000000000000000,-3.8076924597747003886,0.00000000000000000000,5.50000078784525658903,1.00000000000000000000,-0.0003461537959717815,0.99999981508876811808,0.00049999997916666690,640.000000000000000000,0.99999994008875803253,0.00000000000000000000,0.00034615383924101059,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0020340239279903,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 +199.000000000000000000,0.00000000000000000000,-2.9615385330943730934,0.00000000000000000000,5.50000065766772117115,1.00000000000000000000,-0.0002692307323243828,0.99999983875740383609,0.00049999997916666690,640.000000000000000000,0.99999996375739663712,0.00000000000000000000,0.00026923076597822791,0.00000000000000000000,0.00000000000000000000,0.00000000000000000000,11000.0017736688441800,0.00000000000000000000,1.00000000000000000000,0.00000000000000000000 diff --git a/Intern/rayx-core/tests/setupTests.cpp b/Intern/rayx-core/tests/setupTests.cpp index 8bf257c5..c8cd53a4 100644 --- a/Intern/rayx-core/tests/setupTests.cpp +++ b/Intern/rayx-core/tests/setupTests.cpp @@ -50,8 +50,7 @@ RAYX::Ray parseCSVline(std::string line) { ray.m_pathLength = vec[10]; const auto stokes = glm::dvec4(vec[11], vec[12], vec[13], vec[14]); - const auto rotation = RAYX::rotationMatrix(ray.m_direction); - const auto field = rotation * RAYX::stokesToElectricField(stokes); + const auto field = RAYX::stokesToElectricField(stokes, ray.m_direction); ray.m_field = field; // otherwise uninitialized: diff --git a/Intern/rayx-core/tests/testShader.cpp b/Intern/rayx-core/tests/testShader.cpp index 409ec9cb..ce8a066c 100644 --- a/Intern/rayx-core/tests/testShader.cpp +++ b/Intern/rayx-core/tests/testShader.cpp @@ -743,6 +743,47 @@ TEST_F(TestSuite, testVlsGrating) { } } +TEST_F(TestSuite, testBaseRotationConvention) { + const auto forward = glm::dvec3(0, 0, 1); + const auto right = glm::dvec3(1, 0, 0); + const auto up = glm::dvec3(0, 1, 0); + + { + // test if the convention uses the correct forward, up and right + + // rotation into forward yields identity matrix + CHECK_EQ(rotationMatrix(forward), glm::dmat3(1.0)); + + // rotate forward into right yields right + CHECK_EQ(rotationMatrix(right) * forward, right); + + // rotate forward into up yields up + CHECK_EQ(rotationMatrix(up) * forward, up); + } + + { + // in order to test if the rotation function is steadily, + // we gradually increase the rotation angle and compare the resulting angle to the previous. + // TODO(Sven): this test does not give a lot of guarantees + + const auto steps = 100; + const auto stepAngle = 1.0 / steps * PI * 2.0; + + auto get_dir = [](double angle) { return glm::dvec3(glm::cos(angle), glm::sin(angle), 0); }; + + auto prev_vec = get_dir(0.0f); + + for (int i = 1; i < steps + 1; ++i) { + auto angle = i / static_cast(steps) * PI * 2.0; + auto dir = get_dir(angle); + auto new_vec = rotationMatrix(dir) * forward; + auto angle_between_vecs = angleBetweenUnitVectors(prev_vec, new_vec); + CHECK_EQ(angle_between_vecs, stepAngle); + prev_vec = new_vec; + } + } +} + TEST_F(TestSuite, testGetIncidenceAngle) { struct InOutPair { Ray in_ray; @@ -1116,7 +1157,7 @@ TEST_F(TestSuite, testStokesToElectricFieldAndElectricFieldToStokes) { const auto field = stokesToLocalElectricField(p.stokes); CHECK_EQ(intensity(field), intensity(p.stokes)); - const auto stokes = fieldToStokes(field); + const auto stokes = localElectricFieldToStokes(field); CHECK_EQ(intensity(stokes), intensity(p.stokes)); CHECK_EQ(stokes, p.stokes); @@ -1126,7 +1167,7 @@ TEST_F(TestSuite, testStokesToElectricFieldAndElectricFieldToStokes) { const auto theta = arg(field); for (double shift = 0.0; shift < PI * 2.0; shift += PI / 5.0) { const auto field = polar(mag, theta + shift); - const auto stokes = fieldToStokes(field); + const auto stokes = localElectricFieldToStokes(field); CHECK_EQ(stokes, p.stokes); } } @@ -1134,7 +1175,7 @@ TEST_F(TestSuite, testStokesToElectricFieldAndElectricFieldToStokes) { // convert field to stokes and back and check if magnitude and polarization is preserved // the phase is not being checked, because stokes parameters do not preserve phase { - const auto stokes = fieldToStokes(p.field); + const auto stokes = localElectricFieldToStokes(p.field); CHECK_EQ(intensity(stokes), intensity(p.field)); CHECK_EQ(stokes, p.stokes); @@ -1158,51 +1199,6 @@ TEST_F(TestSuite, testStokesToElectricFieldAndElectricFieldToStokes) { } } -TEST_F(TestSuite, testRotateElectricField) { - using namespace complex; - - // convention for incident field - // forward = (0, 0, -1) - // up = (0, 1, 0) - // right = (1, 0, 0) - const auto incidentElectricField = ElectricField({1, 0}, {0, 0}, {0, 0}); - - struct InOutPair { - ElectricField in_field; - glm::dvec3 in_forward; - glm::dvec3 in_up; - ElectricField out_field; - ElectricField out_field_rotationWithoutUp; - }; - - const auto inouts = std::vector{ - { - .in_field = {{1, 0}, {0, 0}, {0, 0}}, - .in_forward = {0, 0, -1}, - .in_up = {0, 1, 0}, - .out_field = {{1, 0}, {0, 0}, {0, 0}}, - .out_field_rotationWithoutUp = {{1, 0}, {0, 0}, {0, 0}}, - }, - { - .in_field = {{1, 0}, {0, 0}, {0, 0}}, - .in_forward = {1, 0, 0}, - .in_up = {0, 0, 1}, - .out_field = {{0, 0}, {-1, 0}, {0, 0}}, - .out_field_rotationWithoutUp = {{0, 0}, {0, 0}, {1, 0}}, - }, - }; - - for (const auto& p : inouts) { - const auto rotation = rotationMatrix(p.in_forward, p.in_up); - const auto field = rotation * incidentElectricField; - CHECK_EQ(field, p.out_field); - - const auto rotationWithoutUp = rotationMatrix(p.in_forward); - const auto field_rotationWithoutUp = rotationWithoutUp * incidentElectricField; - CHECK_EQ(field_rotationWithoutUp, p.out_field_rotationWithoutUp); - } -} - // both the Cpp code as well as the shader define hvlam. TEST_F(TestSuite, testHvlam) { double hv = 100; diff --git a/Intern/rayx-ui/src/Triangulation/TraceTriangulation.cpp b/Intern/rayx-ui/src/Triangulation/TraceTriangulation.cpp index 25e5c5b0..0bea36ea 100644 --- a/Intern/rayx-ui/src/Triangulation/TraceTriangulation.cpp +++ b/Intern/rayx-ui/src/Triangulation/TraceTriangulation.cpp @@ -24,9 +24,8 @@ std::vector> createRayGrid(size_t size, double width, dou constexpr double distanceToObj = 2000.0f; pos = glm::dvec3(x, distanceToObj, z); dir = glm::dvec3(0.0f, -1.0f, 0.0f); - const auto rotation = RAYX::rotationMatrix(dir); const auto stokes = glm::dvec4(1.0f, 0.0f, 0.0f, 0.0f); - const auto field = rotation * RAYX::stokesToElectricField(stokes); + const auto field = RAYX::stokesToElectricField(stokes, dir); RAYX::Ray ray = { .m_position = pos,