From f6825b5b3bef3dc66df5903ffadd17022b7c016d Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 29 Aug 2025 12:16:04 -0400 Subject: [PATCH 01/40] Add test script for tune calculation node --- examples/Diagnostics/Tunes/test_tune.py | 173 ++++++++++++++++++++++++ examples/Diagnostics/Tunes/utils.py | 50 +++++++ 2 files changed, 223 insertions(+) create mode 100644 examples/Diagnostics/Tunes/test_tune.py create mode 100644 examples/Diagnostics/Tunes/utils.py diff --git a/examples/Diagnostics/Tunes/test_tune.py b/examples/Diagnostics/Tunes/test_tune.py new file mode 100644 index 00000000..dc4ffb30 --- /dev/null +++ b/examples/Diagnostics/Tunes/test_tune.py @@ -0,0 +1,173 @@ +import argparse +import math +import os +import pathlib +import random +from pprint import pprint + +import numpy as np +import pandas as pd +import matplotlib.pyplot as plt + +from orbit.core import orbit_mpi +from orbit.core.bunch import Bunch +from orbit.core.bunch import BunchTuneAnalysis +from orbit.core.bunch import BunchTwissAnalysis +from orbit.bunch_generators import TwissContainer +from orbit.bunch_generators import GaussDist2D +from orbit.bunch_generators import WaterBagDist2D +from orbit.lattice import AccLattice +from orbit.lattice import AccNode +from orbit.teapot import TEAPOT_Lattice +from orbit.teapot import TEAPOT_MATRIX_Lattice +from orbit.teapot import DriftTEAPOT +from orbit.teapot import QuadTEAPOT +from orbit.utils.consts import mass_proton + +from utils import make_lattice + + +def main(args: argparse.Namespace) -> None: + + # Setup + # ------------------------------------------------------------------------------------ + + path = pathlib.Path(__file__) + output_dir = os.path.join("outputs", path.stem) + os.makedirs(output_dir, exist_ok=True) + + + # Lattice + # ------------------------------------------------------------------------------------ + + lattice = make_lattice() + + bunch = Bunch() + bunch.mass(mass_proton) + bunch.getSyncParticle().kinEnergy(1.000) + + # Compute lattice parameters from one-turn transfer matrix + matrix_lattice = TEAPOT_MATRIX_Lattice(lattice, bunch) + lattice_params = matrix_lattice.getRingParametersDict() + pprint(lattice_params) + + # Store some parameters as variables + lattice_alpha_x = lattice_params["alpha x"] + lattice_alpha_y = lattice_params["alpha y"] + lattice_beta_x = lattice_params["beta x [m]"] + lattice_beta_y = lattice_params["beta y [m]"] + lattice_eta_x = lattice_params["dispersion x [m]"] + lattice_etap_x = lattice_params["dispersion x [m]"] + + + # Tune diagnostics node + # ------------------------------------------------------------------------------------ + + # The following class is adapted from `orbit.diagnostics` module. + + class TuneAnalysisNode(DriftTEAPOT): + def __init__(self, name: str = "tuneanalysis no name") -> None: + DriftTEAPOT.__init__(self, name) + self.setType("tune calculator teapot") + self.setLength(0.0) + self.calc = BunchTuneAnalysis() + + def track(self, params_dict: dict) -> None: + length = self.getLength(self.getActivePartIndex()) + bunch = params_dict["bunch"] + self.calc.analyzeBunch(bunch) + + def set_twiss( + self, + beta_x: float, + alpha_x: float, + eta_x: float, + etap_x: float, + beta_y: float, + alpha_y: float, + ) -> None: + self.calc.assignTwiss(beta_x, alpha_x, eta_x, etap_x, beta_y, alpha_y) + + + tune_node = TuneAnalysisNode() + tune_node.set_twiss( + beta_x=lattice_beta_x, + beta_y=lattice_beta_y, + alpha_x=lattice_alpha_x, + alpha_y=lattice_alpha_y, + eta_x=lattice_eta_x, + etap_x=lattice_etap_x, + ) + lattice.getNodes()[0].addChildNode(tune_node, 0) + + + # Bunch + # ------------------------------------------------------------------------------------ + + # Generate a matched transverse phase space distribution. The longitudinal + # distribution will be uniform in position (z) and a delta function in energy + # deviation (dE). + emittance_x = 25.0e-06 + emittance_y = 25.0e-06 + bunch_twiss_x = TwissContainer(lattice_alpha_x, lattice_beta_x, emittance_x) + bunch_twiss_y = TwissContainer(lattice_alpha_y, lattice_beta_y, emittance_y) + bunch_dist = GaussDist2D(bunch_twiss_x, bunch_twiss_y) + + for index in range(args.n): + (x, xp, y, yp) = bunch_dist.getCoordinates() + z = random.uniform(-25.0, 25.0) + dE = 0.0 + bunch.addParticle(x, xp, y, yp, z, dE) + + + # Tracking + # ------------------------------------------------------------------------------------ + + for turn in range(args.turns): + lattice.trackBunch(bunch) + + twiss_calc = BunchTwissAnalysis() + twiss_calc.analyzeBunch(bunch) + xrms = math.sqrt(twiss_calc.getCorrelation(0, 0)) * 1000.0 + yrms = math.sqrt(twiss_calc.getCorrelation(2, 2)) * 1000.0 + + print("turn={} xrms={:0.3f} yrms={:0.3f}".format(turn + 1, xrms, yrms)) + + filename = "bunch.dat" + filename = os.path.join(output_dir, filename) + bunch.dumpBunch(filename) + + + # Analysis + # ------------------------------------------------------------------------------------ + + particles = np.loadtxt(filename, comments="%") + particles = pd.DataFrame( + particles, + columns=[ + "x", + "xp", + "y", + "yp", + "z", + "dE", + "action_x", + "phase_x", + "tune_x", + "action_y", + "phase_y", + "tune_y", + ] + ) + + print(particles.iloc[:, 6:]) + + +if __name__ == "__main__": + parser = argparse.ArgumentParser() + parser.add_argument("--n", type=int, default=1000, help="# of macroparticles") + parser.add_argument("--turns", type=int, default=10) + args = parser.parse_args() + + main(args) + \ No newline at end of file diff --git a/examples/Diagnostics/Tunes/utils.py b/examples/Diagnostics/Tunes/utils.py new file mode 100644 index 00000000..e59a0e7e --- /dev/null +++ b/examples/Diagnostics/Tunes/utils.py @@ -0,0 +1,50 @@ +from orbit.core.bunch import Bunch +from orbit.core.bunch import BunchTwissAnalysis +from orbit.bunch_generators import TwissContainer +from orbit.bunch_generators import GaussDist2D +from orbit.bunch_generators import WaterBagDist2D +from orbit.lattice import AccLattice +from orbit.lattice import AccNode +from orbit.teapot import TEAPOT_Lattice +from orbit.teapot import TEAPOT_MATRIX_Lattice +from orbit.teapot import DriftTEAPOT +from orbit.teapot import QuadTEAPOT + + +def make_lattice( + length: float = 5.0, fill_fraction: float = 0.5, kq: float = 0.65 +) -> AccLattice: + drift_nodes = [ + DriftTEAPOT("drift1"), + DriftTEAPOT("drift2"), + ] + quad_nodes = [ + QuadTEAPOT("qf1"), + QuadTEAPOT("qd"), + QuadTEAPOT("qf2"), + ] + for node in [drift_nodes[0], quad_nodes[1], drift_nodes[1]]: + node.setLength(length * fill_fraction * 0.50) + for node in [quad_nodes[0], quad_nodes[2]]: + node.setLength(length * fill_fraction * 0.25) + + quad_nodes[0].setParam("kq", +kq) + quad_nodes[1].setParam("kq", -kq) + quad_nodes[2].setParam("kq", +kq) + + lattice = TEAPOT_Lattice() + lattice.addNode(quad_nodes[0]) + lattice.addNode(drift_nodes[0]) + lattice.addNode(quad_nodes[1]) + lattice.addNode(drift_nodes[1]) + lattice.addNode(quad_nodes[2]) + lattice.initialize() + + for node in lattice.getNodes(): + try: + node.setUsageFringeFieldIN(False) + node.setUsageFringeFieldOUT(False) + except: + pass + + return lattice From 66c5c2c355146f6da183bdde53056e1cf30b0d6a Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 29 Aug 2025 13:02:34 -0400 Subject: [PATCH 02/40] Use correct column order for tune diagnostic --- examples/Diagnostics/Tunes/test_tune.py | 14 +++++++------- 1 file changed, 7 insertions(+), 7 deletions(-) diff --git a/examples/Diagnostics/Tunes/test_tune.py b/examples/Diagnostics/Tunes/test_tune.py index dc4ffb30..45b05dc9 100644 --- a/examples/Diagnostics/Tunes/test_tune.py +++ b/examples/Diagnostics/Tunes/test_tune.py @@ -144,20 +144,20 @@ def set_twiss( particles = np.loadtxt(filename, comments="%") particles = pd.DataFrame( particles, - columns=[ + columns=[ # https://github.com/PyORBIT-Collaboration/PyORBIT3/issues/78 "x", "xp", "y", "yp", "z", - "dE", - "action_x", - "phase_x", - "tune_x", - "action_y", + "dE", + "phase_x", "phase_y", + "tune_x", "tune_y", - ] + "action_x", + "action_y", + ] ) print(particles.iloc[:, 6:]) From 86dfa8a64fed5191da9c032534a824a3aabe5057 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 29 Aug 2025 13:22:05 -0400 Subject: [PATCH 03/40] Test collecting phase information from bunch --- examples/Diagnostics/Tunes/test_tune.py | 12 +++++++++++- 1 file changed, 11 insertions(+), 1 deletion(-) diff --git a/examples/Diagnostics/Tunes/test_tune.py b/examples/Diagnostics/Tunes/test_tune.py index 45b05dc9..78838aa6 100644 --- a/examples/Diagnostics/Tunes/test_tune.py +++ b/examples/Diagnostics/Tunes/test_tune.py @@ -141,6 +141,17 @@ def set_twiss( # Analysis # ------------------------------------------------------------------------------------ + # Collect phase information from bunch + phase_info = {} + for j, key in enumerate(["phase_x", "phase_y", "tune_x", "tune_y", "action_x", "action_y"]): + phase_info[key] = [] + for i in range(bunch.getSize()): + phase_info[key].append(bunch.partAttrValue("ParticlePhaseAttributes", i, j)) + + phase_info = pd.DataFrame(phase_info) + print(phase_info) + + # Read phase information from bunch file particles = np.loadtxt(filename, comments="%") particles = pd.DataFrame( particles, @@ -159,7 +170,6 @@ def set_twiss( "action_y", ] ) - print(particles.iloc[:, 6:]) From c3ce40e441f170acc8162fb587f3a6287e3e4205 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 29 Aug 2025 13:55:14 -0400 Subject: [PATCH 04/40] Track number of turns and sum of previous particle phases --- src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc | 9 +++++++++ src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh | 7 ++++++- 2 files changed, 15 insertions(+), 1 deletion(-) diff --git a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc index 12d11937..468592dd 100644 --- a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc +++ b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc @@ -16,6 +16,10 @@ BunchTuneAnalysis::BunchTuneAnalysis(): CppPyWrapper(NULL) etapx = 0; betay = 0; alphay = 0; + + nturns = 0; + xPhaseSum = 0.0; + yPhaseSum = 0.0; } /** Destructor */ @@ -54,6 +58,11 @@ void BunchTuneAnalysis::analyzeBunch(Bunch* bunch){ } if(bunch->hasParticleAttributes("ParticlePhaseAttributes")){ + + nturns = nturns + 1; + + // std::cout << "debug nturns=" << nturns << " xPhaseSum=" << xPhaseSum << " yPhaseSum=" << yPhaseSum << std::endl; + for (int i=0; i < bunch->getSize(); i++) { double x = part_coord_arr[i][0]; diff --git a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh index b3701788..8015c3d1 100644 --- a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh +++ b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh @@ -32,6 +32,9 @@ class BunchTuneAnalysis: public OrbitUtils::CppPyWrapper /** Returns the average value for coordinate with index ic */ double getTune(int ic); + /** Returns number of turns (number of `analyzeBunch` calls) */ + int getNTurns(); + private: //** Twiss */ @@ -41,7 +44,9 @@ class BunchTuneAnalysis: public OrbitUtils::CppPyWrapper double etapx; double betay; double alphay; - + double nturns; + double xPhaseSum; + double yPhaseSum; }; #endif From cbdfbe5e864cd5595a6e4095edc94c79727ede22 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 29 Aug 2025 15:50:02 -0400 Subject: [PATCH 05/40] Revert "Track number of turns and sum of previous particle phases" This reverts commit c3ce40e441f170acc8162fb587f3a6287e3e4205. --- src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc | 9 --------- src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh | 7 +------ 2 files changed, 1 insertion(+), 15 deletions(-) diff --git a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc index 468592dd..12d11937 100644 --- a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc +++ b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc @@ -16,10 +16,6 @@ BunchTuneAnalysis::BunchTuneAnalysis(): CppPyWrapper(NULL) etapx = 0; betay = 0; alphay = 0; - - nturns = 0; - xPhaseSum = 0.0; - yPhaseSum = 0.0; } /** Destructor */ @@ -58,11 +54,6 @@ void BunchTuneAnalysis::analyzeBunch(Bunch* bunch){ } if(bunch->hasParticleAttributes("ParticlePhaseAttributes")){ - - nturns = nturns + 1; - - // std::cout << "debug nturns=" << nturns << " xPhaseSum=" << xPhaseSum << " yPhaseSum=" << yPhaseSum << std::endl; - for (int i=0; i < bunch->getSize(); i++) { double x = part_coord_arr[i][0]; diff --git a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh index 8015c3d1..b3701788 100644 --- a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh +++ b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh @@ -32,9 +32,6 @@ class BunchTuneAnalysis: public OrbitUtils::CppPyWrapper /** Returns the average value for coordinate with index ic */ double getTune(int ic); - /** Returns number of turns (number of `analyzeBunch` calls) */ - int getNTurns(); - private: //** Twiss */ @@ -44,9 +41,7 @@ class BunchTuneAnalysis: public OrbitUtils::CppPyWrapper double etapx; double betay; double alphay; - double nturns; - double xPhaseSum; - double yPhaseSum; + }; #endif From 44411b28915be23f42941f8145870eb5ca802224 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 29 Aug 2025 17:31:18 -0400 Subject: [PATCH 06/40] Initial version of BunchTuneAnalysis4D --- .../BunchDiagnostics/BunchTuneAnalysis4D.cc | 106 +++++++++++++ .../BunchDiagnostics/BunchTuneAnalysis4D.hh | 32 ++++ .../wrap_bunch_tune_analysis_4d.cc | 145 ++++++++++++++++++ .../wrap_bunch_tune_analysis_4d.hh | 18 +++ 4 files changed, 301 insertions(+) create mode 100644 src/orbit/BunchDiagnostics/BunchTuneAnalysis4D.cc create mode 100644 src/orbit/BunchDiagnostics/BunchTuneAnalysis4D.hh create mode 100644 src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.cc create mode 100644 src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.hh diff --git a/src/orbit/BunchDiagnostics/BunchTuneAnalysis4D.cc b/src/orbit/BunchDiagnostics/BunchTuneAnalysis4D.cc new file mode 100644 index 00000000..e9020db3 --- /dev/null +++ b/src/orbit/BunchDiagnostics/BunchTuneAnalysis4D.cc @@ -0,0 +1,106 @@ +#include "BunchTuneAnalysis4D.hh" +#include "SyncPart.hh" +#include "OrbitConst.hh" + +#include +#include +#include +#include + + +BunchTuneAnalysis4D::BunchTuneAnalysis4D(): CppPyWrapper(NULL) +{ + double matrix[4][4] = { + {1.0, 0.0, 0.0, 0.0}, + {0.0, 1.0, 0.0, 0.0}, + {0.0, 0.0, 1.0, 0.0}, + {0.0, 0.0, 0.0, 1.0} + }; +} + + +BunchTuneAnalysis4D::~BunchTuneAnalysis4D() +{ +} + + +void BunchTuneAnalysis4D::setMatrix(double dummy) { + // for (int i = 0; i < 4; i++) { + // for (int j = 0; j < 4; j++) { + // matrix[i][j] = _matrix[i][j]; + // } + // } +} + + +void BunchTuneAnalysis4D::analyzeBunch(Bunch* bunch){ + + bunch->compress(); + SyncPart* syncPart = bunch->getSyncPart(); + double beta = syncPart->getBeta(); + double** part_coord_arr = bunch->coordArr(); + + if(!bunch->hasParticleAttributes("ParticlePhaseAttributes")){ + cerr << "Adding particle phase information attribute.\n"; + std::map tunemap; + tunemap.insert(std::make_pair("phase1", 0)); + tunemap.insert(std::make_pair("phase2", 0)); + tunemap.insert(std::make_pair("tune1", 0)); + tunemap.insert(std::make_pair("tune2", 0)); + tunemap.insert(std::make_pair("action1", 0)); + tunemap.insert(std::make_pair("action2", 0)); + bunch->addParticleAttributes("ParticlePhaseAttributes", tunemap); + } + + if (bunch->hasParticleAttributes("ParticlePhaseAttributes")) { + for (int i=0; i < bunch->getSize(); i++) { + // Get phase space coordinates + double x = part_coord_arr[i][0]; + double xp = part_coord_arr[i][1]; + double y = part_coord_arr[i][2]; + double yp = part_coord_arr[i][3]; + double Etot = syncPart->getEnergy() + syncPart->getMass(); + double dpp = 1.0 / (beta * beta) * part_coord_arr[i][5] / Etot; + + // Normalize coordinates + double xval = matrix[0][0] * x + matrix[0][1] * xp + matrix[0][2] * y + matrix[0][3] * yp; + double xpval = matrix[1][0] * x + matrix[1][1] * xp + matrix[1][2] * y + matrix[1][3] * yp; + double yval = matrix[2][0] * x + matrix[2][1] * xp + matrix[2][2] * y + matrix[2][3] * yp; + double ypval = matrix[3][0] * x + matrix[3][1] * xp + matrix[3][2] * y + matrix[3][3] * yp; + + // Compute phases (mode 1) + double angle = atan2(xpval, xval); + if (angle < 0.0) { + angle += (2.0 * OrbitConst::PI); + } + double xPhase = angle; + double xPhaseOld = bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 0); + double xTune = (xPhaseOld - xPhase) / (2.0*OrbitConst::PI); + if (xTune < 0.0) { + xTune += 1.0; + } + bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 0) = xPhase; + bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 2) = xTune; + + angle = atan2(ypval, yval); + if (angle < 0.0) { + angle += (2.0 * OrbitConst::PI); + } + double yPhase = angle; + double yPhaseOld = bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 1); + double yTune = (yPhaseOld - yPhase) / (2.0*OrbitConst::PI); + if (yTune < 0.0) { + yTune += 1.0; + } + bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 1) = yPhase; + bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 3) = yTune; + + double xAction = xval * xval + xpval * xpval; + double yAction = yval * yval + ypval * ypval; + + bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 4) = xAction; + bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 5) = yAction; + } + } + +} diff --git a/src/orbit/BunchDiagnostics/BunchTuneAnalysis4D.hh b/src/orbit/BunchDiagnostics/BunchTuneAnalysis4D.hh new file mode 100644 index 00000000..8c3d1fcf --- /dev/null +++ b/src/orbit/BunchDiagnostics/BunchTuneAnalysis4D.hh @@ -0,0 +1,32 @@ +#ifndef BUNCH_TUNE_ANALYSIS_4D_H +#define BUNCH_TUNE_ANALYSIS_4D_H + +#include "CppPyWrapper.hh" + +#include "Bunch.hh" +#include "BunchTwissAnalysis.hh" + +using namespace std; + + +class BunchTuneAnalysis4D: public OrbitUtils::CppPyWrapper +{ + public: + BunchTuneAnalysis4D(); + + virtual ~BunchTuneAnalysis4D(); + + void analyzeBunch(Bunch* bunch); + + // void setMatrix(double _matrix[4][4]); + void setMatrix(double dummy); + + double getTune(int ic); + + private: + double matrix[4][4]; +}; + + +#endif +//endif for BUNCH_TUNE_ANALYSIS_4D_H diff --git a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.cc b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.cc new file mode 100644 index 00000000..35d2d4f6 --- /dev/null +++ b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.cc @@ -0,0 +1,145 @@ +#include "orbit_mpi.hh" +#include "pyORBIT_Object.hh" + +#include "wrap_bunch_tune_analysis_4d.hh" +#include "wrap_bunch.hh" + +#include + +#include "BunchTuneAnalysis4D.hh" + + +namespace wrap_bunch_tune_analysis_4d { + + void error(const char* msg){ ORBIT_MPI_Finalize(msg); } + + +#ifdef __cplusplus +extern "C" { +#endif + +/** +Constructor for python class wrapping C++ BunchTuneAnalysis4D instance. +It never will be called directly. +*/ +static PyObject* BunchTuneAnalysis4D_new(PyTypeObject *type, PyObject *args, PyObject *kwds){ + pyORBIT_Object* self; + self = (pyORBIT_Object *) type->tp_alloc(type, 0); + self->cpp_obj = NULL; + return (PyObject *) self; +} + +/** Implementation of the __init__ method */ +static int BunchTuneAnalysis4D_init(pyORBIT_Object *self, PyObject *args, PyObject *kwds){ + self->cpp_obj = new BunchTuneAnalysis4D(); + ((BunchTuneAnalysis4D*) self->cpp_obj)->setPyWrapper((PyObject*) self); + return 0; +} + +/** Analyzes the bunch. */ +static PyObject* BunchTuneAnalysis4D_analyzeBunch(PyObject *self, PyObject *args){ + BunchTuneAnalysis4D* cpp_BunchTuneAnalysis4D = (BunchTuneAnalysis4D*)((pyORBIT_Object*) self)->cpp_obj; + PyObject* pyBunch; + if(!PyArg_ParseTuple(args,"O:analyzeBunch",&pyBunch)){ + ORBIT_MPI_Finalize("BunchTuneAnalysis4D - analyzeBunch(Bunch* bunch) - parameter are needed."); + } + PyObject* pyORBIT_Bunch_Type = wrap_orbit_bunch::getBunchType("Bunch"); + if(!PyObject_IsInstance(pyBunch,pyORBIT_Bunch_Type)){ + ORBIT_MPI_Finalize("BunchTuneAnalysis4D - analyzeBunch(Bunch* bunch) - method needs a Bunch."); + } + Bunch* cpp_bunch = (Bunch*) ((pyORBIT_Object*)pyBunch)->cpp_obj; + cpp_BunchTuneAnalysis4D->analyzeBunch(cpp_bunch); + Py_INCREF(Py_None); + return Py_None; +} + +/** Sets normalization matrix. */ +static PyObject* BunchTuneAnalysis4D_setMatrix(PyObject *self, PyObject *args){ + BunchTuneAnalysis4D* cpp_BunchTuneAnalysis4D = (BunchTuneAnalysis4D*)((pyORBIT_Object*) self)->cpp_obj; + double dummy; + if(!PyArg_ParseTuple(args,"d:setMatrix",&dummy)){ + ORBIT_MPI_Finalize("BunchTuneAnalysis4D - setMatrix(double dummy) - parameters are needed."); + } + cpp_BunchTuneAnalysis4D->setMatrix(dummy); + Py_INCREF(Py_None); + return Py_None; +} + +// Destructor for python BunchTuneAnalysis4D class (__del__ method). +static void BunchTuneAnalysis4D_del(pyORBIT_Object* self){ + //std::cerr<<"The BunchTuneAnalysis4D __del__ has been called!"<cpp_obj); + self->ob_base.ob_type->tp_free((PyObject*)self); +} + +// Definition of the methods of the python BunchTuneAnalysis4D wrapper class. +// They will be available from python level. +static PyMethodDef BunchTuneAnalysis4DClassMethods[] = { + { "analyzeBunch", BunchTuneAnalysis4D_analyzeBunch, METH_VARARGS,"Analyzes the bunch."}, + { "setMatrix", BunchTuneAnalysis4D_assignTwiss, METH_VARARGS,"Sets normalization matrix."}, + {NULL} +}; + +// Definition of the memebers of the python BunchTwissAnalysis wrapper class. +// They will be vailable from python level. +static PyMemberDef BunchTuneAnalysis4DClassMembers [] = { + {NULL} +}; + +// New python BunchTwissAnalysis wrapper type definition. +static PyTypeObject pyORBIT_BunchTuneAnalysis4D_Type = { + PyVarObject_HEAD_INIT(NULL, 0) + "BunchTuneAnalysis4D", /*tp_name*/ + sizeof(pyORBIT_Object), /*tp_basicsize*/ + 0, /*tp_itemsize*/ + (destructor) BunchTuneAnalysis4D_del , /*tp_dealloc*/ + 0, /*tp_print*/ + 0, /*tp_getattr*/ + 0, /*tp_setattr*/ + 0, /*tp_compare*/ + 0, /*tp_repr*/ + 0, /*tp_as_number*/ + 0, /*tp_as_sequence*/ + 0, /*tp_as_mapping*/ + 0, /*tp_hash */ + 0, /*tp_call*/ + 0, /*tp_str*/ + 0, /*tp_getattro*/ + 0, /*tp_setattro*/ + 0, /*tp_as_buffer*/ + Py_TPFLAGS_DEFAULT | Py_TPFLAGS_BASETYPE, /*tp_flags*/ + "The BunchTuneAnalysis4D python wrapper", /* tp_doc */ + 0, /* tp_traverse */ + 0, /* tp_clear */ + 0, /* tp_richcompare */ + 0, /* tp_weaklistoffset */ + 0, /* tp_iter */ + 0, /* tp_iternext */ + BunchTuneAnalysis4DClassMethods, /* tp_methods */ + BunchTuneAnalysis4DClassMembers, /* tp_members */ + 0, /* tp_getset */ + 0, /* tp_base */ + 0, /* tp_dict */ + 0, /* tp_descr_get */ + 0, /* tp_descr_set */ + 0, /* tp_dictoffset */ + (initproc) BunchTuneAnalysis4D_init, /* tp_init */ + 0, /* tp_alloc */ + BunchTuneAnalysis4D_new, /* tp_new */ +}; + +// Initialization of the pyBunchTwissAnalysis4D class. +void initbunchtuneanalysis4d(PyObject* module){ + if (PyType_Ready(&pyORBIT_BunchTuneAnalysis4D_Type) < 0) return; + Py_INCREF(&pyORBIT_BunchTuneAnalysis4D_Type); + PyModule_AddObject(module, "BunchTuneAnalysis4D", (PyObject *)&pyORBIT_BunchTuneAnalysis4D_Type); +} + + + +#ifdef __cplusplus +} +#endif + + +} diff --git a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.hh b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.hh new file mode 100644 index 00000000..c169b4b8 --- /dev/null +++ b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.hh @@ -0,0 +1,18 @@ +#ifndef WRAP_BUNCH_TUNE_ANALYSIS_4D_HH_ +#define WRAP_BUNCH_TUNE_ANALYSIS_4D_HH_ + +#include "Python.h" + +#ifdef __cplusplus +extern "C" { +#endif + + namespace wrap_bunch_tune_analysis_4d{ + void initbunchtuneanalysis4d(PyObject* module); + } + +#ifdef __cplusplus +} +#endif + +#endif /*WRAP_BUNCH_TUNE_ANALYSIS_4D_HH_*/ From 3eefadbc9155cee4c2240cca620cc9f74cd9b186 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 29 Aug 2025 17:51:29 -0400 Subject: [PATCH 07/40] Fix typos --- .../BunchDiagnostics/wrap_bunch_tune_analysis_4d.cc | 9 +++++---- 1 file changed, 5 insertions(+), 4 deletions(-) diff --git a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.cc b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.cc index 35d2d4f6..b0212742 100644 --- a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.cc +++ b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.cc @@ -54,6 +54,7 @@ static PyObject* BunchTuneAnalysis4D_analyzeBunch(PyObject *self, PyObject *args } /** Sets normalization matrix. */ +// [TO DO] How to parse 2D Python list? static PyObject* BunchTuneAnalysis4D_setMatrix(PyObject *self, PyObject *args){ BunchTuneAnalysis4D* cpp_BunchTuneAnalysis4D = (BunchTuneAnalysis4D*)((pyORBIT_Object*) self)->cpp_obj; double dummy; @@ -76,17 +77,17 @@ static void BunchTuneAnalysis4D_del(pyORBIT_Object* self){ // They will be available from python level. static PyMethodDef BunchTuneAnalysis4DClassMethods[] = { { "analyzeBunch", BunchTuneAnalysis4D_analyzeBunch, METH_VARARGS,"Analyzes the bunch."}, - { "setMatrix", BunchTuneAnalysis4D_assignTwiss, METH_VARARGS,"Sets normalization matrix."}, + { "setMatrix", BunchTuneAnalysis4D_setMatrix, METH_VARARGS,"Sets normalization matrix."}, {NULL} }; -// Definition of the memebers of the python BunchTwissAnalysis wrapper class. +// Definition of the memebers of the python BunchTuneAnalysis4D wrapper class. // They will be vailable from python level. static PyMemberDef BunchTuneAnalysis4DClassMembers [] = { {NULL} }; -// New python BunchTwissAnalysis wrapper type definition. +// New python BunchTuneAnalysis4D wrapper type definition. static PyTypeObject pyORBIT_BunchTuneAnalysis4D_Type = { PyVarObject_HEAD_INIT(NULL, 0) "BunchTuneAnalysis4D", /*tp_name*/ @@ -128,7 +129,7 @@ static PyTypeObject pyORBIT_BunchTuneAnalysis4D_Type = { BunchTuneAnalysis4D_new, /* tp_new */ }; -// Initialization of the pyBunchTwissAnalysis4D class. +// Initialization of the pyBunchTuneAnalysis4D class. void initbunchtuneanalysis4d(PyObject* module){ if (PyType_Ready(&pyORBIT_BunchTuneAnalysis4D_Type) < 0) return; Py_INCREF(&pyORBIT_BunchTuneAnalysis4D_Type); From 3d0ce30b212deb4aef8b9e8cae5f2c89d4339708 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 29 Aug 2025 17:51:53 -0400 Subject: [PATCH 08/40] Try adding BunchTuneAnalysis4D to orbit.core module --- src/meson.build | 2 ++ src/orbit/wrap_bunch.cc | 2 ++ 2 files changed, 4 insertions(+) diff --git a/src/meson.build b/src/meson.build index 841fc403..d47f713e 100644 --- a/src/meson.build +++ b/src/meson.build @@ -80,9 +80,11 @@ sources = files([ 'orbit/Bunch.cc', 'orbit/SyncPart.cc', 'orbit/BunchDiagnostics/wrap_bunch_tune_analysis.cc', + 'orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.cc', 'orbit/BunchDiagnostics/wrap_bunch_twiss_analysis.cc', 'orbit/BunchDiagnostics/BunchTwissAnalysis.cc', 'orbit/BunchDiagnostics/BunchTuneAnalysis.cc', + 'orbit/BunchDiagnostics/BunchTuneAnalysis4D.cc', 'orbit/FieldTracker/wrap_fieldtracker.cc', 'orbit/FieldTracker/FieldTracker.cc', 'orbit/MaterialInteractions/wrap_foil.cc', diff --git a/src/orbit/wrap_bunch.cc b/src/orbit/wrap_bunch.cc index 68824b4e..32ffac5b 100644 --- a/src/orbit/wrap_bunch.cc +++ b/src/orbit/wrap_bunch.cc @@ -12,6 +12,7 @@ #include "wrap_syncpart.hh" #include "wrap_bunch_twiss_analysis.hh" #include "wrap_bunch_tune_analysis.hh" +#include "wrap_bunch_tune_analysis_4d.hh" #include "wrap_synch_part_redefinition_z_de.hh" #include "pyORBIT_Object.hh" @@ -1310,6 +1311,7 @@ extern "C" { wrap_orbit_syncpart::initsyncpart(module); wrap_bunch_twiss_analysis::initbunchtwissanalysis(module); wrap_bunch_tune_analysis::initbunchtuneanalysis(module); + wrap_bunch_tune_analysis_4d::initbunchtuneanalysis4d(module); wrap_synch_part_redefinition::initsynchpartredefinition(module); return module; } From 731a3ae95fc10481aa29d53a8adc5d8d6b71485e Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Tue, 2 Sep 2025 22:23:02 -0400 Subject: [PATCH 09/40] Keep BunchTuneAnalysis4D in same file as BunchTuneAnalysis --- src/meson.build | 2 - .../BunchDiagnostics/BunchTuneAnalysis.cc | 99 +++++ .../BunchDiagnostics/BunchTuneAnalysis.hh | 26 +- .../BunchDiagnostics/BunchTuneAnalysis4D.cc | 106 ----- .../BunchDiagnostics/BunchTuneAnalysis4D.hh | 32 -- .../wrap_bunch_tune_analysis.cc | 373 ++++++++++++------ .../wrap_bunch_tune_analysis.hh | 3 +- .../wrap_bunch_tune_analysis_4d.hh | 18 - src/orbit/wrap_bunch.cc | 3 +- 9 files changed, 378 insertions(+), 284 deletions(-) delete mode 100644 src/orbit/BunchDiagnostics/BunchTuneAnalysis4D.cc delete mode 100644 src/orbit/BunchDiagnostics/BunchTuneAnalysis4D.hh delete mode 100644 src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.hh diff --git a/src/meson.build b/src/meson.build index d47f713e..841fc403 100644 --- a/src/meson.build +++ b/src/meson.build @@ -80,11 +80,9 @@ sources = files([ 'orbit/Bunch.cc', 'orbit/SyncPart.cc', 'orbit/BunchDiagnostics/wrap_bunch_tune_analysis.cc', - 'orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.cc', 'orbit/BunchDiagnostics/wrap_bunch_twiss_analysis.cc', 'orbit/BunchDiagnostics/BunchTwissAnalysis.cc', 'orbit/BunchDiagnostics/BunchTuneAnalysis.cc', - 'orbit/BunchDiagnostics/BunchTuneAnalysis4D.cc', 'orbit/FieldTracker/wrap_fieldtracker.cc', 'orbit/FieldTracker/FieldTracker.cc', 'orbit/MaterialInteractions/wrap_foil.cc', diff --git a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc index 12d11937..0b4dc793 100644 --- a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc +++ b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc @@ -101,3 +101,102 @@ void BunchTuneAnalysis::analyzeBunch(Bunch* bunch){ } } + + + +BunchTuneAnalysis4D::BunchTuneAnalysis4D(): CppPyWrapper(NULL) +{ + double matrix[4][4] = { + {1.0, 0.0, 0.0, 0.0}, + {0.0, 1.0, 0.0, 0.0}, + {0.0, 0.0, 1.0, 0.0}, + {0.0, 0.0, 0.0, 1.0} + }; +} + + +BunchTuneAnalysis4D::~BunchTuneAnalysis4D() +{ +} + + +void BunchTuneAnalysis4D::setMatrix(double dummy) { + // for (int i = 0; i < 4; i++) { + // for (int j = 0; j < 4; j++) { + // matrix[i][j] = _matrix[i][j]; + // } + // } +} + + +void BunchTuneAnalysis4D::analyzeBunch(Bunch* bunch){ + + bunch->compress(); + SyncPart* syncPart = bunch->getSyncPart(); + double beta = syncPart->getBeta(); + double** part_coord_arr = bunch->coordArr(); + + if(!bunch->hasParticleAttributes("ParticlePhaseAttributes")){ + cerr << "Adding particle phase information attribute.\n"; + std::map tunemap; + tunemap.insert(std::make_pair("phase1", 0)); + tunemap.insert(std::make_pair("phase2", 0)); + tunemap.insert(std::make_pair("tune1", 0)); + tunemap.insert(std::make_pair("tune2", 0)); + tunemap.insert(std::make_pair("action1", 0)); + tunemap.insert(std::make_pair("action2", 0)); + bunch->addParticleAttributes("ParticlePhaseAttributes", tunemap); + } + + if (bunch->hasParticleAttributes("ParticlePhaseAttributes")) { + for (int i=0; i < bunch->getSize(); i++) { + // Get phase space coordinates + double x = part_coord_arr[i][0]; + double xp = part_coord_arr[i][1]; + double y = part_coord_arr[i][2]; + double yp = part_coord_arr[i][3]; + double Etot = syncPart->getEnergy() + syncPart->getMass(); + double dpp = 1.0 / (beta * beta) * part_coord_arr[i][5] / Etot; + + // Normalize coordinates + double xval = matrix[0][0] * x + matrix[0][1] * xp + matrix[0][2] * y + matrix[0][3] * yp; + double xpval = matrix[1][0] * x + matrix[1][1] * xp + matrix[1][2] * y + matrix[1][3] * yp; + double yval = matrix[2][0] * x + matrix[2][1] * xp + matrix[2][2] * y + matrix[2][3] * yp; + double ypval = matrix[3][0] * x + matrix[3][1] * xp + matrix[3][2] * y + matrix[3][3] * yp; + + // Compute phases (mode 1) + double angle = atan2(xpval, xval); + if (angle < 0.0) { + angle += (2.0 * OrbitConst::PI); + } + double xPhase = angle; + double xPhaseOld = bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 0); + double xTune = (xPhaseOld - xPhase) / (2.0*OrbitConst::PI); + if (xTune < 0.0) { + xTune += 1.0; + } + bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 0) = xPhase; + bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 2) = xTune; + + angle = atan2(ypval, yval); + if (angle < 0.0) { + angle += (2.0 * OrbitConst::PI); + } + double yPhase = angle; + double yPhaseOld = bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 1); + double yTune = (yPhaseOld - yPhase) / (2.0*OrbitConst::PI); + if (yTune < 0.0) { + yTune += 1.0; + } + bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 1) = yPhase; + bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 3) = yTune; + + double xAction = xval * xval + xpval * xpval; + double yAction = yval * yval + ypval * ypval; + + bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 4) = xAction; + bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 5) = yAction; + } + } + +} diff --git a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh index b3701788..6c7694fa 100644 --- a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh +++ b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh @@ -1,7 +1,6 @@ #ifndef BUNCH_TUNE_ANALYSIS_H #define BUNCH_TUNE_ANALYSIS_H -//pyORBIT utils #include "CppPyWrapper.hh" #include "Bunch.hh" @@ -9,10 +8,10 @@ using namespace std; + /** The BunchTuneAnalysis class calculates the particle tunes */ - class BunchTuneAnalysis: public OrbitUtils::CppPyWrapper { public: @@ -44,5 +43,28 @@ class BunchTuneAnalysis: public OrbitUtils::CppPyWrapper }; + +/** + Calculates tunes using 4D normalization. +*/ +class BunchTuneAnalysis4D: public OrbitUtils::CppPyWrapper +{ + public: + BunchTuneAnalysis4D(); + + virtual ~BunchTuneAnalysis4D(); + + void analyzeBunch(Bunch* bunch); + + // void setMatrix(double _matrix[4][4]); + void setMatrix(double dummy); + + double getTune(int ic); + + private: + double matrix[4][4]; +}; + + #endif //endif for BUNCH_TUNE_ANALYSIS_H diff --git a/src/orbit/BunchDiagnostics/BunchTuneAnalysis4D.cc b/src/orbit/BunchDiagnostics/BunchTuneAnalysis4D.cc deleted file mode 100644 index e9020db3..00000000 --- a/src/orbit/BunchDiagnostics/BunchTuneAnalysis4D.cc +++ /dev/null @@ -1,106 +0,0 @@ -#include "BunchTuneAnalysis4D.hh" -#include "SyncPart.hh" -#include "OrbitConst.hh" - -#include -#include -#include -#include - - -BunchTuneAnalysis4D::BunchTuneAnalysis4D(): CppPyWrapper(NULL) -{ - double matrix[4][4] = { - {1.0, 0.0, 0.0, 0.0}, - {0.0, 1.0, 0.0, 0.0}, - {0.0, 0.0, 1.0, 0.0}, - {0.0, 0.0, 0.0, 1.0} - }; -} - - -BunchTuneAnalysis4D::~BunchTuneAnalysis4D() -{ -} - - -void BunchTuneAnalysis4D::setMatrix(double dummy) { - // for (int i = 0; i < 4; i++) { - // for (int j = 0; j < 4; j++) { - // matrix[i][j] = _matrix[i][j]; - // } - // } -} - - -void BunchTuneAnalysis4D::analyzeBunch(Bunch* bunch){ - - bunch->compress(); - SyncPart* syncPart = bunch->getSyncPart(); - double beta = syncPart->getBeta(); - double** part_coord_arr = bunch->coordArr(); - - if(!bunch->hasParticleAttributes("ParticlePhaseAttributes")){ - cerr << "Adding particle phase information attribute.\n"; - std::map tunemap; - tunemap.insert(std::make_pair("phase1", 0)); - tunemap.insert(std::make_pair("phase2", 0)); - tunemap.insert(std::make_pair("tune1", 0)); - tunemap.insert(std::make_pair("tune2", 0)); - tunemap.insert(std::make_pair("action1", 0)); - tunemap.insert(std::make_pair("action2", 0)); - bunch->addParticleAttributes("ParticlePhaseAttributes", tunemap); - } - - if (bunch->hasParticleAttributes("ParticlePhaseAttributes")) { - for (int i=0; i < bunch->getSize(); i++) { - // Get phase space coordinates - double x = part_coord_arr[i][0]; - double xp = part_coord_arr[i][1]; - double y = part_coord_arr[i][2]; - double yp = part_coord_arr[i][3]; - double Etot = syncPart->getEnergy() + syncPart->getMass(); - double dpp = 1.0 / (beta * beta) * part_coord_arr[i][5] / Etot; - - // Normalize coordinates - double xval = matrix[0][0] * x + matrix[0][1] * xp + matrix[0][2] * y + matrix[0][3] * yp; - double xpval = matrix[1][0] * x + matrix[1][1] * xp + matrix[1][2] * y + matrix[1][3] * yp; - double yval = matrix[2][0] * x + matrix[2][1] * xp + matrix[2][2] * y + matrix[2][3] * yp; - double ypval = matrix[3][0] * x + matrix[3][1] * xp + matrix[3][2] * y + matrix[3][3] * yp; - - // Compute phases (mode 1) - double angle = atan2(xpval, xval); - if (angle < 0.0) { - angle += (2.0 * OrbitConst::PI); - } - double xPhase = angle; - double xPhaseOld = bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 0); - double xTune = (xPhaseOld - xPhase) / (2.0*OrbitConst::PI); - if (xTune < 0.0) { - xTune += 1.0; - } - bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 0) = xPhase; - bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 2) = xTune; - - angle = atan2(ypval, yval); - if (angle < 0.0) { - angle += (2.0 * OrbitConst::PI); - } - double yPhase = angle; - double yPhaseOld = bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 1); - double yTune = (yPhaseOld - yPhase) / (2.0*OrbitConst::PI); - if (yTune < 0.0) { - yTune += 1.0; - } - bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 1) = yPhase; - bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 3) = yTune; - - double xAction = xval * xval + xpval * xpval; - double yAction = yval * yval + ypval * ypval; - - bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 4) = xAction; - bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 5) = yAction; - } - } - -} diff --git a/src/orbit/BunchDiagnostics/BunchTuneAnalysis4D.hh b/src/orbit/BunchDiagnostics/BunchTuneAnalysis4D.hh deleted file mode 100644 index 8c3d1fcf..00000000 --- a/src/orbit/BunchDiagnostics/BunchTuneAnalysis4D.hh +++ /dev/null @@ -1,32 +0,0 @@ -#ifndef BUNCH_TUNE_ANALYSIS_4D_H -#define BUNCH_TUNE_ANALYSIS_4D_H - -#include "CppPyWrapper.hh" - -#include "Bunch.hh" -#include "BunchTwissAnalysis.hh" - -using namespace std; - - -class BunchTuneAnalysis4D: public OrbitUtils::CppPyWrapper -{ - public: - BunchTuneAnalysis4D(); - - virtual ~BunchTuneAnalysis4D(); - - void analyzeBunch(Bunch* bunch); - - // void setMatrix(double _matrix[4][4]); - void setMatrix(double dummy); - - double getTune(int ic); - - private: - double matrix[4][4]; -}; - - -#endif -//endif for BUNCH_TUNE_ANALYSIS_4D_H diff --git a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.cc b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.cc index cce58059..bbc90fdf 100644 --- a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.cc +++ b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.cc @@ -16,134 +16,265 @@ namespace wrap_bunch_tune_analysis{ extern "C" { #endif - /** - Constructor for python class wrapping c++ BunchTuneAnalysis instance. - It never will be called directly. - */ - static PyObject* BunchTuneAnalysis_new(PyTypeObject *type, PyObject *args, PyObject *kwds){ - pyORBIT_Object* self; - self = (pyORBIT_Object *) type->tp_alloc(type, 0); - self->cpp_obj = NULL; - return (PyObject *) self; +/** + Constructor for python class wrapping c++ BunchTuneAnalysis instance. + It never will be called directly. +*/ +static PyObject* BunchTuneAnalysis_new(PyTypeObject *type, PyObject *args, PyObject *kwds){ + pyORBIT_Object* self; + self = (pyORBIT_Object *) type->tp_alloc(type, 0); + self->cpp_obj = NULL; + return (PyObject *) self; +} + +/** This is implementation of the __init__ method */ +static int BunchTuneAnalysis_init(pyORBIT_Object *self, PyObject *args, PyObject *kwds){ + self->cpp_obj = new BunchTuneAnalysis(); + ((BunchTuneAnalysis*) self->cpp_obj)->setPyWrapper((PyObject*) self); +return 0; +} + +/** Performs the Tune analysis of the bunch */ +static PyObject* BunchTuneAnalysis_analyzeBunch(PyObject *self, PyObject *args){ + BunchTuneAnalysis* cpp_BunchTuneAnalysis = (BunchTuneAnalysis*)((pyORBIT_Object*) self)->cpp_obj; + PyObject* pyBunch; + if(!PyArg_ParseTuple(args,"O:analyzeBunch",&pyBunch)){ + ORBIT_MPI_Finalize("BunchTuneAnalysis - analyzeBunch(Bunch* bunch) - parameter are needed."); + } + PyObject* pyORBIT_Bunch_Type = wrap_orbit_bunch::getBunchType("Bunch"); + if(!PyObject_IsInstance(pyBunch,pyORBIT_Bunch_Type)){ + ORBIT_MPI_Finalize("BunchTuneAnalysis - analyzeBunch(Bunch* bunch) - method needs a Bunch."); } + Bunch* cpp_bunch = (Bunch*) ((pyORBIT_Object*)pyBunch)->cpp_obj; + cpp_BunchTuneAnalysis->analyzeBunch(cpp_bunch); + Py_INCREF(Py_None); + return Py_None; +} - /** This is implementation of the __init__ method */ - static int BunchTuneAnalysis_init(pyORBIT_Object *self, PyObject *args, PyObject *kwds){ - self->cpp_obj = new BunchTuneAnalysis(); - ((BunchTuneAnalysis*) self->cpp_obj)->setPyWrapper((PyObject*) self); - return 0; - } - - /** Performs the Tune analysis of the bunch */ - static PyObject* BunchTuneAnalysis_analyzeBunch(PyObject *self, PyObject *args){ - BunchTuneAnalysis* cpp_BunchTuneAnalysis = (BunchTuneAnalysis*)((pyORBIT_Object*) self)->cpp_obj; - PyObject* pyBunch; - if(!PyArg_ParseTuple(args,"O:analyzeBunch",&pyBunch)){ - ORBIT_MPI_Finalize("BunchTuneAnalysis - analyzeBunch(Bunch* bunch) - parameter are needed."); - } - PyObject* pyORBIT_Bunch_Type = wrap_orbit_bunch::getBunchType("Bunch"); - if(!PyObject_IsInstance(pyBunch,pyORBIT_Bunch_Type)){ - ORBIT_MPI_Finalize("BunchTuneAnalysis - analyzeBunch(Bunch* bunch) - method needs a Bunch."); - } - Bunch* cpp_bunch = (Bunch*) ((pyORBIT_Object*)pyBunch)->cpp_obj; - cpp_BunchTuneAnalysis->analyzeBunch(cpp_bunch); - Py_INCREF(Py_None); - return Py_None; - } - - /** Performs the Tune analysis of the bunch */ - static PyObject* BunchTuneAnalysis_assignTwiss(PyObject *self, PyObject *args){ - BunchTuneAnalysis* cpp_BunchTuneAnalysis = (BunchTuneAnalysis*)((pyORBIT_Object*) self)->cpp_obj; - double betax; - double alphax; - double etax; - double etapx; - double betay; - double alphay; - if(!PyArg_ParseTuple(args,"dddddd:assignTwiss",&betax, &alphax,&etax,&etapx,&betay,&alphay)){ - ORBIT_MPI_Finalize("BunchTuneAnalysis - getTwiss(double betax, double alphax, double etax, double etapx, double betay, double alphay) - parameter are needed."); - } - cpp_BunchTuneAnalysis->assignTwiss(betax, alphax, etax, etapx, betay, alphay); - Py_INCREF(Py_None); - return Py_None; +/** Performs the Tune analysis of the bunch */ +static PyObject* BunchTuneAnalysis_assignTwiss(PyObject *self, PyObject *args){ + BunchTuneAnalysis* cpp_BunchTuneAnalysis = (BunchTuneAnalysis*)((pyORBIT_Object*) self)->cpp_obj; + double betax; + double alphax; + double etax; + double etapx; + double betay; + double alphay; + if(!PyArg_ParseTuple(args,"dddddd:assignTwiss",&betax, &alphax,&etax,&etapx,&betay,&alphay)){ + ORBIT_MPI_Finalize("BunchTuneAnalysis - getTwiss(double betax, double alphax, double etax, double etapx, double betay, double alphay) - parameter are needed."); } + cpp_BunchTuneAnalysis->assignTwiss(betax, alphax, etax, etapx, betay, alphay); + Py_INCREF(Py_None); + return Py_None; +} + + + +//-------------------------------------------------------------- +//destructor for python BunchTuneAnalysis class (__del__ method). +//--------------------------------------------------------------- +static void BunchTuneAnalysis_del(pyORBIT_Object* self){ + //std::cerr<<"The BunchTuneAnalysis __del__ has been called!"<cpp_obj); + self->ob_base.ob_type->tp_free((PyObject*)self); +} + +// defenition of the methods of the python BunchTuneAnalysis wrapper class +// they will be vailable from python level +static PyMethodDef BunchTuneAnalysisClassMethods[] = { + { "analyzeBunch", BunchTuneAnalysis_analyzeBunch, METH_VARARGS,"Performs the Tune analysis of the bunch."}, + { "assignTwiss", BunchTuneAnalysis_assignTwiss, METH_VARARGS,"Assigns Twiss at location of tune calculator."}, + {NULL} +}; + +// defenition of the memebers of the python BunchTwissAnalysis wrapper class +// they will be vailable from python level +static PyMemberDef BunchTuneAnalysisClassMembers [] = { + {NULL} +}; + +//new python BunchTwissAnalysis wrapper type definition +static PyTypeObject pyORBIT_BunchTuneAnalysis_Type = { + PyVarObject_HEAD_INIT(NULL, 0) + "BunchTuneAnalysis", /*tp_name*/ + sizeof(pyORBIT_Object), /*tp_basicsize*/ + 0, /*tp_itemsize*/ + (destructor) BunchTuneAnalysis_del , /*tp_dealloc*/ + 0, /*tp_print*/ + 0, /*tp_getattr*/ + 0, /*tp_setattr*/ + 0, /*tp_compare*/ + 0, /*tp_repr*/ + 0, /*tp_as_number*/ + 0, /*tp_as_sequence*/ + 0, /*tp_as_mapping*/ + 0, /*tp_hash */ + 0, /*tp_call*/ + 0, /*tp_str*/ + 0, /*tp_getattro*/ + 0, /*tp_setattro*/ + 0, /*tp_as_buffer*/ + Py_TPFLAGS_DEFAULT | Py_TPFLAGS_BASETYPE, /*tp_flags*/ + "The BunchTuneAnalysis python wrapper", /* tp_doc */ + 0, /* tp_traverse */ + 0, /* tp_clear */ + 0, /* tp_richcompare */ + 0, /* tp_weaklistoffset */ + 0, /* tp_iter */ + 0, /* tp_iternext */ + BunchTuneAnalysisClassMethods, /* tp_methods */ + BunchTuneAnalysisClassMembers, /* tp_members */ + 0, /* tp_getset */ + 0, /* tp_base */ + 0, /* tp_dict */ + 0, /* tp_descr_get */ + 0, /* tp_descr_set */ + 0, /* tp_dictoffset */ + (initproc) BunchTuneAnalysis_init, /* tp_init */ + 0, /* tp_alloc */ + BunchTuneAnalysis_new, /* tp_new */ +}; + + +//-------------------------------------------------- +//Initialization BunchTwissAnalysis of the pyBunchTwissAnalysis class +//-------------------------------------------------- +void initbunchtuneanalysis(PyObject* module){ + if (PyType_Ready(&pyORBIT_BunchTuneAnalysis_Type) < 0) return; + Py_INCREF(&pyORBIT_BunchTuneAnalysis_Type); + PyModule_AddObject(module, "BunchTuneAnalysis", (PyObject *)&pyORBIT_BunchTuneAnalysis_Type); +} + + + + +//----------------------------------------------------------------------------------- +// BunchTwissAnalysis4D +//----------------------------------------------------------------------------------- - //-------------------------------------------------------------- - //destructor for python BunchTuneAnalysis class (__del__ method). - //--------------------------------------------------------------- - static void BunchTuneAnalysis_del(pyORBIT_Object* self){ - //std::cerr<<"The BunchTuneAnalysis __del__ has been called!"<cpp_obj); - self->ob_base.ob_type->tp_free((PyObject*)self); - } - - // defenition of the methods of the python BunchTuneAnalysis wrapper class - // they will be vailable from python level - static PyMethodDef BunchTuneAnalysisClassMethods[] = { - { "analyzeBunch", BunchTuneAnalysis_analyzeBunch, METH_VARARGS,"Performs the Tune analysis of the bunch."}, - { "assignTwiss", BunchTuneAnalysis_assignTwiss, METH_VARARGS,"Assigns Twiss at location of tune calculator."}, - {NULL} - }; - - // defenition of the memebers of the python BunchTwissAnalysis wrapper class - // they will be vailable from python level - static PyMemberDef BunchTuneAnalysisClassMembers [] = { - {NULL} - }; - - //new python BunchTwissAnalysis wrapper type definition - static PyTypeObject pyORBIT_BunchTuneAnalysis_Type = { - PyVarObject_HEAD_INIT(NULL, 0) - "BunchTuneAnalysis", /*tp_name*/ - sizeof(pyORBIT_Object), /*tp_basicsize*/ - 0, /*tp_itemsize*/ - (destructor) BunchTuneAnalysis_del , /*tp_dealloc*/ - 0, /*tp_print*/ - 0, /*tp_getattr*/ - 0, /*tp_setattr*/ - 0, /*tp_compare*/ - 0, /*tp_repr*/ - 0, /*tp_as_number*/ - 0, /*tp_as_sequence*/ - 0, /*tp_as_mapping*/ - 0, /*tp_hash */ - 0, /*tp_call*/ - 0, /*tp_str*/ - 0, /*tp_getattro*/ - 0, /*tp_setattro*/ - 0, /*tp_as_buffer*/ - Py_TPFLAGS_DEFAULT | Py_TPFLAGS_BASETYPE, /*tp_flags*/ - "The BunchTuneAnalysis python wrapper", /* tp_doc */ - 0, /* tp_traverse */ - 0, /* tp_clear */ - 0, /* tp_richcompare */ - 0, /* tp_weaklistoffset */ - 0, /* tp_iter */ - 0, /* tp_iternext */ - BunchTuneAnalysisClassMethods, /* tp_methods */ - BunchTuneAnalysisClassMembers, /* tp_members */ - 0, /* tp_getset */ - 0, /* tp_base */ - 0, /* tp_dict */ - 0, /* tp_descr_get */ - 0, /* tp_descr_set */ - 0, /* tp_dictoffset */ - (initproc) BunchTuneAnalysis_init, /* tp_init */ - 0, /* tp_alloc */ - BunchTuneAnalysis_new, /* tp_new */ - }; - - - //-------------------------------------------------- - //Initialization BunchTwissAnalysis of the pyBunchTwissAnalysis class - //-------------------------------------------------- - void initbunchtuneanalysis(PyObject* module){ - if (PyType_Ready(&pyORBIT_BunchTuneAnalysis_Type) < 0) return; - Py_INCREF(&pyORBIT_BunchTuneAnalysis_Type); - PyModule_AddObject(module, "BunchTuneAnalysis", (PyObject *)&pyORBIT_BunchTuneAnalysis_Type); +/** +Constructor for python class wrapping C++ BunchTuneAnalysis4D instance. +It never will be called directly. +*/ +static PyObject* BunchTuneAnalysis4D_new(PyTypeObject *type, PyObject *args, PyObject *kwds){ + pyORBIT_Object* self; + self = (pyORBIT_Object *) type->tp_alloc(type, 0); + self->cpp_obj = NULL; + return (PyObject *) self; +} + +/** Implementation of the __init__ method */ +static int BunchTuneAnalysis4D_init(pyORBIT_Object *self, PyObject *args, PyObject *kwds){ + self->cpp_obj = new BunchTuneAnalysis4D(); + ((BunchTuneAnalysis4D*) self->cpp_obj)->setPyWrapper((PyObject*) self); + return 0; +} + +/** Analyzes the bunch. */ +static PyObject* BunchTuneAnalysis4D_analyzeBunch(PyObject *self, PyObject *args){ + BunchTuneAnalysis4D* cpp_BunchTuneAnalysis4D = (BunchTuneAnalysis4D*)((pyORBIT_Object*) self)->cpp_obj; + PyObject* pyBunch; + if(!PyArg_ParseTuple(args,"O:analyzeBunch",&pyBunch)){ + ORBIT_MPI_Finalize("BunchTuneAnalysis4D - analyzeBunch(Bunch* bunch) - parameter are needed."); + } + PyObject* pyORBIT_Bunch_Type = wrap_orbit_bunch::getBunchType("Bunch"); + if(!PyObject_IsInstance(pyBunch,pyORBIT_Bunch_Type)){ + ORBIT_MPI_Finalize("BunchTuneAnalysis4D - analyzeBunch(Bunch* bunch) - method needs a Bunch."); } + Bunch* cpp_bunch = (Bunch*) ((pyORBIT_Object*)pyBunch)->cpp_obj; + cpp_BunchTuneAnalysis4D->analyzeBunch(cpp_bunch); + Py_INCREF(Py_None); + return Py_None; +} + +/** Sets normalization matrix. */ +// [TO DO] How to parse 2D Python list? +static PyObject* BunchTuneAnalysis4D_setMatrix(PyObject *self, PyObject *args){ + BunchTuneAnalysis4D* cpp_BunchTuneAnalysis4D = (BunchTuneAnalysis4D*)((pyORBIT_Object*) self)->cpp_obj; + double dummy; + if(!PyArg_ParseTuple(args,"d:setMatrix",&dummy)){ + ORBIT_MPI_Finalize("BunchTuneAnalysis4D - setMatrix(double dummy) - parameters are needed."); + } + cpp_BunchTuneAnalysis4D->setMatrix(dummy); + Py_INCREF(Py_None); + return Py_None; +} + +// Destructor for python BunchTuneAnalysis4D class (__del__ method). +static void BunchTuneAnalysis4D_del(pyORBIT_Object* self){ + //std::cerr<<"The BunchTuneAnalysis4D __del__ has been called!"<cpp_obj); + self->ob_base.ob_type->tp_free((PyObject*)self); +} + +// Definition of the methods of the python BunchTuneAnalysis4D wrapper class. +// They will be available from python level. +static PyMethodDef BunchTuneAnalysis4DClassMethods[] = { + { "analyzeBunch", BunchTuneAnalysis4D_analyzeBunch, METH_VARARGS,"Analyzes the bunch."}, + { "setMatrix", BunchTuneAnalysis4D_setMatrix, METH_VARARGS,"Sets normalization matrix."}, + {NULL} +}; + +// Definition of the memebers of the python BunchTuneAnalysis4D wrapper class. +// They will be vailable from python level. +static PyMemberDef BunchTuneAnalysis4DClassMembers [] = { + {NULL} +}; + +// New python BunchTuneAnalysis4D wrapper type definition. +static PyTypeObject pyORBIT_BunchTuneAnalysis4D_Type = { + PyVarObject_HEAD_INIT(NULL, 0) + "BunchTuneAnalysis4D", /*tp_name*/ + sizeof(pyORBIT_Object), /*tp_basicsize*/ + 0, /*tp_itemsize*/ + (destructor) BunchTuneAnalysis4D_del , /*tp_dealloc*/ + 0, /*tp_print*/ + 0, /*tp_getattr*/ + 0, /*tp_setattr*/ + 0, /*tp_compare*/ + 0, /*tp_repr*/ + 0, /*tp_as_number*/ + 0, /*tp_as_sequence*/ + 0, /*tp_as_mapping*/ + 0, /*tp_hash */ + 0, /*tp_call*/ + 0, /*tp_str*/ + 0, /*tp_getattro*/ + 0, /*tp_setattro*/ + 0, /*tp_as_buffer*/ + Py_TPFLAGS_DEFAULT | Py_TPFLAGS_BASETYPE, /*tp_flags*/ + "The BunchTuneAnalysis4D python wrapper", /* tp_doc */ + 0, /* tp_traverse */ + 0, /* tp_clear */ + 0, /* tp_richcompare */ + 0, /* tp_weaklistoffset */ + 0, /* tp_iter */ + 0, /* tp_iternext */ + BunchTuneAnalysis4DClassMethods, /* tp_methods */ + BunchTuneAnalysis4DClassMembers, /* tp_members */ + 0, /* tp_getset */ + 0, /* tp_base */ + 0, /* tp_dict */ + 0, /* tp_descr_get */ + 0, /* tp_descr_set */ + 0, /* tp_dictoffset */ + (initproc) BunchTuneAnalysis4D_init, /* tp_init */ + 0, /* tp_alloc */ + BunchTuneAnalysis4D_new, /* tp_new */ +}; + +// Initialization of the pyBunchTuneAnalysis4D class. +void initbunchtuneanalysis4d(PyObject* module){ + if (PyType_Ready(&pyORBIT_BunchTuneAnalysis4D_Type) < 0) return; + Py_INCREF(&pyORBIT_BunchTuneAnalysis4D_Type); + PyModule_AddObject(module, "BunchTuneAnalysis4D", (PyObject *)&pyORBIT_BunchTuneAnalysis4D_Type); +} + + + + #ifdef __cplusplus } diff --git a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.hh b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.hh index af0f0c0a..87c9103a 100644 --- a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.hh +++ b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.hh @@ -7,8 +7,9 @@ extern "C" { #endif - namespace wrap_bunch_tune_analysis{ + namespace wrap_bunch_tune_analysis { void initbunchtuneanalysis(PyObject* module); + void initbunchtuneanalysis4d(PyObject* module); } #ifdef __cplusplus diff --git a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.hh b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.hh deleted file mode 100644 index c169b4b8..00000000 --- a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.hh +++ /dev/null @@ -1,18 +0,0 @@ -#ifndef WRAP_BUNCH_TUNE_ANALYSIS_4D_HH_ -#define WRAP_BUNCH_TUNE_ANALYSIS_4D_HH_ - -#include "Python.h" - -#ifdef __cplusplus -extern "C" { -#endif - - namespace wrap_bunch_tune_analysis_4d{ - void initbunchtuneanalysis4d(PyObject* module); - } - -#ifdef __cplusplus -} -#endif - -#endif /*WRAP_BUNCH_TUNE_ANALYSIS_4D_HH_*/ diff --git a/src/orbit/wrap_bunch.cc b/src/orbit/wrap_bunch.cc index 32ffac5b..c3c2dadc 100644 --- a/src/orbit/wrap_bunch.cc +++ b/src/orbit/wrap_bunch.cc @@ -12,7 +12,6 @@ #include "wrap_syncpart.hh" #include "wrap_bunch_twiss_analysis.hh" #include "wrap_bunch_tune_analysis.hh" -#include "wrap_bunch_tune_analysis_4d.hh" #include "wrap_synch_part_redefinition_z_de.hh" #include "pyORBIT_Object.hh" @@ -1311,7 +1310,7 @@ extern "C" { wrap_orbit_syncpart::initsyncpart(module); wrap_bunch_twiss_analysis::initbunchtwissanalysis(module); wrap_bunch_tune_analysis::initbunchtuneanalysis(module); - wrap_bunch_tune_analysis_4d::initbunchtuneanalysis4d(module); + wrap_bunch_tune_analysis::initbunchtuneanalysis4d(module); wrap_synch_part_redefinition::initsynchpartredefinition(module); return module; } From 64f6d38ef2ede703ae63032c7ef88e3e71d7e56d Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Wed, 3 Sep 2025 16:40:20 -0400 Subject: [PATCH 10/40] Update test_tune.py --- examples/Diagnostics/Tunes/test_tune.py | 287 +++++++++++------------- 1 file changed, 137 insertions(+), 150 deletions(-) diff --git a/examples/Diagnostics/Tunes/test_tune.py b/examples/Diagnostics/Tunes/test_tune.py index 78838aa6..cab3829b 100644 --- a/examples/Diagnostics/Tunes/test_tune.py +++ b/examples/Diagnostics/Tunes/test_tune.py @@ -1,4 +1,3 @@ -import argparse import math import os import pathlib @@ -27,157 +26,145 @@ from utils import make_lattice -def main(args: argparse.Namespace) -> None: - - # Setup - # ------------------------------------------------------------------------------------ +# Setup +# ------------------------------------------------------------------------------------ + +path = pathlib.Path(__file__) +output_dir = os.path.join("outputs", path.stem) +os.makedirs(output_dir, exist_ok=True) + - path = pathlib.Path(__file__) - output_dir = os.path.join("outputs", path.stem) - os.makedirs(output_dir, exist_ok=True) +# Lattice +# ------------------------------------------------------------------------------------ +lattice = make_lattice() - # Lattice - # ------------------------------------------------------------------------------------ - - lattice = make_lattice() +bunch = Bunch() +bunch.mass(mass_proton) +bunch.getSyncParticle().kinEnergy(1.000) - bunch = Bunch() - bunch.mass(mass_proton) - bunch.getSyncParticle().kinEnergy(1.000) +# Compute lattice parameters from one-turn transfer matrix +matrix_lattice = TEAPOT_MATRIX_Lattice(lattice, bunch) +lattice_params = matrix_lattice.getRingParametersDict() +pprint(lattice_params) - # Compute lattice parameters from one-turn transfer matrix - matrix_lattice = TEAPOT_MATRIX_Lattice(lattice, bunch) - lattice_params = matrix_lattice.getRingParametersDict() - pprint(lattice_params) - - # Store some parameters as variables - lattice_alpha_x = lattice_params["alpha x"] - lattice_alpha_y = lattice_params["alpha y"] - lattice_beta_x = lattice_params["beta x [m]"] - lattice_beta_y = lattice_params["beta y [m]"] - lattice_eta_x = lattice_params["dispersion x [m]"] - lattice_etap_x = lattice_params["dispersion x [m]"] - - - # Tune diagnostics node - # ------------------------------------------------------------------------------------ - - # The following class is adapted from `orbit.diagnostics` module. - - class TuneAnalysisNode(DriftTEAPOT): - def __init__(self, name: str = "tuneanalysis no name") -> None: - DriftTEAPOT.__init__(self, name) - self.setType("tune calculator teapot") - self.setLength(0.0) - self.calc = BunchTuneAnalysis() - - def track(self, params_dict: dict) -> None: - length = self.getLength(self.getActivePartIndex()) - bunch = params_dict["bunch"] - self.calc.analyzeBunch(bunch) - - def set_twiss( - self, - beta_x: float, - alpha_x: float, - eta_x: float, - etap_x: float, - beta_y: float, - alpha_y: float, - ) -> None: - self.calc.assignTwiss(beta_x, alpha_x, eta_x, etap_x, beta_y, alpha_y) - - - tune_node = TuneAnalysisNode() - tune_node.set_twiss( - beta_x=lattice_beta_x, - beta_y=lattice_beta_y, - alpha_x=lattice_alpha_x, - alpha_y=lattice_alpha_y, - eta_x=lattice_eta_x, - etap_x=lattice_etap_x, - ) - lattice.getNodes()[0].addChildNode(tune_node, 0) - - - # Bunch - # ------------------------------------------------------------------------------------ - - # Generate a matched transverse phase space distribution. The longitudinal - # distribution will be uniform in position (z) and a delta function in energy - # deviation (dE). - emittance_x = 25.0e-06 - emittance_y = 25.0e-06 - bunch_twiss_x = TwissContainer(lattice_alpha_x, lattice_beta_x, emittance_x) - bunch_twiss_y = TwissContainer(lattice_alpha_y, lattice_beta_y, emittance_y) - bunch_dist = GaussDist2D(bunch_twiss_x, bunch_twiss_y) - - for index in range(args.n): - (x, xp, y, yp) = bunch_dist.getCoordinates() - z = random.uniform(-25.0, 25.0) - dE = 0.0 - bunch.addParticle(x, xp, y, yp, z, dE) - - - # Tracking - # ------------------------------------------------------------------------------------ - - for turn in range(args.turns): - lattice.trackBunch(bunch) - - twiss_calc = BunchTwissAnalysis() - twiss_calc.analyzeBunch(bunch) - xrms = math.sqrt(twiss_calc.getCorrelation(0, 0)) * 1000.0 - yrms = math.sqrt(twiss_calc.getCorrelation(2, 2)) * 1000.0 - - print("turn={} xrms={:0.3f} yrms={:0.3f}".format(turn + 1, xrms, yrms)) - - filename = "bunch.dat" - filename = os.path.join(output_dir, filename) - bunch.dumpBunch(filename) - - - # Analysis - # ------------------------------------------------------------------------------------ - - # Collect phase information from bunch - phase_info = {} - for j, key in enumerate(["phase_x", "phase_y", "tune_x", "tune_y", "action_x", "action_y"]): - phase_info[key] = [] - for i in range(bunch.getSize()): - phase_info[key].append(bunch.partAttrValue("ParticlePhaseAttributes", i, j)) - - phase_info = pd.DataFrame(phase_info) - print(phase_info) - - # Read phase information from bunch file - particles = np.loadtxt(filename, comments="%") - particles = pd.DataFrame( - particles, - columns=[ # https://github.com/PyORBIT-Collaboration/PyORBIT3/issues/78 - "x", - "xp", - "y", - "yp", - "z", - "dE", - "phase_x", - "phase_y", - "tune_x", - "tune_y", - "action_x", - "action_y", - ] - ) - print(particles.iloc[:, 6:]) - - -if __name__ == "__main__": - parser = argparse.ArgumentParser() - parser.add_argument("--n", type=int, default=1000, help="# of macroparticles") - parser.add_argument("--turns", type=int, default=10) - args = parser.parse_args() - - main(args) - \ No newline at end of file +# Store some parameters as variables +lattice_alpha_x = lattice_params["alpha x"] +lattice_alpha_y = lattice_params["alpha y"] +lattice_beta_x = lattice_params["beta x [m]"] +lattice_beta_y = lattice_params["beta y [m]"] +lattice_eta_x = lattice_params["dispersion x [m]"] +lattice_etap_x = lattice_params["dispersion x [m]"] + + +# Tune diagnostics node +# ------------------------------------------------------------------------------------ + +class TuneAnalysisNode(DriftTEAPOT): + def __init__(self, name: str = "tuneanalysis no name") -> None: + DriftTEAPOT.__init__(self, name) + self.setType("tune calculator teapot") + self.setLength(0.0) + self.calc = BunchTuneAnalysis() + + def track(self, params_dict: dict) -> None: + length = self.getLength(self.getActivePartIndex()) + bunch = params_dict["bunch"] + self.calc.analyzeBunch(bunch) + + def set_twiss( + self, + beta_x: float, + alpha_x: float, + eta_x: float, + etap_x: float, + beta_y: float, + alpha_y: float, + ) -> None: + self.calc.assignTwiss(beta_x, alpha_x, eta_x, etap_x, beta_y, alpha_y) + + +tune_node = TuneAnalysisNode() +tune_node.set_twiss( + beta_x=lattice_beta_x, + beta_y=lattice_beta_y, + alpha_x=lattice_alpha_x, + alpha_y=lattice_alpha_y, + eta_x=lattice_eta_x, + etap_x=lattice_etap_x, +) +lattice.getNodes()[0].addChildNode(tune_node, 0) + + +# Bunch +# ------------------------------------------------------------------------------------ + +# Generate a matched transverse phase space distribution. The longitudinal +# distribution will be uniform in position (z) and a delta function in energy +# deviation (dE). +emittance_x = 25.0e-06 +emittance_y = 25.0e-06 +bunch_twiss_x = TwissContainer(lattice_alpha_x, lattice_beta_x, emittance_x) +bunch_twiss_y = TwissContainer(lattice_alpha_y, lattice_beta_y, emittance_y) +bunch_dist = GaussDist2D(bunch_twiss_x, bunch_twiss_y) + +n_parts = 1000 +for index in range(n_parts): + (x, xp, y, yp) = bunch_dist.getCoordinates() + z = random.uniform(-25.0, 25.0) + dE = 0.0 + bunch.addParticle(x, xp, y, yp, z, dE) + + +# Tracking +# ------------------------------------------------------------------------------------ + +n_turns = 100 +for turn in range(n_turns): + lattice.trackBunch(bunch) + + twiss_calc = BunchTwissAnalysis() + twiss_calc.analyzeBunch(bunch) + xrms = math.sqrt(twiss_calc.getCorrelation(0, 0)) * 1000.0 + yrms = math.sqrt(twiss_calc.getCorrelation(2, 2)) * 1000.0 + + print("turn={} xrms={:0.3f} yrms={:0.3f}".format(turn + 1, xrms, yrms)) + +filename = "bunch.dat" +filename = os.path.join(output_dir, filename) +bunch.dumpBunch(filename) + + +# Analysis +# ------------------------------------------------------------------------------------ + +# Collect phase information from bunch +phase_info = {} +for j, key in enumerate(["phase_x", "phase_y", "tune_x", "tune_y", "action_x", "action_y"]): + phase_info[key] = [] + for i in range(bunch.getSize()): + phase_info[key].append(bunch.partAttrValue("ParticlePhaseAttributes", i, j)) + +phase_info = pd.DataFrame(phase_info) +print(phase_info) + +# Read phase information from bunch file +particles = np.loadtxt(filename, comments="%") +particles = pd.DataFrame( + particles, + columns=[ # https://github.com/PyORBIT-Collaboration/PyORBIT3/issues/78 + "x", + "xp", + "y", + "yp", + "z", + "dE", + "phase_x", + "phase_y", + "tune_x", + "tune_y", + "action_x", + "action_y", + ] +) +print(particles.iloc[:, 6:]) \ No newline at end of file From 75164fd1a4465d329708f6b5f9b4af690ddf5bb7 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Wed, 3 Sep 2025 16:51:33 -0400 Subject: [PATCH 11/40] Add test_tune_4d.py --- examples/Diagnostics/Tunes/test_tune.py | 2 +- examples/Diagnostics/Tunes/test_tune_4d.py | 124 +++++++++++++++++++++ 2 files changed, 125 insertions(+), 1 deletion(-) create mode 100644 examples/Diagnostics/Tunes/test_tune_4d.py diff --git a/examples/Diagnostics/Tunes/test_tune.py b/examples/Diagnostics/Tunes/test_tune.py index cab3829b..c46745a3 100644 --- a/examples/Diagnostics/Tunes/test_tune.py +++ b/examples/Diagnostics/Tunes/test_tune.py @@ -119,7 +119,7 @@ def set_twiss( # Tracking # ------------------------------------------------------------------------------------ -n_turns = 100 +n_turns = 10 for turn in range(n_turns): lattice.trackBunch(bunch) diff --git a/examples/Diagnostics/Tunes/test_tune_4d.py b/examples/Diagnostics/Tunes/test_tune_4d.py new file mode 100644 index 00000000..c19ec4c1 --- /dev/null +++ b/examples/Diagnostics/Tunes/test_tune_4d.py @@ -0,0 +1,124 @@ +import math +import os +import pathlib +import random +from pprint import pprint + +import numpy as np +import pandas as pd +import matplotlib.pyplot as plt + +from orbit.core import orbit_mpi +from orbit.core.bunch import Bunch +from orbit.core.bunch import BunchTuneAnalysis4D +from orbit.core.bunch import BunchTwissAnalysis +from orbit.bunch_generators import TwissContainer +from orbit.bunch_generators import GaussDist2D +from orbit.bunch_generators import WaterBagDist2D +from orbit.lattice import AccLattice +from orbit.lattice import AccNode +from orbit.teapot import TEAPOT_Lattice +from orbit.teapot import TEAPOT_MATRIX_Lattice +from orbit.teapot import DriftTEAPOT +from orbit.teapot import QuadTEAPOT +from orbit.utils.consts import mass_proton + +from utils import make_lattice + + +# Setup +# ------------------------------------------------------------------------------------ + +path = pathlib.Path(__file__) +output_dir = os.path.join("outputs", path.stem) +os.makedirs(output_dir, exist_ok=True) + + +# Initialize lattice and bunch +# ------------------------------------------------------------------------------------ + +lattice = make_lattice() + +bunch = Bunch() +bunch.mass(mass_proton) +bunch.getSyncParticle().kinEnergy(1.000) + + +# Analyze transfer matrix +# ------------------------------------------------------------------------------------ + +matrix_lattice = TEAPOT_MATRIX_Lattice(lattice, bunch) +lattice_params = matrix_lattice.getRingParametersDict() + +norm_matrix = None + + +# Add tune diagnostic node +# ------------------------------------------------------------------------------------ + +class TuneAnalysisNode(DriftTEAPOT): + def __init__(self, name: str = "tune_analysis_no_name") -> None: + DriftTEAPOT.__init__(self, name) + self.setLength(0.0) + self._tune_analysis = BunchTuneAnalysis4D() + + def track(self, params_dict: dict) -> None: + bunch = params_dict["bunch"] + self._tune_analysis.analyzeBunch(bunch) + + def set_matrix(self, norm_matrix: np.ndarray) -> None: + self._tune_analysis.setMatrix(norm_matrix.tolist()) + + +tune_node = TuneAnalysisNode() +# tune_node.set_matrix(norm_matrix) +lattice.getNodes()[0].addChildNode(tune_node, 0) + + +# Generate phase space distribution +# ------------------------------------------------------------------------------------ + +emittance_x = 25.0e-06 +emittance_y = 25.0e-06 +bunch_twiss_x = TwissContainer(lattice_params["alpha x"], lattice_params["beta x [m]"], emittance_x) +bunch_twiss_y = TwissContainer(lattice_params["alpha y"], lattice_params["beta y [m]"], emittance_y) +bunch_dist = GaussDist2D(bunch_twiss_x, bunch_twiss_y) + +n_parts = 1000 +for index in range(n_parts): + (x, xp, y, yp) = bunch_dist.getCoordinates() + z = random.uniform(-25.0, 25.0) + dE = 0.0 + bunch.addParticle(x, xp, y, yp, z, dE) + + +# Track bunch +# ------------------------------------------------------------------------------------ + +n_turns = 10 +for turn in range(n_turns): + lattice.trackBunch(bunch) + + twiss_calc = BunchTwissAnalysis() + twiss_calc.analyzeBunch(bunch) + xrms = math.sqrt(twiss_calc.getCorrelation(0, 0)) * 1000.0 + yrms = math.sqrt(twiss_calc.getCorrelation(2, 2)) * 1000.0 + + print("turn={} xrms={:0.3f} yrms={:0.3f}".format(turn + 1, xrms, yrms)) + +filename = "bunch.dat" +filename = os.path.join(output_dir, filename) +bunch.dumpBunch(filename) + + +# Analysis +# ------------------------------------------------------------------------------------ + +phase_info = {} +for j, key in enumerate(["phase_x", "phase_y", "tune_x", "tune_y", "action_x", "action_y"]): + phase_info[key] = [] + for i in range(bunch.getSize()): + phase_info[key].append(bunch.partAttrValue("ParticlePhaseAttributes", i, j)) + +phase_info = pd.DataFrame(phase_info) +print(phase_info) \ No newline at end of file From cc3b5f5b38af955c7be4c766c4ce3aa33f8c5048 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Wed, 3 Sep 2025 16:52:20 -0400 Subject: [PATCH 12/40] Rename test_tune_4d.py to test_tune_4d_uncoupled.py This test will compute tunes in an uncoupled lattice. --- .../Tunes/{test_tune_4d.py => test_tune_4d_uncoupled.py} | 0 1 file changed, 0 insertions(+), 0 deletions(-) rename examples/Diagnostics/Tunes/{test_tune_4d.py => test_tune_4d_uncoupled.py} (100%) diff --git a/examples/Diagnostics/Tunes/test_tune_4d.py b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py similarity index 100% rename from examples/Diagnostics/Tunes/test_tune_4d.py rename to examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py From 9d9ac9c8c11022c93b8e0d976f12b6186700b91d Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Thu, 4 Sep 2025 16:48:34 -0400 Subject: [PATCH 13/40] Delete file --- .../wrap_bunch_tune_analysis_4d.cc | 146 ------------------ 1 file changed, 146 deletions(-) delete mode 100644 src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.cc diff --git a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.cc b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.cc deleted file mode 100644 index b0212742..00000000 --- a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis_4d.cc +++ /dev/null @@ -1,146 +0,0 @@ -#include "orbit_mpi.hh" -#include "pyORBIT_Object.hh" - -#include "wrap_bunch_tune_analysis_4d.hh" -#include "wrap_bunch.hh" - -#include - -#include "BunchTuneAnalysis4D.hh" - - -namespace wrap_bunch_tune_analysis_4d { - - void error(const char* msg){ ORBIT_MPI_Finalize(msg); } - - -#ifdef __cplusplus -extern "C" { -#endif - -/** -Constructor for python class wrapping C++ BunchTuneAnalysis4D instance. -It never will be called directly. -*/ -static PyObject* BunchTuneAnalysis4D_new(PyTypeObject *type, PyObject *args, PyObject *kwds){ - pyORBIT_Object* self; - self = (pyORBIT_Object *) type->tp_alloc(type, 0); - self->cpp_obj = NULL; - return (PyObject *) self; -} - -/** Implementation of the __init__ method */ -static int BunchTuneAnalysis4D_init(pyORBIT_Object *self, PyObject *args, PyObject *kwds){ - self->cpp_obj = new BunchTuneAnalysis4D(); - ((BunchTuneAnalysis4D*) self->cpp_obj)->setPyWrapper((PyObject*) self); - return 0; -} - -/** Analyzes the bunch. */ -static PyObject* BunchTuneAnalysis4D_analyzeBunch(PyObject *self, PyObject *args){ - BunchTuneAnalysis4D* cpp_BunchTuneAnalysis4D = (BunchTuneAnalysis4D*)((pyORBIT_Object*) self)->cpp_obj; - PyObject* pyBunch; - if(!PyArg_ParseTuple(args,"O:analyzeBunch",&pyBunch)){ - ORBIT_MPI_Finalize("BunchTuneAnalysis4D - analyzeBunch(Bunch* bunch) - parameter are needed."); - } - PyObject* pyORBIT_Bunch_Type = wrap_orbit_bunch::getBunchType("Bunch"); - if(!PyObject_IsInstance(pyBunch,pyORBIT_Bunch_Type)){ - ORBIT_MPI_Finalize("BunchTuneAnalysis4D - analyzeBunch(Bunch* bunch) - method needs a Bunch."); - } - Bunch* cpp_bunch = (Bunch*) ((pyORBIT_Object*)pyBunch)->cpp_obj; - cpp_BunchTuneAnalysis4D->analyzeBunch(cpp_bunch); - Py_INCREF(Py_None); - return Py_None; -} - -/** Sets normalization matrix. */ -// [TO DO] How to parse 2D Python list? -static PyObject* BunchTuneAnalysis4D_setMatrix(PyObject *self, PyObject *args){ - BunchTuneAnalysis4D* cpp_BunchTuneAnalysis4D = (BunchTuneAnalysis4D*)((pyORBIT_Object*) self)->cpp_obj; - double dummy; - if(!PyArg_ParseTuple(args,"d:setMatrix",&dummy)){ - ORBIT_MPI_Finalize("BunchTuneAnalysis4D - setMatrix(double dummy) - parameters are needed."); - } - cpp_BunchTuneAnalysis4D->setMatrix(dummy); - Py_INCREF(Py_None); - return Py_None; -} - -// Destructor for python BunchTuneAnalysis4D class (__del__ method). -static void BunchTuneAnalysis4D_del(pyORBIT_Object* self){ - //std::cerr<<"The BunchTuneAnalysis4D __del__ has been called!"<cpp_obj); - self->ob_base.ob_type->tp_free((PyObject*)self); -} - -// Definition of the methods of the python BunchTuneAnalysis4D wrapper class. -// They will be available from python level. -static PyMethodDef BunchTuneAnalysis4DClassMethods[] = { - { "analyzeBunch", BunchTuneAnalysis4D_analyzeBunch, METH_VARARGS,"Analyzes the bunch."}, - { "setMatrix", BunchTuneAnalysis4D_setMatrix, METH_VARARGS,"Sets normalization matrix."}, - {NULL} -}; - -// Definition of the memebers of the python BunchTuneAnalysis4D wrapper class. -// They will be vailable from python level. -static PyMemberDef BunchTuneAnalysis4DClassMembers [] = { - {NULL} -}; - -// New python BunchTuneAnalysis4D wrapper type definition. -static PyTypeObject pyORBIT_BunchTuneAnalysis4D_Type = { - PyVarObject_HEAD_INIT(NULL, 0) - "BunchTuneAnalysis4D", /*tp_name*/ - sizeof(pyORBIT_Object), /*tp_basicsize*/ - 0, /*tp_itemsize*/ - (destructor) BunchTuneAnalysis4D_del , /*tp_dealloc*/ - 0, /*tp_print*/ - 0, /*tp_getattr*/ - 0, /*tp_setattr*/ - 0, /*tp_compare*/ - 0, /*tp_repr*/ - 0, /*tp_as_number*/ - 0, /*tp_as_sequence*/ - 0, /*tp_as_mapping*/ - 0, /*tp_hash */ - 0, /*tp_call*/ - 0, /*tp_str*/ - 0, /*tp_getattro*/ - 0, /*tp_setattro*/ - 0, /*tp_as_buffer*/ - Py_TPFLAGS_DEFAULT | Py_TPFLAGS_BASETYPE, /*tp_flags*/ - "The BunchTuneAnalysis4D python wrapper", /* tp_doc */ - 0, /* tp_traverse */ - 0, /* tp_clear */ - 0, /* tp_richcompare */ - 0, /* tp_weaklistoffset */ - 0, /* tp_iter */ - 0, /* tp_iternext */ - BunchTuneAnalysis4DClassMethods, /* tp_methods */ - BunchTuneAnalysis4DClassMembers, /* tp_members */ - 0, /* tp_getset */ - 0, /* tp_base */ - 0, /* tp_dict */ - 0, /* tp_descr_get */ - 0, /* tp_descr_set */ - 0, /* tp_dictoffset */ - (initproc) BunchTuneAnalysis4D_init, /* tp_init */ - 0, /* tp_alloc */ - BunchTuneAnalysis4D_new, /* tp_new */ -}; - -// Initialization of the pyBunchTuneAnalysis4D class. -void initbunchtuneanalysis4d(PyObject* module){ - if (PyType_Ready(&pyORBIT_BunchTuneAnalysis4D_Type) < 0) return; - Py_INCREF(&pyORBIT_BunchTuneAnalysis4D_Type); - PyModule_AddObject(module, "BunchTuneAnalysis4D", (PyObject *)&pyORBIT_BunchTuneAnalysis4D_Type); -} - - - -#ifdef __cplusplus -} -#endif - - -} From 62439c6ecc5c11f329a0deaa04021aa78b2951b2 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Thu, 4 Sep 2025 17:12:19 -0400 Subject: [PATCH 14/40] Implement setMatrixElement method --- .../BunchDiagnostics/BunchTuneAnalysis.cc | 13 +++---- .../BunchDiagnostics/BunchTuneAnalysis.hh | 8 +--- .../wrap_bunch_tune_analysis.cc | 37 ++++++++++++++----- 3 files changed, 34 insertions(+), 24 deletions(-) diff --git a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc index 0b4dc793..0f3dae55 100644 --- a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc +++ b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc @@ -114,20 +114,17 @@ BunchTuneAnalysis4D::BunchTuneAnalysis4D(): CppPyWrapper(NULL) }; } - BunchTuneAnalysis4D::~BunchTuneAnalysis4D() { } - -void BunchTuneAnalysis4D::setMatrix(double dummy) { - // for (int i = 0; i < 4; i++) { - // for (int j = 0; j < 4; j++) { - // matrix[i][j] = _matrix[i][j]; - // } - // } +void BunchTuneAnalysis4D::setMatrixElement(int i, int j, double value) { + matrix[i][j] = value; } +double BunchTuneAnalysis4D::getMatrixElement(int i, int j) { + return matrix[i][j]; +} void BunchTuneAnalysis4D::analyzeBunch(Bunch* bunch){ diff --git a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh index 6c7694fa..8e415380 100644 --- a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh +++ b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh @@ -28,9 +28,6 @@ class BunchTuneAnalysis: public OrbitUtils::CppPyWrapper //** Assigns Twiss values at location of calculator */ void assignTwiss(double bx, double ax, double dx, double dpx, double by, double ay); - /** Returns the average value for coordinate with index ic */ - double getTune(int ic); - private: //** Twiss */ @@ -56,10 +53,9 @@ class BunchTuneAnalysis4D: public OrbitUtils::CppPyWrapper void analyzeBunch(Bunch* bunch); - // void setMatrix(double _matrix[4][4]); - void setMatrix(double dummy); + void setMatrixElement(int i, int j, double value); - double getTune(int ic); + double getMatrixElement(int i, int j); private: double matrix[4][4]; diff --git a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.cc b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.cc index bbc90fdf..5d90c8c2 100644 --- a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.cc +++ b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.cc @@ -176,7 +176,7 @@ static int BunchTuneAnalysis4D_init(pyORBIT_Object *self, PyObject *args, PyObje static PyObject* BunchTuneAnalysis4D_analyzeBunch(PyObject *self, PyObject *args){ BunchTuneAnalysis4D* cpp_BunchTuneAnalysis4D = (BunchTuneAnalysis4D*)((pyORBIT_Object*) self)->cpp_obj; PyObject* pyBunch; - if(!PyArg_ParseTuple(args,"O:analyzeBunch",&pyBunch)){ + if(!PyArg_ParseTuple(args,"O:analyzeBunch", &pyBunch)){ ORBIT_MPI_Finalize("BunchTuneAnalysis4D - analyzeBunch(Bunch* bunch) - parameter are needed."); } PyObject* pyORBIT_Bunch_Type = wrap_orbit_bunch::getBunchType("Bunch"); @@ -189,20 +189,36 @@ static PyObject* BunchTuneAnalysis4D_analyzeBunch(PyObject *self, PyObject *args return Py_None; } -/** Sets normalization matrix. */ -// [TO DO] How to parse 2D Python list? -static PyObject* BunchTuneAnalysis4D_setMatrix(PyObject *self, PyObject *args){ +/** Set normalization matrix element. */ +static PyObject* BunchTuneAnalysis4D_setMatrixElement(PyObject *self, PyObject *args){ + BunchTuneAnalysis4D* cpp_BunchTuneAnalysis4D = (BunchTuneAnalysis4D*)((pyORBIT_Object*) self)->cpp_obj; + double value; + int i; + int j; + if(!PyArg_ParseTuple(args,"iid:setMatrixElement", &i, &j, &value)){ + ORBIT_MPI_Finalize("BunchTuneAnalysis4D - setMatrixElement(int i, int j, double value) - parameters are needed."); + } + cpp_BunchTuneAnalysis4D->setMatrixElement(i, j, value); + Py_INCREF(Py_None); + return Py_None; +} + +/** Get normalization matrix element. */ +static PyObject* BunchTuneAnalysis4D_getMatrixElement(PyObject *self, PyObject *args){ BunchTuneAnalysis4D* cpp_BunchTuneAnalysis4D = (BunchTuneAnalysis4D*)((pyORBIT_Object*) self)->cpp_obj; - double dummy; - if(!PyArg_ParseTuple(args,"d:setMatrix",&dummy)){ - ORBIT_MPI_Finalize("BunchTuneAnalysis4D - setMatrix(double dummy) - parameters are needed."); + int i; + int j; + if(!PyArg_ParseTuple(args,"ii:getMatrixElement", &i, &j)){ + ORBIT_MPI_Finalize("BunchTuneAnalysis4D - getMatrixElement(int i, int j) - parameters are needed."); } - cpp_BunchTuneAnalysis4D->setMatrix(dummy); + double value = cpp_BunchTuneAnalysis4D->getMatrixElement(i, j); + return Py_BuildValue("d", value); + Py_INCREF(Py_None); return Py_None; } -// Destructor for python BunchTuneAnalysis4D class (__del__ method). +/** Destructor for python BunchTuneAnalysis4D class (__del__ method). */ static void BunchTuneAnalysis4D_del(pyORBIT_Object* self){ //std::cerr<<"The BunchTuneAnalysis4D __del__ has been called!"<cpp_obj); @@ -213,7 +229,8 @@ static void BunchTuneAnalysis4D_del(pyORBIT_Object* self){ // They will be available from python level. static PyMethodDef BunchTuneAnalysis4DClassMethods[] = { { "analyzeBunch", BunchTuneAnalysis4D_analyzeBunch, METH_VARARGS,"Analyzes the bunch."}, - { "setMatrix", BunchTuneAnalysis4D_setMatrix, METH_VARARGS,"Sets normalization matrix."}, + { "setMatrixElement", BunchTuneAnalysis4D_setMatrixElement, METH_VARARGS,"Sets normalization matrix element."}, + { "getMatrixElement", BunchTuneAnalysis4D_getMatrixElement, METH_VARARGS,"Gets normalization matrix element."}, {NULL} }; From 0cfba278654033af223e10fb6e6d7911861971c1 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Thu, 4 Sep 2025 17:33:48 -0400 Subject: [PATCH 15/40] Add example test_tune_4d_uncoupled.py This example tests the BunchTuneAnalysis4D class in an uncoupled lattice. --- .../Tunes/test_tune_4d_uncoupled.py | 78 +++++++++++++++---- 1 file changed, 63 insertions(+), 15 deletions(-) diff --git a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py index c19ec4c1..de859e2f 100644 --- a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py +++ b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py @@ -47,17 +47,30 @@ # Analyze transfer matrix # ------------------------------------------------------------------------------------ +def build_norm_matrix_from_twiss_2d(alpha: float, beta: float) -> np.ndarray: + norm_matrix_inv = np.array([[beta, 0.0], [-alpha, 1.0]]) * np.sqrt(1.0 / beta) + norm_matrix = np.linalg.inv(norm_matrix_inv) + print(norm_matrix) + + matrix_lattice = TEAPOT_MATRIX_Lattice(lattice, bunch) lattice_params = matrix_lattice.getRingParametersDict() -norm_matrix = None +lattice_alpha_x = lattice_params["alpha x"] +lattice_alpha_y = lattice_params["alpha y"] +lattice_beta_x = lattice_params["beta x"] +lattice_beta_y = lattice_params["beta y"] + +norm_matrix = np.zeros((4, 4)) +norm_matrix[0:2, 0:2] = build_norm_matrix_from_twiss_2d(lattice_alpha_x, lattice_beta_x) +norm_matrix[2:4, 2:4] = build_norm_matrix_from_twiss_2d(lattice_alpha_x, lattice_beta_y) # Add tune diagnostic node # ------------------------------------------------------------------------------------ class TuneAnalysisNode(DriftTEAPOT): - def __init__(self, name: str = "tune_analysis_no_name") -> None: + def __init__(self, name: str = "tune_analysis_4d_no_name") -> None: DriftTEAPOT.__init__(self, name) self.setLength(0.0) self._tune_analysis = BunchTuneAnalysis4D() @@ -66,33 +79,47 @@ def track(self, params_dict: dict) -> None: bunch = params_dict["bunch"] self._tune_analysis.analyzeBunch(bunch) - def set_matrix(self, norm_matrix: np.ndarray) -> None: - self._tune_analysis.setMatrix(norm_matrix.tolist()) + def set_norm_matrix(self, norm_matrix: list[list[float]]) -> None: + norm_matrix_list = list(norm_matrix) + for i in range(4): + for j in range(4): + self._tune_analysis.setMatrixElement(i, j, norm_matrix_list[i][j]) + + def get_norm_matrix(self) -> list[list[float]]: + norm_matrix = [ + [0.0, 0.0, 0.0, 0.0], + [0.0, 0.0, 0.0, 0.0], + [0.0, 0.0, 0.0, 0.0], + [0.0, 0.0, 0.0, 0.0], + ] + for i in range(4): + for j in range(4): + norm_matrix[i][j] = self._tune_analysis.getMatrixElement(i, j) tune_node = TuneAnalysisNode() -# tune_node.set_matrix(norm_matrix) +tune_node.set_matrix(norm_matrix) lattice.getNodes()[0].addChildNode(tune_node, 0) # Generate phase space distribution # ------------------------------------------------------------------------------------ -emittance_x = 25.0e-06 -emittance_y = 25.0e-06 -bunch_twiss_x = TwissContainer(lattice_params["alpha x"], lattice_params["beta x [m]"], emittance_x) -bunch_twiss_y = TwissContainer(lattice_params["alpha y"], lattice_params["beta y [m]"], emittance_y) -bunch_dist = GaussDist2D(bunch_twiss_x, bunch_twiss_y) +bunch_emitt_x = 25.0e-06 +bunch_emitt_y = 25.0e-06 +bunch_twiss_x = TwissContainer(lattice_alpha_x, lattice_beta_x, bunch_emitt_x) +bunch_twiss_y = TwissContainer(lattice_alpha_y, lattice_beta_y, bunch_emitt_y) +bunch_dist_xy = GaussDist2D(bunch_twiss_x, bunch_twiss_y) n_parts = 1000 for index in range(n_parts): - (x, xp, y, yp) = bunch_dist.getCoordinates() + (x, xp, y, yp) = bunch_dist_xy.getCoordinates() z = random.uniform(-25.0, 25.0) dE = 0.0 bunch.addParticle(x, xp, y, yp, z, dE) -# Track bunch +# Tracking # ------------------------------------------------------------------------------------ n_turns = 10 @@ -103,7 +130,6 @@ def set_matrix(self, norm_matrix: np.ndarray) -> None: twiss_calc.analyzeBunch(bunch) xrms = math.sqrt(twiss_calc.getCorrelation(0, 0)) * 1000.0 yrms = math.sqrt(twiss_calc.getCorrelation(2, 2)) * 1000.0 - print("turn={} xrms={:0.3f} yrms={:0.3f}".format(turn + 1, xrms, yrms)) filename = "bunch.dat" @@ -114,11 +140,33 @@ def set_matrix(self, norm_matrix: np.ndarray) -> None: # Analysis # ------------------------------------------------------------------------------------ +# Collect phase information from bunch phase_info = {} -for j, key in enumerate(["phase_x", "phase_y", "tune_x", "tune_y", "action_x", "action_y"]): +for j, key in enumerate(["phase_1", "phase_2", "tune_1", "tune_2", "action_1", "action_2"]): phase_info[key] = [] for i in range(bunch.getSize()): phase_info[key].append(bunch.partAttrValue("ParticlePhaseAttributes", i, j)) phase_info = pd.DataFrame(phase_info) -print(phase_info) \ No newline at end of file +print(phase_info) + +# Read phase information from file +particles = np.loadtxt(filename, comments="%") +particles = pd.DataFrame( + particles, + columns=[ # https://github.com/PyORBIT-Collaboration/PyORBIT3/issues/78 + "x", + "xp", + "y", + "yp", + "z", + "dE", + "phase_1", + "phase_2", + "tune_1", + "tune_2", + "action_1", + "action_2", + ] +) +print(particles.iloc[:, 6:]) \ No newline at end of file From 30e5e9325a4545f8d1bf984d33c64c028cf5a6a1 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Thu, 4 Sep 2025 17:48:52 -0400 Subject: [PATCH 16/40] Change function names --- examples/Diagnostics/Tunes/test_tune.py | 2 +- .../Tunes/test_tune_4d_uncoupled.py | 27 +++++++++++-------- .../BunchDiagnostics/BunchTuneAnalysis.cc | 4 +-- .../BunchDiagnostics/BunchTuneAnalysis.hh | 4 +-- .../wrap_bunch_tune_analysis.cc | 20 +++++++------- 5 files changed, 31 insertions(+), 26 deletions(-) diff --git a/examples/Diagnostics/Tunes/test_tune.py b/examples/Diagnostics/Tunes/test_tune.py index c46745a3..9b677496 100644 --- a/examples/Diagnostics/Tunes/test_tune.py +++ b/examples/Diagnostics/Tunes/test_tune.py @@ -148,7 +148,7 @@ def set_twiss( phase_info = pd.DataFrame(phase_info) print(phase_info) -# Read phase information from bunch file +# Read phase information from file particles = np.loadtxt(filename, comments="%") particles = pd.DataFrame( particles, diff --git a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py index de859e2f..560c355f 100644 --- a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py +++ b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py @@ -50,7 +50,7 @@ def build_norm_matrix_from_twiss_2d(alpha: float, beta: float) -> np.ndarray: norm_matrix_inv = np.array([[beta, 0.0], [-alpha, 1.0]]) * np.sqrt(1.0 / beta) norm_matrix = np.linalg.inv(norm_matrix_inv) - print(norm_matrix) + return norm_matrix matrix_lattice = TEAPOT_MATRIX_Lattice(lattice, bunch) @@ -58,12 +58,15 @@ def build_norm_matrix_from_twiss_2d(alpha: float, beta: float) -> np.ndarray: lattice_alpha_x = lattice_params["alpha x"] lattice_alpha_y = lattice_params["alpha y"] -lattice_beta_x = lattice_params["beta x"] -lattice_beta_y = lattice_params["beta y"] +lattice_beta_x = lattice_params["beta x [m]"] +lattice_beta_y = lattice_params["beta y [m]"] norm_matrix = np.zeros((4, 4)) norm_matrix[0:2, 0:2] = build_norm_matrix_from_twiss_2d(lattice_alpha_x, lattice_beta_x) -norm_matrix[2:4, 2:4] = build_norm_matrix_from_twiss_2d(lattice_alpha_x, lattice_beta_y) +norm_matrix[2:4, 2:4] = build_norm_matrix_from_twiss_2d(lattice_alpha_y, lattice_beta_y) + +print("Normalization matrix V^{-1}:") +print(norm_matrix) # Add tune diagnostic node @@ -73,17 +76,18 @@ class TuneAnalysisNode(DriftTEAPOT): def __init__(self, name: str = "tune_analysis_4d_no_name") -> None: DriftTEAPOT.__init__(self, name) self.setLength(0.0) - self._tune_analysis = BunchTuneAnalysis4D() + self.tune_calc = BunchTuneAnalysis4D() def track(self, params_dict: dict) -> None: bunch = params_dict["bunch"] - self._tune_analysis.analyzeBunch(bunch) + self.tune_calc.analyzeBunch(bunch) def set_norm_matrix(self, norm_matrix: list[list[float]]) -> None: norm_matrix_list = list(norm_matrix) for i in range(4): for j in range(4): - self._tune_analysis.setMatrixElement(i, j, norm_matrix_list[i][j]) + value = float(norm_matrix_list[i][j]) + self.tune_calc.setNormMatrixElement(i, j, value) def get_norm_matrix(self) -> list[list[float]]: norm_matrix = [ @@ -94,11 +98,12 @@ def get_norm_matrix(self) -> list[list[float]]: ] for i in range(4): for j in range(4): - norm_matrix[i][j] = self._tune_analysis.getMatrixElement(i, j) - - + norm_matrix[i][j] = self.tune_calc.getNormMatrixElement(i, j) + return norm_matrix + + tune_node = TuneAnalysisNode() -tune_node.set_matrix(norm_matrix) +tune_node.set_norm_matrix(norm_matrix) lattice.getNodes()[0].addChildNode(tune_node, 0) diff --git a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc index 0f3dae55..7ef31e4b 100644 --- a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc +++ b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc @@ -118,11 +118,11 @@ BunchTuneAnalysis4D::~BunchTuneAnalysis4D() { } -void BunchTuneAnalysis4D::setMatrixElement(int i, int j, double value) { +void BunchTuneAnalysis4D::setNormMatrixElement(int i, int j, double value) { matrix[i][j] = value; } -double BunchTuneAnalysis4D::getMatrixElement(int i, int j) { +double BunchTuneAnalysis4D::getNormMatrixElement(int i, int j) { return matrix[i][j]; } diff --git a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh index 8e415380..585316b4 100644 --- a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh +++ b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh @@ -53,9 +53,9 @@ class BunchTuneAnalysis4D: public OrbitUtils::CppPyWrapper void analyzeBunch(Bunch* bunch); - void setMatrixElement(int i, int j, double value); + void setNormMatrixElement(int i, int j, double value); - double getMatrixElement(int i, int j); + double getNormMatrixElement(int i, int j); private: double matrix[4][4]; diff --git a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.cc b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.cc index 5d90c8c2..d8874edd 100644 --- a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.cc +++ b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.cc @@ -190,28 +190,28 @@ static PyObject* BunchTuneAnalysis4D_analyzeBunch(PyObject *self, PyObject *args } /** Set normalization matrix element. */ -static PyObject* BunchTuneAnalysis4D_setMatrixElement(PyObject *self, PyObject *args){ +static PyObject* BunchTuneAnalysis4D_setNormMatrixElement(PyObject *self, PyObject *args){ BunchTuneAnalysis4D* cpp_BunchTuneAnalysis4D = (BunchTuneAnalysis4D*)((pyORBIT_Object*) self)->cpp_obj; double value; int i; int j; - if(!PyArg_ParseTuple(args,"iid:setMatrixElement", &i, &j, &value)){ - ORBIT_MPI_Finalize("BunchTuneAnalysis4D - setMatrixElement(int i, int j, double value) - parameters are needed."); + if(!PyArg_ParseTuple(args,"iid:setNormMatrixElement", &i, &j, &value)){ + ORBIT_MPI_Finalize("BunchTuneAnalysis4D - setNormMatrixElement(int i, int j, double value) - parameters are needed."); } - cpp_BunchTuneAnalysis4D->setMatrixElement(i, j, value); + cpp_BunchTuneAnalysis4D->setNormMatrixElement(i, j, value); Py_INCREF(Py_None); return Py_None; } /** Get normalization matrix element. */ -static PyObject* BunchTuneAnalysis4D_getMatrixElement(PyObject *self, PyObject *args){ +static PyObject* BunchTuneAnalysis4D_getNormMatrixElement(PyObject *self, PyObject *args){ BunchTuneAnalysis4D* cpp_BunchTuneAnalysis4D = (BunchTuneAnalysis4D*)((pyORBIT_Object*) self)->cpp_obj; int i; int j; - if(!PyArg_ParseTuple(args,"ii:getMatrixElement", &i, &j)){ - ORBIT_MPI_Finalize("BunchTuneAnalysis4D - getMatrixElement(int i, int j) - parameters are needed."); + if(!PyArg_ParseTuple(args,"ii:getNormMatrixElement", &i, &j)){ + ORBIT_MPI_Finalize("BunchTuneAnalysis4D - getNormMatrixElement(int i, int j) - parameters are needed."); } - double value = cpp_BunchTuneAnalysis4D->getMatrixElement(i, j); + double value = cpp_BunchTuneAnalysis4D->getNormMatrixElement(i, j); return Py_BuildValue("d", value); Py_INCREF(Py_None); @@ -229,8 +229,8 @@ static void BunchTuneAnalysis4D_del(pyORBIT_Object* self){ // They will be available from python level. static PyMethodDef BunchTuneAnalysis4DClassMethods[] = { { "analyzeBunch", BunchTuneAnalysis4D_analyzeBunch, METH_VARARGS,"Analyzes the bunch."}, - { "setMatrixElement", BunchTuneAnalysis4D_setMatrixElement, METH_VARARGS,"Sets normalization matrix element."}, - { "getMatrixElement", BunchTuneAnalysis4D_getMatrixElement, METH_VARARGS,"Gets normalization matrix element."}, + { "setNormMatrixElement", BunchTuneAnalysis4D_setNormMatrixElement, METH_VARARGS,"Sets normalization matrix element."}, + { "getNormMatrixElement", BunchTuneAnalysis4D_getNormMatrixElement, METH_VARARGS,"Gets normalization matrix element."}, {NULL} }; From adb09779fd68a514d80d6bfb35552c3a50dc7e8c Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Thu, 4 Sep 2025 18:03:03 -0400 Subject: [PATCH 17/40] Add comments --- examples/Diagnostics/Tunes/test_tune.py | 18 +++++++++++++++++ .../Tunes/test_tune_4d_uncoupled.py | 20 +++++++++++++++++++ 2 files changed, 38 insertions(+) diff --git a/examples/Diagnostics/Tunes/test_tune.py b/examples/Diagnostics/Tunes/test_tune.py index 9b677496..9632e951 100644 --- a/examples/Diagnostics/Tunes/test_tune.py +++ b/examples/Diagnostics/Tunes/test_tune.py @@ -1,3 +1,21 @@ +"""Test one-turn tune calculation. + +This example tracks a Gaussian distribution through a FODO lattice. The tunes +are estimated from the phase space coordinates before/after tracking using the +`BunchTuneAnalysis` class. This class "normalizes" the coordinates in each +2D phase plane (x-x', y-y') using the periodic lattice parameters (alpha, beta). +In the normalized frame, the turn-by-turn coordinates advance in phase around +a circle; the different in phase angle is equal to the fractional tune multiplied +by 2 pi. + +The calculation will only be correct if the distribution's covariance matrix +(in each 2D phase space) is (approximately) unchanged after one turn. This is +true in this example because the distribution is generated from the periodic +lattice parameters. + +Note that the `BunchTuneAnalysis` class also accounts for dispersion, but there +is no disperion in this lattice at the tune diagnostic node. +""" import math import os import pathlib diff --git a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py index 560c355f..2eb00fce 100644 --- a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py +++ b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py @@ -1,3 +1,23 @@ +"""Test one-turn tune calculation using 4D normalization. + +See comments on `test_tune.py`. This example is the same, but the tunes are +estimated using the `BunchTuneAnalysis4D` class. This class normalizes the +coordinates by applying a 4 x 4 matrix V^{-1}. For the calculation to work, +the motion must be decoupled in the normalized frame; i.e., particles should +advance in phase along circles in x-x' and y-y'. The fractional tunes (also +called "eigentunes" or "mode tunes") are defined by the change in phase angle +divided by 2 pi. + + +The calculation will only be correct if the distribution's covariance matrix +(in each 2D phase space) is (approximately) unchanged after one turn. This is +true in this example because the distribution is generated from the periodic +lattice parameters. + +This node accepts any normalization matrix (V^{-1}). It is up to the user to +ensure that the matrix is symplectic and that it removes the coupling between +planes. +""" import math import os import pathlib From 49e207f9699e2e185186ee1d03a20fde69a83ee9 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Thu, 4 Sep 2025 18:04:34 -0400 Subject: [PATCH 18/40] Add comments --- examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py index 2eb00fce..32a419fb 100644 --- a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py +++ b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py @@ -16,7 +16,7 @@ This node accepts any normalization matrix (V^{-1}). It is up to the user to ensure that the matrix is symplectic and that it removes the coupling between -planes. +planes. In this example, the tunes {nu1, nu2} should be the same as {nux, nuy}. """ import math import os From 0c62262fff76545ffeabd9de148150bec13a6d97 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Thu, 4 Sep 2025 18:07:25 -0400 Subject: [PATCH 19/40] Use built-in TeapotTuneAnalysisNode --- examples/Diagnostics/Tunes/test_tune.py | 41 ++++++------------------- 1 file changed, 9 insertions(+), 32 deletions(-) diff --git a/examples/Diagnostics/Tunes/test_tune.py b/examples/Diagnostics/Tunes/test_tune.py index 9632e951..326f16e4 100644 --- a/examples/Diagnostics/Tunes/test_tune.py +++ b/examples/Diagnostics/Tunes/test_tune.py @@ -33,6 +33,7 @@ from orbit.bunch_generators import TwissContainer from orbit.bunch_generators import GaussDist2D from orbit.bunch_generators import WaterBagDist2D +from orbit.diagnostics import TeapotTuneAnalysisNode from orbit.lattice import AccLattice from orbit.lattice import AccNode from orbit.teapot import TEAPOT_Lattice @@ -78,38 +79,14 @@ # Tune diagnostics node # ------------------------------------------------------------------------------------ -class TuneAnalysisNode(DriftTEAPOT): - def __init__(self, name: str = "tuneanalysis no name") -> None: - DriftTEAPOT.__init__(self, name) - self.setType("tune calculator teapot") - self.setLength(0.0) - self.calc = BunchTuneAnalysis() - - def track(self, params_dict: dict) -> None: - length = self.getLength(self.getActivePartIndex()) - bunch = params_dict["bunch"] - self.calc.analyzeBunch(bunch) - - def set_twiss( - self, - beta_x: float, - alpha_x: float, - eta_x: float, - etap_x: float, - beta_y: float, - alpha_y: float, - ) -> None: - self.calc.assignTwiss(beta_x, alpha_x, eta_x, etap_x, beta_y, alpha_y) - - -tune_node = TuneAnalysisNode() -tune_node.set_twiss( - beta_x=lattice_beta_x, - beta_y=lattice_beta_y, - alpha_x=lattice_alpha_x, - alpha_y=lattice_alpha_y, - eta_x=lattice_eta_x, - etap_x=lattice_etap_x, +tune_node = TeapotTuneAnalysisNode() +tune_node.assignTwiss( + lattice_beta_x, + lattice_alpha_x, + lattice_eta_x, + lattice_etap_x, + lattice_beta_y, + lattice_alpha_y, ) lattice.getNodes()[0].addChildNode(tune_node, 0) From 92474865a94b20104c14b3b62291496ebdfb1f08 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Thu, 4 Sep 2025 18:44:56 -0400 Subject: [PATCH 20/40] Update documentation --- examples/Diagnostics/Tunes/test_tune.py | 30 ++-- .../Tunes/test_tune_4d_uncoupled.py | 57 ++------ py/orbit/diagnostics/TeapotDiagnosticsNode.py | 132 ++++++++++++++---- py/orbit/diagnostics/__init__.py | 2 + 4 files changed, 122 insertions(+), 99 deletions(-) diff --git a/examples/Diagnostics/Tunes/test_tune.py b/examples/Diagnostics/Tunes/test_tune.py index 326f16e4..03b7747b 100644 --- a/examples/Diagnostics/Tunes/test_tune.py +++ b/examples/Diagnostics/Tunes/test_tune.py @@ -1,20 +1,8 @@ -"""Test one-turn tune calculation. +"""Test one-turn tune estimation in uncoupled lattice. This example tracks a Gaussian distribution through a FODO lattice. The tunes are estimated from the phase space coordinates before/after tracking using the -`BunchTuneAnalysis` class. This class "normalizes" the coordinates in each -2D phase plane (x-x', y-y') using the periodic lattice parameters (alpha, beta). -In the normalized frame, the turn-by-turn coordinates advance in phase around -a circle; the different in phase angle is equal to the fractional tune multiplied -by 2 pi. - -The calculation will only be correct if the distribution's covariance matrix -(in each 2D phase space) is (approximately) unchanged after one turn. This is -true in this example because the distribution is generated from the periodic -lattice parameters. - -Note that the `BunchTuneAnalysis` class also accounts for dispersion, but there -is no disperion in this lattice at the tune diagnostic node. +`BunchTuneAnalysis` class. """ import math import os @@ -73,7 +61,7 @@ lattice_beta_x = lattice_params["beta x [m]"] lattice_beta_y = lattice_params["beta y [m]"] lattice_eta_x = lattice_params["dispersion x [m]"] -lattice_etap_x = lattice_params["dispersion x [m]"] +lattice_etap_x = lattice_params["dispersion prime x"] # Tune diagnostics node @@ -81,12 +69,12 @@ tune_node = TeapotTuneAnalysisNode() tune_node.assignTwiss( - lattice_beta_x, - lattice_alpha_x, - lattice_eta_x, - lattice_etap_x, - lattice_beta_y, - lattice_alpha_y, + betax=lattice_beta_x, + alphax=lattice_alpha_x, + etax=lattice_eta_x, + etapx=lattice_etap_x, + betay=lattice_beta_y, + alphay=lattice_alpha_y, ) lattice.getNodes()[0].addChildNode(tune_node, 0) diff --git a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py index 32a419fb..d6319911 100644 --- a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py +++ b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py @@ -1,22 +1,9 @@ -"""Test one-turn tune calculation using 4D normalization. +"""Test one-turn tune estimation in uncoupled lattice using 4D normalization. See comments on `test_tune.py`. This example is the same, but the tunes are -estimated using the `BunchTuneAnalysis4D` class. This class normalizes the -coordinates by applying a 4 x 4 matrix V^{-1}. For the calculation to work, -the motion must be decoupled in the normalized frame; i.e., particles should -advance in phase along circles in x-x' and y-y'. The fractional tunes (also -called "eigentunes" or "mode tunes") are defined by the change in phase angle -divided by 2 pi. - - -The calculation will only be correct if the distribution's covariance matrix -(in each 2D phase space) is (approximately) unchanged after one turn. This is -true in this example because the distribution is generated from the periodic -lattice parameters. - -This node accepts any normalization matrix (V^{-1}). It is up to the user to -ensure that the matrix is symplectic and that it removes the coupling between -planes. In this example, the tunes {nu1, nu2} should be the same as {nux, nuy}. +estimated using the `BunchTuneAnalysis4D` class. Since there is no coupling +in the lattice, the (eigen)tunes {nu1, nu2} should be the same as horizontal +and vertical tunes {nux, nuy}. """ import math import os @@ -35,6 +22,7 @@ from orbit.bunch_generators import TwissContainer from orbit.bunch_generators import GaussDist2D from orbit.bunch_generators import WaterBagDist2D +from orbit.diagnostics import TeapotTuneAnalysis4DNode from orbit.lattice import AccLattice from orbit.lattice import AccNode from orbit.teapot import TEAPOT_Lattice @@ -75,6 +63,7 @@ def build_norm_matrix_from_twiss_2d(alpha: float, beta: float) -> np.ndarray: matrix_lattice = TEAPOT_MATRIX_Lattice(lattice, bunch) lattice_params = matrix_lattice.getRingParametersDict() +pprint(lattice_params) lattice_alpha_x = lattice_params["alpha x"] lattice_alpha_y = lattice_params["alpha y"] @@ -91,39 +80,9 @@ def build_norm_matrix_from_twiss_2d(alpha: float, beta: float) -> np.ndarray: # Add tune diagnostic node # ------------------------------------------------------------------------------------ - -class TuneAnalysisNode(DriftTEAPOT): - def __init__(self, name: str = "tune_analysis_4d_no_name") -> None: - DriftTEAPOT.__init__(self, name) - self.setLength(0.0) - self.tune_calc = BunchTuneAnalysis4D() - - def track(self, params_dict: dict) -> None: - bunch = params_dict["bunch"] - self.tune_calc.analyzeBunch(bunch) - - def set_norm_matrix(self, norm_matrix: list[list[float]]) -> None: - norm_matrix_list = list(norm_matrix) - for i in range(4): - for j in range(4): - value = float(norm_matrix_list[i][j]) - self.tune_calc.setNormMatrixElement(i, j, value) - - def get_norm_matrix(self) -> list[list[float]]: - norm_matrix = [ - [0.0, 0.0, 0.0, 0.0], - [0.0, 0.0, 0.0, 0.0], - [0.0, 0.0, 0.0, 0.0], - [0.0, 0.0, 0.0, 0.0], - ] - for i in range(4): - for j in range(4): - norm_matrix[i][j] = self.tune_calc.getNormMatrixElement(i, j) - return norm_matrix - -tune_node = TuneAnalysisNode() -tune_node.set_norm_matrix(norm_matrix) +tune_node = TeapotTuneAnalysis4DNode() +tune_node.setNormMatrix(norm_matrix) lattice.getNodes()[0].addChildNode(tune_node, 0) diff --git a/py/orbit/diagnostics/TeapotDiagnosticsNode.py b/py/orbit/diagnostics/TeapotDiagnosticsNode.py index 4d7b2b42..98feda23 100644 --- a/py/orbit/diagnostics/TeapotDiagnosticsNode.py +++ b/py/orbit/diagnostics/TeapotDiagnosticsNode.py @@ -1,29 +1,23 @@ -""" -This module is a collimator node class for TEAPOT lattice -""" +"""TEAPOT-style bunch diagnostic nodes.""" -import os -import math +from ..utils import orbitFinalize +from ..utils import NamedObject +from ..utils import ParamsDictObject -# import the auxiliary classes -from ..utils import orbitFinalize, NamedObject, ParamsDictObject +from ..lattice import AccNode +from ..lattice import AccActionsContainer +from ..lattice import AccNodeBunchTracker -# import general accelerator elements and lattice -from ..lattice import AccNode, AccActionsContainer, AccNodeBunchTracker - - -# import Diagnostics classes -from .diagnostics import StatLats, StatLatsSetMember -from .diagnostics import Moments, MomentsSetMember, BPMSignal - -# import teapot drift class from ..teapot import DriftTEAPOT +from .diagnostics import StatLats +from .diagnostics import StatLatsSetMember +from .diagnostics import Moments +from .diagnostics import MomentsSetMember +from .diagnostics import BPMSignal -# import Bunch diagnostics -from orbit.core import bunch - -BunchTuneAnalysis = bunch.BunchTuneAnalysis +from orbit.core.bunch import BunchTuneAnalysis +from orbit.core.bunch import BunchTuneAnalysis4D class TeapotStatLatsNode(DriftTEAPOT): @@ -186,10 +180,23 @@ def resetFile(self, file): class TeapotTuneAnalysisNode(DriftTEAPOT): - def __init__(self, name="tuneanalysis no name"): - """ - Constructor. Creates the StatLats TEAPOT element. - """ + """Tune analysis node. + + The tunes are estimated from the particle phase space coordinates on + neighboring turns. The coordinates are "normalized" in each 2D phase + plane (x-x', y-y') using provided twiss parameters (alpha, beta) as + well as the dispersion in the x plane. In the normalized frame, the + turn-by-turn coordinates advance in phase around a circle. The fractional + tune is defined by the change in angle for a single turn. + + The calculation will be incorrect if the normalization matrix does not + map the turn-by-turn coordinates to a circle. In a linear lattice + without space charge, the normalization will be correct if the provided + twiss parameters are the same as the periodic lattice twiss parameters + at the location of the node. + """ + def __init__(self, name: str = "tuneanalysis no name") -> None: + """Constructor.""" DriftTEAPOT.__init__(self, name) self.bunchtune = BunchTuneAnalysis() self.setType("tune calculator teapot") @@ -197,10 +204,8 @@ def __init__(self, name="tuneanalysis no name"): self.setLength(0.0) self.position = 0.0 - def track(self, paramsDict): - """ - The bunchtuneanalysis-teapot class implementation of the AccNodeBunchTracker class track(probe) method. - """ + def track(self, paramsDict: dict) -> None: + """Implementation of the AccNodeBunchTracker class track(probe) method.""" length = self.getLength(self.getActivePartIndex()) bunch = paramsDict["bunch"] self.bunchtune.analyzeBunch(bunch) @@ -211,10 +216,79 @@ def setPosition(self, pos): def setLatticeLength(self, lattlength): self.lattlength = lattlength - def assignTwiss(self, betax, alphax, etax, etapx, betay, alphay): + def assignTwiss( + self, + betax: float, + alphax: float, + etax: float, + etapx: float, + betay: float, + alphay: float, + ) -> None: + """Set the twiss parameters for the coordinate normalization. + + betax{y}: Beta parameter in x{y} plane. + alphax{y}: Alpha parameter in x{y} plane. + etax: Dispersion in x plane. + etapx: Disperion prime in x plane. + """ self.bunchtune.assignTwiss(betax, alphax, etax, etapx, betay, alphay) +class TeapotTuneAnalysis4DNode(DriftTEAPOT): + """Tune analysis node with 4D normalization. + + The tunes are estimated from the particle phase space coordinates on + neighboring turns. Each set of 4D phase space coordinates is normalized + with the provided 4 x 4 matrix. + + In the normalized frame (if the matrix is properly chosen), the + turn-by-turn coordinates advance in phase around a circle. The fractional + tune is defined by the change in angle on a single turn, divided by + 2 pi. + + Note that any normalization matrix is allowed. It is up to the user + to ensure proper normalization, i.e., based on the one-turn transfer + matrix. + """ + def __init__(self, name: str = "tuneanalysis4d no name") -> None: + DriftTEAPOT.__init__(self, name) + self.bunchtune = BunchTuneAnalysis4D() + self.setType("tune calculator 4d teapot") + self.lattlength = 0.0 + self.setLength(0.0) + self.position = 0.0 + + def track(self, paramsDict: dict) -> None: + bunch = paramsDict["bunch"] + self.bunchtune.analyzeBunch(bunch) + + def setPosition(self, pos: float) -> None: + self.position = pos + + def setLatticeLength(self, lattlength: float) -> None: + self.lattlength = lattlength + + def setNormMatrix(self, norm_matrix: list[list[float]]) -> None: + norm_matrix_list = list(norm_matrix) + for i in range(4): + for j in range(4): + value = float(norm_matrix_list[i][j]) + self.bunchtune.setNormMatrixElement(i, j, value) + + def getNormMatrix(self) -> list[list[float]]: + norm_matrix = [ + [0.0, 0.0, 0.0, 0.0], + [0.0, 0.0, 0.0, 0.0], + [0.0, 0.0, 0.0, 0.0], + [0.0, 0.0, 0.0, 0.0], + ] + for i in range(4): + for j in range(4): + norm_matrix[i][j] = self.bunchtune.getNormMatrixElement(i, j) + return norm_matrix + + class TeapotBPMSignalNode(DriftTEAPOT): def __init__(self, name="BPMSignal no name"): """ diff --git a/py/orbit/diagnostics/__init__.py b/py/orbit/diagnostics/__init__.py index c1d197a3..e89b2e58 100644 --- a/py/orbit/diagnostics/__init__.py +++ b/py/orbit/diagnostics/__init__.py @@ -13,6 +13,7 @@ from .TeapotDiagnosticsNode import TeapotStatLatsNode, TeapotStatLatsNodeSetMember from .TeapotDiagnosticsNode import TeapotMomentsNode, TeapotMomentsNodeSetMember from .TeapotDiagnosticsNode import TeapotTuneAnalysisNode +from .TeapotDiagnosticsNode import TeapotTuneAnalysis4DNode __all__ = [] @@ -29,4 +30,5 @@ __all__.append("addTeapotStatLatsNodeSet") __all__.append("addTeapotMomentsNodeSet") __all__.append("TeapotTuneAnalysisNode") +__all__.append("TeapotTuneAnalysis4DNode") __all__.append("profiles") From fb89208b18af029593a51d2b0a28d6d842589785 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Thu, 4 Sep 2025 19:09:06 -0400 Subject: [PATCH 21/40] Add getData method to tune analysis nodes This method returns a dictionary of phase, tune, and action for each plane for a single particle in the bunch. --- examples/Diagnostics/Tunes/test_tune.py | 25 +++++++++++-------- .../Tunes/test_tune_4d_uncoupled.py | 25 +++++++++++-------- py/orbit/diagnostics/TeapotDiagnosticsNode.py | 17 +++++++++++++ 3 files changed, 45 insertions(+), 22 deletions(-) diff --git a/examples/Diagnostics/Tunes/test_tune.py b/examples/Diagnostics/Tunes/test_tune.py index 03b7747b..545772a9 100644 --- a/examples/Diagnostics/Tunes/test_tune.py +++ b/examples/Diagnostics/Tunes/test_tune.py @@ -121,17 +121,20 @@ # Analysis # ------------------------------------------------------------------------------------ -# Collect phase information from bunch -phase_info = {} -for j, key in enumerate(["phase_x", "phase_y", "tune_x", "tune_y", "action_x", "action_y"]): - phase_info[key] = [] - for i in range(bunch.getSize()): - phase_info[key].append(bunch.partAttrValue("ParticlePhaseAttributes", i, j)) - -phase_info = pd.DataFrame(phase_info) -print(phase_info) - -# Read phase information from file +# Collect phase data from bunch +phase_data = {} +for i in range(bunch.getSize()): + data = tune_node.getData(bunch, i) + for key in data: + if key in phase_data: + phase_data[key].append(data[key]) + else: + phase_data[key] = [] + +phase_data = pd.DataFrame(phase_data) +print(phase_data) + +# Read phase data from file particles = np.loadtxt(filename, comments="%") particles = pd.DataFrame( particles, diff --git a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py index d6319911..65f2dce9 100644 --- a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py +++ b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py @@ -124,17 +124,20 @@ def build_norm_matrix_from_twiss_2d(alpha: float, beta: float) -> np.ndarray: # Analysis # ------------------------------------------------------------------------------------ -# Collect phase information from bunch -phase_info = {} -for j, key in enumerate(["phase_1", "phase_2", "tune_1", "tune_2", "action_1", "action_2"]): - phase_info[key] = [] - for i in range(bunch.getSize()): - phase_info[key].append(bunch.partAttrValue("ParticlePhaseAttributes", i, j)) - -phase_info = pd.DataFrame(phase_info) -print(phase_info) - -# Read phase information from file +# Collect phase data from bunch +phase_data = {} +for i in range(bunch.getSize()): + data = tune_node.getData(bunch, i) + for key in data: + if key in phase_data: + phase_data[key].append(data[key]) + else: + phase_data[key] = [] + +phase_data = pd.DataFrame(phase_data) +print(phase_data) + +# Read phase data from file particles = np.loadtxt(filename, comments="%") particles = pd.DataFrame( particles, diff --git a/py/orbit/diagnostics/TeapotDiagnosticsNode.py b/py/orbit/diagnostics/TeapotDiagnosticsNode.py index 98feda23..9e225500 100644 --- a/py/orbit/diagnostics/TeapotDiagnosticsNode.py +++ b/py/orbit/diagnostics/TeapotDiagnosticsNode.py @@ -16,6 +16,7 @@ from .diagnostics import MomentsSetMember from .diagnostics import BPMSignal +from orbit.core.bunch import Bunch from orbit.core.bunch import BunchTuneAnalysis from orbit.core.bunch import BunchTuneAnalysis4D @@ -234,6 +235,14 @@ def assignTwiss( """ self.bunchtune.assignTwiss(betax, alphax, etax, etapx, betay, alphay) + def getData(self, bunch: Bunch, index: int) -> dict[str, float]: + """Return phase advances, tunes, and actions for a single particle.""" + keys = ["phase_x", "phase_y", "tune_x", "tune_y", "action_x", "action_y"] + data = {} + for j, key in enumerate(keys): + data[key] = bunch.partAttrValue("ParticlePhaseAttributes", index, j) + return data + class TeapotTuneAnalysis4DNode(DriftTEAPOT): """Tune analysis node with 4D normalization. @@ -287,6 +296,14 @@ def getNormMatrix(self) -> list[list[float]]: for j in range(4): norm_matrix[i][j] = self.bunchtune.getNormMatrixElement(i, j) return norm_matrix + + def getData(self, bunch: Bunch, index: int) -> dict[str, float]: + """Return phase advances, tunes, and actions for a single particle.""" + keys = ["phase_1", "phase_2", "tune_1", "tune_2", "action_1", "action_2"] + data = {} + for j, key in enumerate(keys): + data[key] = bunch.partAttrValue("ParticlePhaseAttributes", index, j) + return data class TeapotBPMSignalNode(DriftTEAPOT): From 7eaee4d0b0700e9dddcb0eff0c29b7dba0a2a54b Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 5 Sep 2025 19:48:52 -0400 Subject: [PATCH 22/40] Fix type on examples --- examples/Diagnostics/Tunes/test_tune.py | 4 ++-- examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py | 4 ++-- 2 files changed, 4 insertions(+), 4 deletions(-) diff --git a/examples/Diagnostics/Tunes/test_tune.py b/examples/Diagnostics/Tunes/test_tune.py index 545772a9..52d33c7b 100644 --- a/examples/Diagnostics/Tunes/test_tune.py +++ b/examples/Diagnostics/Tunes/test_tune.py @@ -128,8 +128,8 @@ for key in data: if key in phase_data: phase_data[key].append(data[key]) - else: - phase_data[key] = [] + else: + phase_data[key] = [] phase_data = pd.DataFrame(phase_data) print(phase_data) diff --git a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py index 65f2dce9..c5a5c236 100644 --- a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py +++ b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py @@ -131,8 +131,8 @@ def build_norm_matrix_from_twiss_2d(alpha: float, beta: float) -> np.ndarray: for key in data: if key in phase_data: phase_data[key].append(data[key]) - else: - phase_data[key] = [] + else: + phase_data[key] = [] phase_data = pd.DataFrame(phase_data) print(phase_data) From 73086e7652e08c428d9744fed4f0ccddb5752e3f Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Thu, 11 Sep 2025 11:11:24 -0400 Subject: [PATCH 23/40] Add setActive method to TeapotTuneAnalysis4DNode --- py/orbit/diagnostics/TeapotDiagnosticsNode.py | 19 +++++++++++++------ 1 file changed, 13 insertions(+), 6 deletions(-) diff --git a/py/orbit/diagnostics/TeapotDiagnosticsNode.py b/py/orbit/diagnostics/TeapotDiagnosticsNode.py index 9e225500..9e3460c3 100644 --- a/py/orbit/diagnostics/TeapotDiagnosticsNode.py +++ b/py/orbit/diagnostics/TeapotDiagnosticsNode.py @@ -267,16 +267,23 @@ def __init__(self, name: str = "tuneanalysis4d no name") -> None: self.lattlength = 0.0 self.setLength(0.0) self.position = 0.0 + self.active = True - def track(self, paramsDict: dict) -> None: - bunch = paramsDict["bunch"] + def track(self, params_dict: dict) -> None: + if not self.active: + return + + bunch = params_dict["bunch"] self.bunchtune.analyzeBunch(bunch) - def setPosition(self, pos: float) -> None: - self.position = pos + def setActive(self, active: bool) -> None: + self.active = active + + def setPosition(self, position: float) -> None: + self.position = position - def setLatticeLength(self, lattlength: float) -> None: - self.lattlength = lattlength + def setLatticeLength(self, length: float) -> None: + self.lattlength = length def setNormMatrix(self, norm_matrix: list[list[float]]) -> None: norm_matrix_list = list(norm_matrix) From c483fa4ca7e9e60c7f76e76c0545ddf0fa6fe295 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 12 Sep 2025 12:07:40 -0400 Subject: [PATCH 24/40] Unify BunchTuneAnalysis and BunchTuneAnalysis4D --- .../BunchDiagnostics/BunchTuneAnalysis.cc | 191 ++++++--------- .../BunchDiagnostics/BunchTuneAnalysis.hh | 43 +--- .../wrap_bunch_tune_analysis.cc | 222 ++++-------------- .../wrap_bunch_tune_analysis.hh | 1 - src/orbit/wrap_bunch.cc | 1 - 5 files changed, 127 insertions(+), 331 deletions(-) diff --git a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc index 7ef31e4b..938317db 100644 --- a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc +++ b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc @@ -7,35 +7,66 @@ #include #include -/** Constructor */ -BunchTuneAnalysis::BunchTuneAnalysis(): CppPyWrapper(NULL) -{ - betax = 0; - alphax = 0; - etax = 0; - etapx = 0; - betay = 0; - alphay = 0; + +BunchTuneAnalysis::BunchTuneAnalysis(): CppPyWrapper(NULL) { + double matrix[6][6] = { + {1.0, 0.0, 0.0, 0.0, 0.0, 0.0}, + {0.0, 1.0, 0.0, 0.0, 0.0, 0.0}, + {0.0, 0.0, 1.0, 0.0, 0.0, 0.0}, + {0.0, 0.0, 0.0, 1.0, 0.0, 0.0}, + {0.0, 0.0, 0.0, 0.0, 1.0, 0.0}, + {0.0, 0.0, 0.0, 0.0, 0.0, 1.0} + }; } -/** Destructor */ -BunchTuneAnalysis::~BunchTuneAnalysis() -{ + +BunchTuneAnalysis::~BunchTuneAnalysis() {} + +void BunchTuneAnalysis::setNormMatrixElement(int i, int j, double value) { + matrix[i][j] = value; } -void BunchTuneAnalysis::assignTwiss(double bx, double ax, double dx, double dpx, double by, double ay){ - betax = bx; - alphax = ax; - etax = dx; - etapx = dpx; - betay = by; - alphay = ay; +double BunchTuneAnalysis::getNormMatrixElement(int i, int j) { + return matrix[i][j]; +} + +void BunchTuneAnalysis::assignTwiss(double betax, double alphax, double etax, double etapx, double betay, double alphay) { + // Set V_{-1} = I + for (int i = 0; i < 6; i++) { + for (int j = 0; j < 6; j++) { + matrix[i][j] = 0.0; + } + } + for (int i = 0; i < 6; i++) { + matrix[i][i] = 1.0; + } + + // 2D normalization (x-x') + matrix[0][0] = 1.0 / sqrt(betax); + matrix[0][1] = 0.0; + matrix[1][0] = alphax / sqrt(betax); + matrix[1][1] = sqrt(betax); + + // 2D normalization (y-y') + matrix[2][2] = 1.0 / sqrt(betay); + matrix[2][3] = 0.0; + matrix[3][2] = alphay / sqrt(betay); + matrix[3][3] = sqrt(betay); + + // Dispersion (x-x') + matrix[0][5] = -etax / sqrt(betax); + matrix[1][5] = -etax * (alphax / sqrt(betax)) - etapx * sqrt(betax); + + // Dispersion (y-y') + double etay = 0.0; + double etapy = 0.0; + matrix[2][5] = -etay / sqrt(betay); + matrix[3][5] = -etay * (alphay / sqrt(betay)) - etapy * sqrt(betay); + } -/** Performs the Tune analysis of the bunch */ void BunchTuneAnalysis::analyzeBunch(Bunch* bunch){ - //initialization bunch->compress(); SyncPart* syncPart = bunch->getSyncPart(); double beta = syncPart->getBeta(); @@ -53,144 +84,56 @@ void BunchTuneAnalysis::analyzeBunch(Bunch* bunch){ bunch->addParticleAttributes("ParticlePhaseAttributes", tunemap); } - if(bunch->hasParticleAttributes("ParticlePhaseAttributes")){ + if (bunch->hasParticleAttributes("ParticlePhaseAttributes")){ for (int i=0; i < bunch->getSize(); i++) { + // Extract phase space coordinates double x = part_coord_arr[i][0]; double xp = part_coord_arr[i][1]; double y = part_coord_arr[i][2]; double yp = part_coord_arr[i][3]; - double Etot = syncPart->getEnergy() + syncPart->getMass(); - double dpp = 1/(beta*beta)*part_coord_arr[i][5]/Etot; - - double xval = (x - etax * dpp)/sqrt(betax); - double xpval = (xp - etapx * dpp) * sqrt(betax) + xval * alphax; - double yval = y / sqrt(betay); - double ypval = (yp + y * alphay/betay) * sqrt(betay); - - double angle = atan2(xpval, xval); - if(angle < 0.) angle += (2.0*OrbitConst::PI); - double xPhase = angle; - double xPhaseOld = bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i,0); - double xTune = (xPhaseOld - xPhase) / (2.0*OrbitConst::PI); - if(xTune < 0.) xTune += 1.; - bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 0) = xPhase; - bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 2) = xTune; - - angle = atan2(ypval, yval); - if(angle < 0.) angle += (2.0*OrbitConst::PI); - double yPhase = angle; - double yPhaseOld = bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i,1); - double yTune = (yPhaseOld - yPhase) / (2.0*OrbitConst::PI); - if(yTune < 0.) yTune += 1.; - bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 1) = yPhase; - bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 3) = yTune; - - double xcanonical = x - etax * dpp; - double ycanonical = y; - double xpfac = xp - etapx * dpp; - double ypfac = yp; - double pxcanonical = xpfac + xcanonical * (alphax/betax); - double pycanonical = ypfac + ycanonical * (alphay/betay); - double xAction = xcanonical * xcanonical / betax + pxcanonical * pxcanonical * betax; - double yAction = ycanonical * ycanonical / betay + pycanonical * pycanonical * betay; - - bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 4) = xAction; - bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 5) = yAction; - } - } - -} - - - -BunchTuneAnalysis4D::BunchTuneAnalysis4D(): CppPyWrapper(NULL) -{ - double matrix[4][4] = { - {1.0, 0.0, 0.0, 0.0}, - {0.0, 1.0, 0.0, 0.0}, - {0.0, 0.0, 1.0, 0.0}, - {0.0, 0.0, 0.0, 1.0} - }; -} - -BunchTuneAnalysis4D::~BunchTuneAnalysis4D() -{ -} - -void BunchTuneAnalysis4D::setNormMatrixElement(int i, int j, double value) { - matrix[i][j] = value; -} - -double BunchTuneAnalysis4D::getNormMatrixElement(int i, int j) { - return matrix[i][j]; -} - -void BunchTuneAnalysis4D::analyzeBunch(Bunch* bunch){ - - bunch->compress(); - SyncPart* syncPart = bunch->getSyncPart(); - double beta = syncPart->getBeta(); - double** part_coord_arr = bunch->coordArr(); - - if(!bunch->hasParticleAttributes("ParticlePhaseAttributes")){ - cerr << "Adding particle phase information attribute.\n"; - std::map tunemap; - tunemap.insert(std::make_pair("phase1", 0)); - tunemap.insert(std::make_pair("phase2", 0)); - tunemap.insert(std::make_pair("tune1", 0)); - tunemap.insert(std::make_pair("tune2", 0)); - tunemap.insert(std::make_pair("action1", 0)); - tunemap.insert(std::make_pair("action2", 0)); - bunch->addParticleAttributes("ParticlePhaseAttributes", tunemap); - } - - if (bunch->hasParticleAttributes("ParticlePhaseAttributes")) { - for (int i=0; i < bunch->getSize(); i++) { - // Get phase space coordinates - double x = part_coord_arr[i][0]; - double xp = part_coord_arr[i][1]; - double y = part_coord_arr[i][2]; - double yp = part_coord_arr[i][3]; + double z = part_coord_arr[i][4]; double Etot = syncPart->getEnergy() + syncPart->getMass(); double dpp = 1.0 / (beta * beta) * part_coord_arr[i][5] / Etot; - // Normalize coordinates - double xval = matrix[0][0] * x + matrix[0][1] * xp + matrix[0][2] * y + matrix[0][3] * yp; - double xpval = matrix[1][0] * x + matrix[1][1] * xp + matrix[1][2] * y + matrix[1][3] * yp; - double yval = matrix[2][0] * x + matrix[2][1] * xp + matrix[2][2] * y + matrix[2][3] * yp; - double ypval = matrix[3][0] * x + matrix[3][1] * xp + matrix[3][2] * y + matrix[3][3] * yp; + // Normalize phase space coordinates + double xval = matrix[0][0] * x + matrix[0][1] * xp + matrix[0][2] * y + matrix[0][3] * yp + matrix[0][4] * z + matrix[0][5] * dpp; + double xpval = matrix[1][0] * x + matrix[1][1] * xp + matrix[1][2] * y + matrix[1][3] * yp + matrix[1][4] * z + matrix[1][5] * dpp; + double yval = matrix[2][0] * x + matrix[2][1] * xp + matrix[2][2] * y + matrix[2][3] * yp + matrix[2][4] * z + matrix[2][5] * dpp; + double ypval = matrix[3][0] * x + matrix[3][1] * xp + matrix[3][2] * y + matrix[3][3] * yp + matrix[3][4] * z + matrix[3][5] * dpp; - // Compute phases (mode 1) + // Compute phase advance in normalized x-x' double angle = atan2(xpval, xval); if (angle < 0.0) { angle += (2.0 * OrbitConst::PI); } double xPhase = angle; double xPhaseOld = bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 0); - double xTune = (xPhaseOld - xPhase) / (2.0*OrbitConst::PI); - if (xTune < 0.0) { + double xTune = (xPhaseOld - xPhase) / (2.0 * OrbitConst::PI); + if (xTune < 0.0) { xTune += 1.0; } bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 0) = xPhase; bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 2) = xTune; + // Compute phase advance in normalized y-y' angle = atan2(ypval, yval); if (angle < 0.0) { angle += (2.0 * OrbitConst::PI); } double yPhase = angle; double yPhaseOld = bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 1); - double yTune = (yPhaseOld - yPhase) / (2.0*OrbitConst::PI); + double yTune = (yPhaseOld - yPhase) / (2.0 * OrbitConst::PI); if (yTune < 0.0) { yTune += 1.0; } bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 1) = yPhase; bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 3) = yTune; + // Compute actions double xAction = xval * xval + xpval * xpval; double yAction = yval * yval + ypval * ypval; - + bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 4) = xAction; bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 5) = yAction; } diff --git a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh index 585316b4..1b8d137c 100644 --- a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh +++ b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.hh @@ -9,56 +9,31 @@ using namespace std; -/** - The BunchTuneAnalysis class calculates the particle tunes -*/ +/** Estimates particle tunes using average phase advance (APA) over one turn. */ class BunchTuneAnalysis: public OrbitUtils::CppPyWrapper { public: - /** Constructor*/ BunchTuneAnalysis(); /** Destructor */ virtual ~BunchTuneAnalysis(); - /** Performs the Twiss analysis of the bunch */ - void analyzeBunch(Bunch* bunch); - - //** Assigns Twiss values at location of calculator */ - void assignTwiss(double bx, double ax, double dx, double dpx, double by, double ay); - - - private: - //** Twiss */ - double betax; - double alphax; - double etax; - double etapx; - double betay; - double alphay; - -}; - - -/** - Calculates tunes using 4D normalization. -*/ -class BunchTuneAnalysis4D: public OrbitUtils::CppPyWrapper -{ - public: - BunchTuneAnalysis4D(); - - virtual ~BunchTuneAnalysis4D(); - + /** Estimates tunes. */ void analyzeBunch(Bunch* bunch); + /** Sets element of normalization matrix. */ void setNormMatrixElement(int i, int j, double value); + /** Returns element of normalization matrix. */ double getNormMatrixElement(int i, int j); + /** Sets normalization matrix based on uncoupled Twiss parameters. */ + void assignTwiss(double betax, double alphax, double etax, double etapx, double betay, double alphay); + private: - double matrix[4][4]; + // Normalization matrix V^{-1} + double matrix[6][6]; }; diff --git a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.cc b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.cc index d8874edd..c9b65cf6 100644 --- a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.cc +++ b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.cc @@ -16,9 +16,10 @@ namespace wrap_bunch_tune_analysis{ extern "C" { #endif + /** - Constructor for python class wrapping c++ BunchTuneAnalysis instance. - It never will be called directly. +Constructor for Python class wrapping C++ BunchTuneAnalysis instance. +It never will be called directly. */ static PyObject* BunchTuneAnalysis_new(PyTypeObject *type, PyObject *args, PyObject *kwds){ pyORBIT_Object* self; @@ -27,18 +28,18 @@ static PyObject* BunchTuneAnalysis_new(PyTypeObject *type, PyObject *args, PyObj return (PyObject *) self; } -/** This is implementation of the __init__ method */ +/** Implementation of the __init__ method */ static int BunchTuneAnalysis_init(pyORBIT_Object *self, PyObject *args, PyObject *kwds){ self->cpp_obj = new BunchTuneAnalysis(); ((BunchTuneAnalysis*) self->cpp_obj)->setPyWrapper((PyObject*) self); -return 0; + return 0; } -/** Performs the Tune analysis of the bunch */ +/** Analyzes the bunch. */ static PyObject* BunchTuneAnalysis_analyzeBunch(PyObject *self, PyObject *args){ BunchTuneAnalysis* cpp_BunchTuneAnalysis = (BunchTuneAnalysis*)((pyORBIT_Object*) self)->cpp_obj; PyObject* pyBunch; - if(!PyArg_ParseTuple(args,"O:analyzeBunch",&pyBunch)){ + if(!PyArg_ParseTuple(args,"O:analyzeBunch", &pyBunch)){ ORBIT_MPI_Finalize("BunchTuneAnalysis - analyzeBunch(Bunch* bunch) - parameter are needed."); } PyObject* pyORBIT_Bunch_Type = wrap_orbit_bunch::getBunchType("Bunch"); @@ -51,7 +52,36 @@ static PyObject* BunchTuneAnalysis_analyzeBunch(PyObject *self, PyObject *args){ return Py_None; } -/** Performs the Tune analysis of the bunch */ +/** Sets normalization matrix element. */ +static PyObject* BunchTuneAnalysis_setNormMatrixElement(PyObject *self, PyObject *args){ + BunchTuneAnalysis* cpp_BunchTuneAnalysis = (BunchTuneAnalysis*)((pyORBIT_Object*) self)->cpp_obj; + double value; + int i; + int j; + if(!PyArg_ParseTuple(args,"iid:setNormMatrixElement", &i, &j, &value)){ + ORBIT_MPI_Finalize("BunchTuneAnalysis - setNormMatrixElement(int i, int j, double value) - parameters are needed."); + } + cpp_BunchTuneAnalysis->setNormMatrixElement(i, j, value); + Py_INCREF(Py_None); + return Py_None; +} + +/** Gets normalization matrix element. */ +static PyObject* BunchTuneAnalysis_getNormMatrixElement(PyObject *self, PyObject *args){ + BunchTuneAnalysis* cpp_BunchTuneAnalysis = (BunchTuneAnalysis*)((pyORBIT_Object*) self)->cpp_obj; + int i; + int j; + if(!PyArg_ParseTuple(args,"ii:getNormMatrixElement", &i, &j)){ + ORBIT_MPI_Finalize("BunchTuneAnalysis - getNormMatrixElement(int i, int j) - parameters are needed."); + } + double value = cpp_BunchTuneAnalysis->getNormMatrixElement(i, j); + return Py_BuildValue("d", value); + + Py_INCREF(Py_None); + return Py_None; +} + +/** Sets normalization matrix based on uncoupled Twiss parameters. */ static PyObject* BunchTuneAnalysis_assignTwiss(PyObject *self, PyObject *args){ BunchTuneAnalysis* cpp_BunchTuneAnalysis = (BunchTuneAnalysis*)((pyORBIT_Object*) self)->cpp_obj; double betax; @@ -60,7 +90,9 @@ static PyObject* BunchTuneAnalysis_assignTwiss(PyObject *self, PyObject *args){ double etapx; double betay; double alphay; - if(!PyArg_ParseTuple(args,"dddddd:assignTwiss",&betax, &alphax,&etax,&etapx,&betay,&alphay)){ + double etay; + double etapy; + if(!PyArg_ParseTuple(args,"dddddd:assignTwiss",&betax, &alphax, &etax, &etapx, &betay, &alphay)){ ORBIT_MPI_Finalize("BunchTuneAnalysis - getTwiss(double betax, double alphax, double etax, double etapx, double betay, double alphay) - parameter are needed."); } cpp_BunchTuneAnalysis->assignTwiss(betax, alphax, etax, etapx, betay, alphay); @@ -68,32 +100,30 @@ static PyObject* BunchTuneAnalysis_assignTwiss(PyObject *self, PyObject *args){ return Py_None; } - - -//-------------------------------------------------------------- -//destructor for python BunchTuneAnalysis class (__del__ method). -//--------------------------------------------------------------- +/** Destructor for python BunchTuneAnalysis class (__del__ method). */ static void BunchTuneAnalysis_del(pyORBIT_Object* self){ //std::cerr<<"The BunchTuneAnalysis __del__ has been called!"<cpp_obj); self->ob_base.ob_type->tp_free((PyObject*)self); } -// defenition of the methods of the python BunchTuneAnalysis wrapper class -// they will be vailable from python level +// Definition of the methods of the python BunchTuneAnalysis wrapper class. +// They will be available from python level. static PyMethodDef BunchTuneAnalysisClassMethods[] = { - { "analyzeBunch", BunchTuneAnalysis_analyzeBunch, METH_VARARGS,"Performs the Tune analysis of the bunch."}, - { "assignTwiss", BunchTuneAnalysis_assignTwiss, METH_VARARGS,"Assigns Twiss at location of tune calculator."}, + { "analyzeBunch", BunchTuneAnalysis_analyzeBunch, METH_VARARGS,"Analyzes the bunch."}, + { "setNormMatrixElement", BunchTuneAnalysis_setNormMatrixElement, METH_VARARGS,"Sets normalization matrix element."}, + { "getNormMatrixElement", BunchTuneAnalysis_getNormMatrixElement, METH_VARARGS,"Gets normalization matrix element."}, + { "assignTwiss", BunchTuneAnalysis_assignTwiss, METH_VARARGS,"Sets normalization matrix based on uncoupled Twiss parameters."}, {NULL} }; -// defenition of the memebers of the python BunchTwissAnalysis wrapper class -// they will be vailable from python level +// Definition of the memebers of the python BunchTuneAnalysis wrapper class. +// They will be vailable from python level. static PyMemberDef BunchTuneAnalysisClassMembers [] = { {NULL} }; -//new python BunchTwissAnalysis wrapper type definition +// New python BunchTuneAnalysis wrapper type definition. static PyTypeObject pyORBIT_BunchTuneAnalysis_Type = { PyVarObject_HEAD_INIT(NULL, 0) "BunchTuneAnalysis", /*tp_name*/ @@ -135,10 +165,7 @@ static PyTypeObject pyORBIT_BunchTuneAnalysis_Type = { BunchTuneAnalysis_new, /* tp_new */ }; - -//-------------------------------------------------- -//Initialization BunchTwissAnalysis of the pyBunchTwissAnalysis class -//-------------------------------------------------- +// Initialization of the pyBunchTuneAnalysis class. void initbunchtuneanalysis(PyObject* module){ if (PyType_Ready(&pyORBIT_BunchTuneAnalysis_Type) < 0) return; Py_INCREF(&pyORBIT_BunchTuneAnalysis_Type); @@ -146,153 +173,6 @@ void initbunchtuneanalysis(PyObject* module){ } - - - -//----------------------------------------------------------------------------------- -// BunchTwissAnalysis4D -//----------------------------------------------------------------------------------- - - -/** -Constructor for python class wrapping C++ BunchTuneAnalysis4D instance. -It never will be called directly. -*/ -static PyObject* BunchTuneAnalysis4D_new(PyTypeObject *type, PyObject *args, PyObject *kwds){ - pyORBIT_Object* self; - self = (pyORBIT_Object *) type->tp_alloc(type, 0); - self->cpp_obj = NULL; - return (PyObject *) self; -} - -/** Implementation of the __init__ method */ -static int BunchTuneAnalysis4D_init(pyORBIT_Object *self, PyObject *args, PyObject *kwds){ - self->cpp_obj = new BunchTuneAnalysis4D(); - ((BunchTuneAnalysis4D*) self->cpp_obj)->setPyWrapper((PyObject*) self); - return 0; -} - -/** Analyzes the bunch. */ -static PyObject* BunchTuneAnalysis4D_analyzeBunch(PyObject *self, PyObject *args){ - BunchTuneAnalysis4D* cpp_BunchTuneAnalysis4D = (BunchTuneAnalysis4D*)((pyORBIT_Object*) self)->cpp_obj; - PyObject* pyBunch; - if(!PyArg_ParseTuple(args,"O:analyzeBunch", &pyBunch)){ - ORBIT_MPI_Finalize("BunchTuneAnalysis4D - analyzeBunch(Bunch* bunch) - parameter are needed."); - } - PyObject* pyORBIT_Bunch_Type = wrap_orbit_bunch::getBunchType("Bunch"); - if(!PyObject_IsInstance(pyBunch,pyORBIT_Bunch_Type)){ - ORBIT_MPI_Finalize("BunchTuneAnalysis4D - analyzeBunch(Bunch* bunch) - method needs a Bunch."); - } - Bunch* cpp_bunch = (Bunch*) ((pyORBIT_Object*)pyBunch)->cpp_obj; - cpp_BunchTuneAnalysis4D->analyzeBunch(cpp_bunch); - Py_INCREF(Py_None); - return Py_None; -} - -/** Set normalization matrix element. */ -static PyObject* BunchTuneAnalysis4D_setNormMatrixElement(PyObject *self, PyObject *args){ - BunchTuneAnalysis4D* cpp_BunchTuneAnalysis4D = (BunchTuneAnalysis4D*)((pyORBIT_Object*) self)->cpp_obj; - double value; - int i; - int j; - if(!PyArg_ParseTuple(args,"iid:setNormMatrixElement", &i, &j, &value)){ - ORBIT_MPI_Finalize("BunchTuneAnalysis4D - setNormMatrixElement(int i, int j, double value) - parameters are needed."); - } - cpp_BunchTuneAnalysis4D->setNormMatrixElement(i, j, value); - Py_INCREF(Py_None); - return Py_None; -} - -/** Get normalization matrix element. */ -static PyObject* BunchTuneAnalysis4D_getNormMatrixElement(PyObject *self, PyObject *args){ - BunchTuneAnalysis4D* cpp_BunchTuneAnalysis4D = (BunchTuneAnalysis4D*)((pyORBIT_Object*) self)->cpp_obj; - int i; - int j; - if(!PyArg_ParseTuple(args,"ii:getNormMatrixElement", &i, &j)){ - ORBIT_MPI_Finalize("BunchTuneAnalysis4D - getNormMatrixElement(int i, int j) - parameters are needed."); - } - double value = cpp_BunchTuneAnalysis4D->getNormMatrixElement(i, j); - return Py_BuildValue("d", value); - - Py_INCREF(Py_None); - return Py_None; -} - -/** Destructor for python BunchTuneAnalysis4D class (__del__ method). */ -static void BunchTuneAnalysis4D_del(pyORBIT_Object* self){ - //std::cerr<<"The BunchTuneAnalysis4D __del__ has been called!"<cpp_obj); - self->ob_base.ob_type->tp_free((PyObject*)self); -} - -// Definition of the methods of the python BunchTuneAnalysis4D wrapper class. -// They will be available from python level. -static PyMethodDef BunchTuneAnalysis4DClassMethods[] = { - { "analyzeBunch", BunchTuneAnalysis4D_analyzeBunch, METH_VARARGS,"Analyzes the bunch."}, - { "setNormMatrixElement", BunchTuneAnalysis4D_setNormMatrixElement, METH_VARARGS,"Sets normalization matrix element."}, - { "getNormMatrixElement", BunchTuneAnalysis4D_getNormMatrixElement, METH_VARARGS,"Gets normalization matrix element."}, - {NULL} -}; - -// Definition of the memebers of the python BunchTuneAnalysis4D wrapper class. -// They will be vailable from python level. -static PyMemberDef BunchTuneAnalysis4DClassMembers [] = { - {NULL} -}; - -// New python BunchTuneAnalysis4D wrapper type definition. -static PyTypeObject pyORBIT_BunchTuneAnalysis4D_Type = { - PyVarObject_HEAD_INIT(NULL, 0) - "BunchTuneAnalysis4D", /*tp_name*/ - sizeof(pyORBIT_Object), /*tp_basicsize*/ - 0, /*tp_itemsize*/ - (destructor) BunchTuneAnalysis4D_del , /*tp_dealloc*/ - 0, /*tp_print*/ - 0, /*tp_getattr*/ - 0, /*tp_setattr*/ - 0, /*tp_compare*/ - 0, /*tp_repr*/ - 0, /*tp_as_number*/ - 0, /*tp_as_sequence*/ - 0, /*tp_as_mapping*/ - 0, /*tp_hash */ - 0, /*tp_call*/ - 0, /*tp_str*/ - 0, /*tp_getattro*/ - 0, /*tp_setattro*/ - 0, /*tp_as_buffer*/ - Py_TPFLAGS_DEFAULT | Py_TPFLAGS_BASETYPE, /*tp_flags*/ - "The BunchTuneAnalysis4D python wrapper", /* tp_doc */ - 0, /* tp_traverse */ - 0, /* tp_clear */ - 0, /* tp_richcompare */ - 0, /* tp_weaklistoffset */ - 0, /* tp_iter */ - 0, /* tp_iternext */ - BunchTuneAnalysis4DClassMethods, /* tp_methods */ - BunchTuneAnalysis4DClassMembers, /* tp_members */ - 0, /* tp_getset */ - 0, /* tp_base */ - 0, /* tp_dict */ - 0, /* tp_descr_get */ - 0, /* tp_descr_set */ - 0, /* tp_dictoffset */ - (initproc) BunchTuneAnalysis4D_init, /* tp_init */ - 0, /* tp_alloc */ - BunchTuneAnalysis4D_new, /* tp_new */ -}; - -// Initialization of the pyBunchTuneAnalysis4D class. -void initbunchtuneanalysis4d(PyObject* module){ - if (PyType_Ready(&pyORBIT_BunchTuneAnalysis4D_Type) < 0) return; - Py_INCREF(&pyORBIT_BunchTuneAnalysis4D_Type); - PyModule_AddObject(module, "BunchTuneAnalysis4D", (PyObject *)&pyORBIT_BunchTuneAnalysis4D_Type); -} - - - - - #ifdef __cplusplus } #endif diff --git a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.hh b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.hh index 87c9103a..6511745e 100644 --- a/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.hh +++ b/src/orbit/BunchDiagnostics/wrap_bunch_tune_analysis.hh @@ -9,7 +9,6 @@ extern "C" { namespace wrap_bunch_tune_analysis { void initbunchtuneanalysis(PyObject* module); - void initbunchtuneanalysis4d(PyObject* module); } #ifdef __cplusplus diff --git a/src/orbit/wrap_bunch.cc b/src/orbit/wrap_bunch.cc index c3c2dadc..68824b4e 100644 --- a/src/orbit/wrap_bunch.cc +++ b/src/orbit/wrap_bunch.cc @@ -1310,7 +1310,6 @@ extern "C" { wrap_orbit_syncpart::initsyncpart(module); wrap_bunch_twiss_analysis::initbunchtwissanalysis(module); wrap_bunch_tune_analysis::initbunchtuneanalysis(module); - wrap_bunch_tune_analysis::initbunchtuneanalysis4d(module); wrap_synch_part_redefinition::initsynchpartredefinition(module); return module; } From 1b00ec795f53d2bc00550f4827d2e719cee91567 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 12 Sep 2025 12:08:15 -0400 Subject: [PATCH 25/40] Unify BunchTuneAnalysis and BunchTuneAnalysis4D python classes --- py/orbit/diagnostics/TeapotDiagnosticsNode.py | 96 +++++-------------- py/orbit/diagnostics/__init__.py | 2 - 2 files changed, 24 insertions(+), 74 deletions(-) diff --git a/py/orbit/diagnostics/TeapotDiagnosticsNode.py b/py/orbit/diagnostics/TeapotDiagnosticsNode.py index 9e3460c3..eeedb01b 100644 --- a/py/orbit/diagnostics/TeapotDiagnosticsNode.py +++ b/py/orbit/diagnostics/TeapotDiagnosticsNode.py @@ -18,7 +18,6 @@ from orbit.core.bunch import Bunch from orbit.core.bunch import BunchTuneAnalysis -from orbit.core.bunch import BunchTuneAnalysis4D class TeapotStatLatsNode(DriftTEAPOT): @@ -211,12 +210,34 @@ def track(self, paramsDict: dict) -> None: bunch = paramsDict["bunch"] self.bunchtune.analyzeBunch(bunch) - def setPosition(self, pos): - self.position = pos + def setPosition(self, position: float) -> None: + self.position = position def setLatticeLength(self, lattlength): self.lattlength = lattlength + def setNormMatrix(self, norm_matrix: list[list[float]]) -> None: + ndim = len(norm_matrix) + norm_matrix_list = list(norm_matrix) + for i in range(ndim): + for j in range(ndim): + value = float(norm_matrix_list[i][j]) + self.bunchtune.setNormMatrixElement(i, j, value) + + def getNormMatrix(self) -> list[list[float]]: + norm_matrix = [ + [0.0, 0.0, 0.0, 0.0, 0.0, 0.0], + [0.0, 0.0, 0.0, 0.0, 0.0, 0.0], + [0.0, 0.0, 0.0, 0.0, 0.0, 0.0], + [0.0, 0.0, 0.0, 0.0, 0.0, 0.0], + [0.0, 0.0, 0.0, 0.0, 0.0, 0.0], + [0.0, 0.0, 0.0, 0.0, 0.0, 0.0], + ] + for i in range(6): + for j in range(6): + norm_matrix[i][j] = self.bunchtune.getNormMatrixElement(i, j) + return norm_matrix + def assignTwiss( self, betax: float, @@ -244,75 +265,6 @@ def getData(self, bunch: Bunch, index: int) -> dict[str, float]: return data -class TeapotTuneAnalysis4DNode(DriftTEAPOT): - """Tune analysis node with 4D normalization. - - The tunes are estimated from the particle phase space coordinates on - neighboring turns. Each set of 4D phase space coordinates is normalized - with the provided 4 x 4 matrix. - - In the normalized frame (if the matrix is properly chosen), the - turn-by-turn coordinates advance in phase around a circle. The fractional - tune is defined by the change in angle on a single turn, divided by - 2 pi. - - Note that any normalization matrix is allowed. It is up to the user - to ensure proper normalization, i.e., based on the one-turn transfer - matrix. - """ - def __init__(self, name: str = "tuneanalysis4d no name") -> None: - DriftTEAPOT.__init__(self, name) - self.bunchtune = BunchTuneAnalysis4D() - self.setType("tune calculator 4d teapot") - self.lattlength = 0.0 - self.setLength(0.0) - self.position = 0.0 - self.active = True - - def track(self, params_dict: dict) -> None: - if not self.active: - return - - bunch = params_dict["bunch"] - self.bunchtune.analyzeBunch(bunch) - - def setActive(self, active: bool) -> None: - self.active = active - - def setPosition(self, position: float) -> None: - self.position = position - - def setLatticeLength(self, length: float) -> None: - self.lattlength = length - - def setNormMatrix(self, norm_matrix: list[list[float]]) -> None: - norm_matrix_list = list(norm_matrix) - for i in range(4): - for j in range(4): - value = float(norm_matrix_list[i][j]) - self.bunchtune.setNormMatrixElement(i, j, value) - - def getNormMatrix(self) -> list[list[float]]: - norm_matrix = [ - [0.0, 0.0, 0.0, 0.0], - [0.0, 0.0, 0.0, 0.0], - [0.0, 0.0, 0.0, 0.0], - [0.0, 0.0, 0.0, 0.0], - ] - for i in range(4): - for j in range(4): - norm_matrix[i][j] = self.bunchtune.getNormMatrixElement(i, j) - return norm_matrix - - def getData(self, bunch: Bunch, index: int) -> dict[str, float]: - """Return phase advances, tunes, and actions for a single particle.""" - keys = ["phase_1", "phase_2", "tune_1", "tune_2", "action_1", "action_2"] - data = {} - for j, key in enumerate(keys): - data[key] = bunch.partAttrValue("ParticlePhaseAttributes", index, j) - return data - - class TeapotBPMSignalNode(DriftTEAPOT): def __init__(self, name="BPMSignal no name"): """ diff --git a/py/orbit/diagnostics/__init__.py b/py/orbit/diagnostics/__init__.py index e89b2e58..c1d197a3 100644 --- a/py/orbit/diagnostics/__init__.py +++ b/py/orbit/diagnostics/__init__.py @@ -13,7 +13,6 @@ from .TeapotDiagnosticsNode import TeapotStatLatsNode, TeapotStatLatsNodeSetMember from .TeapotDiagnosticsNode import TeapotMomentsNode, TeapotMomentsNodeSetMember from .TeapotDiagnosticsNode import TeapotTuneAnalysisNode -from .TeapotDiagnosticsNode import TeapotTuneAnalysis4DNode __all__ = [] @@ -30,5 +29,4 @@ __all__.append("addTeapotStatLatsNodeSet") __all__.append("addTeapotMomentsNodeSet") __all__.append("TeapotTuneAnalysisNode") -__all__.append("TeapotTuneAnalysis4DNode") __all__.append("profiles") From e3465588c16817c08070e3827fce6761cc44904b Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 12 Sep 2025 12:08:24 -0400 Subject: [PATCH 26/40] Update tune example --- .../Tunes/outputs/test_tune/bunch.dat | 1015 +++++++++++++++++ .../outputs/test_tune_4d_uncoupled/bunch.dat | 1015 +++++++++++++++++ .../Tunes/test_tune_4d_uncoupled.py | 6 +- 3 files changed, 2033 insertions(+), 3 deletions(-) create mode 100644 examples/Diagnostics/Tunes/outputs/test_tune/bunch.dat create mode 100644 examples/Diagnostics/Tunes/outputs/test_tune_4d_uncoupled/bunch.dat diff --git a/examples/Diagnostics/Tunes/outputs/test_tune/bunch.dat b/examples/Diagnostics/Tunes/outputs/test_tune/bunch.dat new file mode 100644 index 00000000..43574170 --- /dev/null +++ b/examples/Diagnostics/Tunes/outputs/test_tune/bunch.dat @@ -0,0 +1,1015 @@ +% PARTICLE_ATTRIBUTES_CONTROLLERS_NAMES ParticlePhaseAttributes +% PARTICLE_ATTRIBUTES_CONTROLLER_DICT ParticlePhaseAttributes size 6 xAction 0 xLastPhase 0 xLastTune 0 yAction 0 yLastPhase 0 yLastTune 0 +% BUNCH_ATTRIBUTE_DOUBLE charge 1 +% BUNCH_ATTRIBUTE_DOUBLE classical_radius 1.5347e-18 +% BUNCH_ATTRIBUTE_DOUBLE macro_size 0 +% BUNCH_ATTRIBUTE_DOUBLE mass 0.938272 +% SYNC_PART_COORDS 0 0 0 x, y, z positions in [m] +% SYNC_PART_MOMENTUM 0 0 1.6960377525279 px, py, pz momentum component in GeV/c +% SYNC_PART_X_AXIS 1 0 0 nxx, nxy, pxz - x-axis ort coordinates +% info only: energy of the synchronous particle [GeV] = 1 +% info only: momentum of the synchronous particle [GeV/c] = 1.6960377525279 +% info only: beta=v/c of the synchronous particle = 0.8750256554045 +% info only: gamma=1/sqrt(1-(v/c)**2) of the synchronous particle = 2.0657889919897 +% SYNC_PART_TIME 1.9060246584653e-07 time in [sec] +% x[m] px[rad] y[m] py[rad] z[m] (pz or dE [GeV]) PhaseVars +-0.00053353841 0.0019264679 -0.0023728768 0.00451823 11.15473 0 3.5462865 4.0028295 0.30957174 0.30957174 3.3838685e-05 2.5925778e-05 +0.016052551 -0.0010796933 0.00071740327 -0.0069386597 -24.326636 0 1.3953941 0.47816024 0.30957174 0.30957174 3.8906961e-05 4.8274568e-05 +0.0057484801 -0.00052091008 0.0031216119 0.012490659 2.3378761 0 1.2550202 3.269077 0.30957174 0.30957174 6.0993882e-06 0.00016457893 +0.034876448 0.002308461 -0.0078291127 -0.0071192182 -1.5907307 0 2.48768 5.8205937 0.30957174 0.30957174 0.00018207287 0.00011206812 +0.015217737 0.00053102817 -0.0056642814 0.0027910962 7.1093982 0 2.2528706 4.6320664 0.30957174 0.30957174 2.7990865e-05 4.0072853e-05 +0.0081969177 -0.001455795 -0.00058586893 -0.001069189 -5.3175185 0 0.92792542 6.1527838 0.30957174 0.30957174 2.6681716e-05 1.479962e-06 +-0.024247489 0.0010330531 0.00048850158 0.0024520119 13.606911 0 4.7164827 3.3176813 0.30957174 0.30957174 7.4263882e-05 6.2043265e-06 +-0.017532851 0.0031443202 0.000279889 -0.0016720985 8.3584392 0 4.0651771 0.54147759 0.30957174 0.30957174 0.00012380767 2.8522825e-06 +0.010784952 0.00039402385 0.0016238349 0.0014538236 -12.172981 0 2.2663737 2.6712776 0.30957174 0.30957174 1.4183005e-05 4.7548475e-06 +0.0003566723 0.0010079991 0.0058046167 0.0068512881 8.420607 0 3.4770687 2.8090023 0.30957174 0.30957174 9.2696591e-06 8.0528835e-05 +0.0075209373 0.00042703336 0.001980975 0.0011078983 -6.3889453 0 2.4224281 2.4515771 0.30957174 0.30957174 7.8706437e-06 5.1737655e-06 +-0.019452037 -0.00079725203 0.0056721518 -0.0050012194 -11.840858 0 5.4440149 1.2265016 0.30957174 0.30957174 4.7327629e-05 5.7245526e-05 +0.0072460155 -9.5140441e-05 0.0031884742 0.0076521209 11.755332 0 1.8260557 3.118201 0.30957174 0.30957174 5.846268e-06 6.8330728e-05 +0.010278729 0.00079522052 0.0025233186 -0.0085538356 6.0483318 0 2.5590053 0.66336761 0.30957174 0.30957174 1.7358736e-05 7.8995516e-05 +-0.0062316991 0.0033190819 0.00078603477 0.0062888006 -16.379802 0 3.7191569 3.3905451 0.30957174 0.30957174 0.00010461476 3.9852112e-05 +-0.0055201673 -0.0012137694 -0.010743058 0.0086168562 -22.211306 0 6.1944296 4.4146367 0.30957174 0.30957174 1.6765414e-05 0.00019000395 +-0.034150227 0.0014493494 0.0060647611 0.012038448 6.3948873 0 4.7177828 3.0459538 0.30957174 0.30957174 0.00014716139 0.00018083355 +-0.01050912 -0.0020513583 -0.0030589314 0.0039432379 23.167352 0 6.1451811 4.1796016 0.30957174 0.30957174 5.045685e-05 2.4856735e-05 +-0.0032521047 -0.0010126354 0.00069193794 -0.0018116763 -18.765538 0 0.035354091 0.74184905 0.30957174 0.30957174 1.0502055e-05 3.7383129e-06 +-0.042058981 -0.0025930601 -0.006301898 0.0094856585 14.207953 0 5.5984099 4.1060453 0.30957174 0.30957174 0.00025544197 0.00012928783 +0.017881527 0.0035595634 -0.0039339754 0.0060882378 19.654341 0 3.0119244 4.0932709 0.30957174 0.30957174 0.00015052137 5.2369245e-05 +-0.018620719 6.1256081e-06 -0.0089035385 -0.0020794093 5.0062168 0 5.0836926 5.3143339 0.30957174 0.30957174 3.8063447e-05 8.4208194e-05 +-0.00053305458 0.00038824715 0.0013209288 -0.0028068977 -16.316282 0 3.6654883 0.81728932 0.30957174 0.30957174 1.4043024e-06 9.5740453e-06 +-0.025653842 0.0014490835 0.0063914034 -0.0082622705 -9.4785053 0 4.6114676 1.0366463 0.30957174 0.30957174 9.1374654e-05 0.00010889617 +-0.0074732153 -0.00022149989 0.0052286851 0.0072247735 14.417174 0 5.3503958 2.8855659 0.30957174 0.30957174 6.5778557e-06 7.9337302e-05 +-0.0034289135 0.0032201249 0.016929839 -0.0017384006 -16.357773 0 3.6322596 1.8435943 0.30957174 0.30957174 9.5747686e-05 0.00029195351 +0.0081034561 0.0020823725 0.0094974866 -0.00097251006 -13.097487 0 3.112167 1.8438751 0.30957174 0.30957174 4.6709381e-05 9.187569e-05 +0.0025752754 -0.0005025236 0.0055772413 -0.0049253524 3.9405681 0 0.88674486 1.2257144 0.30957174 0.30957174 3.0284364e-06 5.5422128e-05 +0.013726602 9.5934836e-05 0.0020512199 -0.0027096942 24.297572 0 2.008676 1.0261732 0.30957174 0.30957174 2.0767975e-05 1.1524874e-05 +0.0090718825 0.0034082343 0.0028952082 -0.0025429574 17.501914 0 3.2316079 1.2284052 0.30957174 0.30957174 0.00011484962 1.4864905e-05 +-0.0060525809 0.0012085305 0.0018080293 -0.0035300648 -1.1081685 0 4.0185725 0.85094642 0.30957174 0.30957174 1.7326204e-05 1.5656215e-05 +0.011481774 -0.0010704618 0.0016957418 0.00077138283 -8.7957317 0 1.2410207 2.3689611 0.30957174 0.30957174 2.4910357e-05 3.489201e-06 +-0.014155327 0.00051465396 0.0038867853 0.0021721475 3.3410243 0 4.7668642 2.4512625 0.30957174 0.30957174 2.4409167e-05 1.9910324e-05 +0.012327073 0.00019066255 -0.0021562054 -0.0074436985 -24.033575 0 2.0850698 0.090171462 0.30957174 0.30957174 1.7012498e-05 5.9647742e-05 +-0.021500397 0.00093678155 0.0087012843 0.0019150258 15.442127 0 4.7088586 2.1600304 0.30957174 0.30957174 5.874031e-05 7.996721e-05 +0.002532024 -0.00039608111 0.0060940308 0.0086347253 -11.812598 0 0.98621341 2.8974827 0.30957174 0.30957174 2.1328775e-06 0.00011139556 +-0.024570009 -0.00091047446 -0.0088232898 0.00063090088 -6.0226922 0 5.4122391 5.015882 0.30957174 0.30957174 7.3822107e-05 7.8879881e-05 +0.0077839722 0.0020329936 -0.0037047195 -0.0056210682 17.245703 0 3.1179958 6.0710191 0.30957174 0.30957174 4.430104e-05 4.5177753e-05 +-0.039532631 -0.0037819478 -0.0040340341 -0.0020427185 -19.737015 0 5.8035119 5.5521566 0.30957174 0.30957174 0.00030185525 2.0545047e-05 +-0.012250269 -0.0031563696 -0.0064933408 -4.8515008e-05 3.4761564 0 6.2547188 5.0941002 0.30957174 0.30957174 0.00010722784 4.2509517e-05 +-0.020164211 0.0021931873 -0.0062594778 0.0024129232 12.186319 0 4.3059156 4.7214762 0.30957174 0.30957174 8.8451567e-05 4.5275579e-05 +-0.01349985 0.0010020856 0.0011732701 -0.00042396521 -2.758671 0 4.492127 1.6009301 0.30957174 0.30957174 2.9153827e-05 1.5660772e-06 +0.011940338 0.00053211711 -0.0010333154 -0.0011100165 23.970535 0 2.3307271 5.9038079 0.30957174 0.30957174 1.8230397e-05 2.2986185e-06 +-0.032855231 -0.001469868 0.0093885049 -0.0047953388 23.05332 0 5.4736724 1.4761535 0.30957174 0.30957174 0.00013818148 0.00011167189 +-0.0013040119 0.0051016911 0.0010505987 0.0014445138 -24.717018 0 3.543945 2.8832104 0.30957174 0.30957174 0.00023727871 3.1825032e-06 +0.014830385 0.0026351526 0.00035342521 0.0024234967 -22.66568 0 2.9624775 3.3699171 0.30957174 0.30957174 8.7400166e-05 5.9517727e-06 +0.0034470659 5.9730203e-06 0.0036363755 -0.00045466396 21.748992 0 1.9608799 1.8217055 0.30957174 0.30957174 1.3047241e-06 1.3536068e-05 +0.019246763 0.0014560245 -0.005223744 0.008943192 6.1055766 0 2.5484883 4.0480842 0.30957174 0.30957174 5.9977505e-05 0.00010684391 +-0.017737434 0.00060866917 0.0025982602 -0.0089421492 17.355453 0 4.7837197 0.65926001 0.30957174 0.30957174 3.7912486e-05 8.6121459e-05 +-0.025070359 0.00040220168 -0.0077550797 0.003783942 -20.686628 0 4.9415755 4.6359352 0.30957174 0.30957174 7.0470943e-05 7.4833961e-05 +0.0048789378 0.0012205469 0.002201843 0.00063487491 -2.21842 0 3.1023787 2.2236664 0.30957174 0.30957174 1.6183691e-05 5.2874404e-06 +0.017755061 0.00073764861 -0.01148556 0.0027709073 24.856687 0 2.3068942 4.8518056 0.30957174 0.30957174 3.9562984e-05 0.0001406093 +-0.022584526 0.00085652986 -0.0051845834 -0.002541648 0.078798876 0 4.7540488 5.539291 0.30957174 0.30957174 6.2675979e-05 3.3506764e-05 +-0.010688179 0.00079807623 -0.0012181202 0.0065446038 6.0878902 0 4.4893837 3.7013792 0.30957174 0.30957174 1.8342609e-05 4.3981418e-05 +-0.02580881 0.001855245 0.0029526251 -0.0011293873 4.6273898 0 4.5069331 1.5824653 0.30957174 0.30957174 0.00010447575 1.0054264e-05 +0.007575453 0.00012723218 0.0035400182 0.0030661372 -15.522012 0 2.0969143 2.6548687 0.30957174 0.30957174 6.4472888e-06 2.1959065e-05 +-0.017921493 -0.00067362811 0.0063925889 -0.002916143 4.4194926 0 5.4165781 1.5201764 0.30957174 0.30957174 3.9391771e-05 4.9633446e-05 +-0.030011928 0.0020666237 0.0017256701 -0.0032989193 4.1502842 0 4.5264575 0.85960012 0.30957174 0.30957174 0.00013778342 1.3797084e-05 +0.0097984851 0.00039475159 -0.0025353846 -0.0067886982 10.986153 0 2.2968259 0.014201291 0.30957174 0.30957174 1.1959227e-05 5.2194351e-05 +-0.011910322 -0.00028612888 0.0039115556 0.0061832445 23.27158 0 5.3021329 2.9481686 0.30957174 0.30957174 1.6318282e-05 5.3348362e-05 +0.00011200603 0.001223494 0.0055091531 0.0097552586 -20.599626 0 3.5058436 2.9983224 0.30957174 0.30957174 1.3637546e-05 0.00012499376 +0.011861211 -0.001669654 0.0056383016 0.0018702748 -24.329526 0 1.0366364 2.2629662 0.30957174 0.30957174 4.0838958e-05 3.5519237e-05 +-0.00025165206 0.0015168639 -0.0074260134 -0.0019811617 4.27204 0 3.5341032 5.3453888 0.30957174 0.30957174 2.09665e-05 5.9488475e-05 +-9.2620418e-05 0.00093640594 -0.0045775248 0.0084964115 4.8454163 0 3.5267506 4.0134631 0.30957174 0.30957174 7.9885541e-06 9.2729842e-05 +-0.017291748 -0.00055083974 0.0014660424 0.0058238455 2.517491 0 5.3691173 3.2673569 0.30957174 0.30957174 3.558783e-05 3.5809727e-05 +0.024778709 0.00055545175 -0.0058949647 0.0034867791 -9.8725207 0 2.1465276 4.5561053 0.30957174 0.30957174 7.0211851e-05 4.7093211e-05 +0.018412706 0.0023554111 0.0014198901 0.0023001953 -5.4371557 0 2.8066875 2.9592209 0.30957174 0.30957174 8.7755918e-05 7.2806395e-06 +-0.0096285346 0.00018019627 -0.0018623084 0.0044533971 -13.437039 0 4.9178323 3.9148683 0.30957174 0.30957174 1.0473068e-05 2.3168845e-05 +-0.013045998 -0.0015939206 0.0013111444 0.008366873 -4.7859612 0 5.9254954 3.3592039 0.30957174 0.30957174 4.1826959e-05 7.117163e-05 +0.015843296 -0.00043945153 -0.0030287924 0.0011219075 -19.716298 0 1.6976063 4.7345814 0.30957174 0.30957174 2.9314309e-05 1.0496863e-05 +0.016683572 0.0034769006 -0.0043881102 0.002893346 -19.033772 0 3.0310716 4.507487 0.30957174 0.30957174 0.00014067728 2.7716239e-05 +-0.0057797249 -0.0031979156 4.2988144e-06 0.0038832625 16.815099 0 0.17843932 3.5147769 0.30957174 0.30957174 9.6825662e-05 1.4957814e-05 +-0.0036245307 0.00017998388 0.012787009 -0.0016758171 23.970639 0 4.6618863 1.815825 0.30957174 0.30957174 1.7372557e-06 0.00016762613 +0.0050174107 5.9520054e-06 -0.006939218 0.0063852453 -14.049776 0 1.9559024 4.3468867 0.30957174 0.30957174 2.7638938e-06 8.8986963e-05 +-0.0059335386 0.00091534602 -0.0028729372 -0.0016871345 -5.3518582 0 4.134366 5.6141434 0.30957174 0.30957174 1.1497273e-05 1.1144458e-05 +0.0032547718 0.00032294699 -0.0019193693 -0.0081045785 -22.497035 0 2.6800381 0.139932 0.30957174 0.30957174 2.1129872e-06 6.8867089e-05 +-0.0069659561 0.0015677065 0.0003797071 -0.0030101433 22.937586 0 3.9697199 0.50079211 0.30957174 0.30957174 2.7715026e-05 9.1330499e-06 +0.0010103707 0.0013983442 0.0047560963 0.0078404434 4.2881819 0 3.4367395 2.96702 0.30957174 0.30957174 1.7924237e-05 8.3780343e-05 +0.0093463348 0.0036194963 -0.00067273527 0.0049577378 12.773654 0 3.2396709 3.6518492 0.30957174 0.30957174 0.00012892915 2.4836682e-05 +-0.026844455 -0.0014573022 -0.0026873934 -0.0019823057 2.8763654 0 5.5459431 5.7183536 0.30957174 0.30957174 9.8453875e-05 1.1178718e-05 +0.030001979 -0.00026757303 -0.0059830503 -0.0012701727 22.108311 0 1.8640325 5.2942355 0.30957174 0.30957174 9.9464517e-05 3.7688993e-05 +0.0018700843 0.00039448603 -0.0055873088 -0.0017307113 -11.346039 0 3.0360554 5.3847868 0.30957174 0.30957174 1.8015079e-06 3.4443643e-05 +0.0083069012 -0.0049188312 0.00044603555 0.00079939891 -9.6299122 0 0.55760999 3.0034943 0.30957174 0.30957174 0.00022797558 8.3444092e-07 +0.0038480694 0.00051736965 -0.0044438786 0.010740474 -9.8749499 0 2.8311749 3.9110732 0.30957174 0.30957174 4.0638573e-06 0.00013433405 +-0.023044413 0.00024938103 0.012376125 0.004384834 -12.852363 0 4.9884273 2.2830475 0.30957174 0.30957174 5.8863043e-05 0.00017348837 +-0.00079032486 0.0012289209 0.0050277246 0.0011894131 -5.175434 0 3.5863741 2.1755844 0.30957174 0.30957174 1.3825974e-05 2.688734e-05 +-0.02254966 -0.00092388901 0.00066446611 -0.0027804578 5.1760466 0 5.4439011 0.61072 0.30957174 0.30957174 6.3595693e-05 8.1135485e-06 +-0.0046542327 0.00086494783 0.00029507117 -0.0025069185 20.52348 0 4.0494487 0.4924102 0.30957174 0.30957174 9.1930175e-06 6.3216003e-06 +-0.012297452 -0.0019422238 0.0037917588 -0.0025666568 24.790961 0 6.0500775 1.3538031 0.30957174 0.30957174 5.0963976e-05 2.1029096e-05 +-0.020842412 -0.0002957909 -0.007225005 0.0005113734 7.6935541 0 5.2152544 5.0165983 0.30957174 0.30957174 4.8484802e-05 5.2885614e-05 +-0.01435085 0.00020623474 -0.001761774 -0.0084872326 -5.6194912 0 4.9565195 0.16800594 0.30957174 0.30957174 2.2995677e-05 7.4579816e-05 +0.0062101673 0.00024212181 0.00054279172 -0.0026672972 1.4245089 0 2.2863574 0.57665016 0.30957174 0.30957174 4.7676978e-06 7.353972e-06 +-0.0069300752 -0.0024261229 -0.00175283 -0.0069638985 -22.406556 0 0.070439592 0.12579135 0.30957174 0.30957174 5.8890593e-05 5.1201209e-05 +0.01702617 -0.0028091119 0.0044491484 0.0051568249 4.6466664 0 0.96140045 2.8000145 0.30957174 0.30957174 0.00010370639 4.6334102e-05 +0.032107619 0.0002519548 0.00012860135 -0.0010755339 19.317101 0 2.0164583 0.49426591 0.30957174 0.30957174 0.00011374729 1.1640929e-06 +0.017556731 -0.0010108109 -0.0015134477 0.00071419474 -8.1331979 0 1.4620706 4.6488993 0.30957174 0.30957174 4.3144933e-05 2.8151456e-06 +-0.0011644835 -0.0026539341 0.0028976435 -0.0013886753 -14.325605 0 0.32616992 1.5013481 0.30957174 0.30957174 6.4309537e-05 1.0377609e-05 +0.0043829004 -0.00079012544 0.004245688 0.0099652999 8.8442768 0 0.92126982 3.1101998 0.30957174 0.30957174 7.7957634e-06 0.00011667703 +-0.022316139 0.00089956413 0.0036709376 0.0026714588 -8.4756332 0 4.7347751 2.5703354 0.30957174 0.30957174 6.2041495e-05 2.0664621e-05 +0.0014940622 0.0012897784 -0.0013405744 -0.0039349018 13.268098 0 3.3894076 0.043458764 0.30957174 0.30957174 1.5398753e-05 1.7170044e-05 +0.019059554 -0.00091859731 0.0075210403 -0.0027485739 -13.171137 0 1.5313968 1.5973329 0.30957174 0.30957174 4.7565e-05 6.4520734e-05 +0.021719709 -0.0022391844 -0.0081687977 -0.0047603155 -13.595201 0 1.1910799 5.610799 0.30957174 0.30957174 9.7460764e-05 8.9750591e-05 +0.030389392 0.00037437279 -0.010867836 -0.010701686 5.3049056 0 2.0568492 5.860326 0.30957174 0.30957174 0.00010265744 0.00023267271 +-0.015290156 -0.00027917384 -0.00042327693 0.00070107125 18.015667 0 5.2515032 4.0626697 0.30957174 0.30957174 2.6374607e-05 6.6815056e-07 +-0.008769378 -0.002476316 -0.0093736641 0.005484056 9.4246321 0 0.0035267776 4.560867 0.30957174 0.30957174 6.430205e-05 0.00011841353 +-0.024397502 -0.0015970312 -0.0046455937 -8.7369544e-05 -11.045231 0 5.6243755 5.105342 0.30957174 0.30957174 8.8576996e-05 2.1765041e-05 +-0.018213993 0.001864371 -0.0059249065 0.00058631339 21.256583 0 4.3362436 4.9888454 0.30957174 0.30957174 6.808156e-05 3.5731665e-05 +0.018176071 0.0011091646 0.0010046989 0.0054461752 9.8340793 0 2.4524465 3.3320121 0.30957174 0.30957174 4.7473752e-05 3.043864e-05 +0.00098735386 -4.2634663e-05 -0.00046576571 0.010736455 15.698277 0 1.5703365 3.5596004 0.30957174 0.30957174 1.2357629e-07 0.00011455811 +-0.002313395 0.00027777079 -0.0037280589 -0.0035980221 -8.6127002 0 4.2565364 5.8502833 0.30957174 0.30957174 1.2903528e-06 2.6852806e-05 +0.018028353 -0.00044226219 -0.0071286098 -0.00058844329 20.139005 0 1.7252422 5.1683863 0.30957174 0.30957174 3.746164e-05 5.1574794e-05 +0.0052252035 -3.0221664e-05 -0.0032096932 -0.0010501052 -0.67656149 0 1.8924582 5.4004882 0.30957174 0.30957174 3.005534e-06 1.1479916e-05 +0.0034999705 0.00050188683 0.008694828 -0.0016913093 -10.299796 0 2.8625179 1.7544927 0.30957174 0.30957174 3.6393099e-06 7.9053706e-05 +0.0066054735 -0.0032501001 -0.006388028 -0.0015721421 -14.859358 0 0.59381482 5.3261239 0.30957174 0.30957174 0.00010101354 4.3591196e-05 +-0.0076974788 -0.0017081811 0.0071980321 0.0031023594 14.750532 0 6.1981016 2.3490964 0.30957174 0.30957174 3.308451e-05 6.1780833e-05 +-0.023610648 0.0010111809 -0.0021263686 0.00088062501 -11.635494 0 4.7147201 4.6969105 0.30957174 0.30957174 7.0510799e-05 5.327531e-06 +0.021884063 0.00039664195 0.001762663 0.0024824503 -4.0074568 0 2.1087251 2.8946164 0.30957174 0.30957174 5.4006674e-05 9.2450379e-06 +-0.0012069346 0.0017674205 0.00094813194 0.0072393656 18.074955 0 3.5907174 3.3846157 0.30957174 0.30957174 2.8615556e-05 5.2890929e-05 +0.0070210005 -0.00078421366 -0.0020598641 0.0061443131 -24.167038 0 1.1510365 3.8418197 0.30957174 0.30957174 1.1013582e-05 4.172495e-05 +-0.0043843351 -0.0021542589 -0.002513327 -0.0090682794 20.402298 0 0.15449258 0.10183394 0.30957174 0.30957174 4.4385259e-05 8.7937067e-05 +-0.01072185 -0.0017034247 0.00020886885 -0.0071592648 12.284438 0 6.0528469 0.40370424 0.30957174 0.30957174 3.9052024e-05 5.0884613e-05 +-0.010296355 0.0034462408 0.010996902 0.0015180177 -22.750384 0 3.832819 2.0811747 0.30957174 0.30957174 0.0001198262 0.0001242034 +-0.0067169004 0.00098276826 -0.004995511 0.0051793191 -16.000109 0 4.1595796 4.2872853 0.30957174 0.30957174 1.3750922e-05 5.1766999e-05 +-0.0091450554 0.002228721 0.0053068567 0.0058013673 24.637335 0 3.939117 2.7709382 0.30957174 0.30957174 5.4428946e-05 6.1776031e-05 +-0.0058371441 0.0030931251 0.0065487079 0.0027890697 -3.5734463 0 3.7201673 2.3448075 0.30957174 0.30957174 9.0893611e-05 5.095118e-05 +0.012762642 -0.00087179077 -0.0092797752 0.0019854866 -23.523367 0 1.388482 4.8775637 0.30957174 0.30957174 2.4804329e-05 9.0726493e-05 +-0.004922704 0.00075727451 0.0021117211 0.0010398602 21.402748 0 4.1356957 2.3994546 0.30957174 0.30957174 7.8841334e-06 5.5682839e-06 +0.012712858 0.0020049177 0.0030244234 0.0001844958 9.1321166 0 2.907804 2.0055316 0.30957174 0.30957174 5.4358717e-05 9.2554657e-06 +0.0062904866 0.0020176083 0.00039741218 0.011813338 12.809136 0 3.1861282 3.4819907 0.30957174 0.30957174 4.1425834e-05 0.00013858575 +0.0020425273 -0.00087027967 -0.0060213672 -0.0048561099 18.607247 0 0.62646044 5.7614049 0.30957174 0.30957174 7.3573015e-06 5.9943545e-05 +0.0020643758 -1.4844984e-05 0.0048261552 0.0013984789 -1.6297393 0 1.8796843 2.2249797 0.30957174 0.30957174 4.698383e-07 2.5421573e-05 +-0.0078535376 -0.0021695122 0.0020485517 0.002177001 -4.7224841 0 6.2792331 2.7568308 0.30957174 0.30957174 4.9646693e-05 8.9317853e-06 +-0.00046985757 -0.00012687753 -0.0046498128 0.0074306619 -18.316821 0 6.2713624 4.078696 0.30957174 0.30957174 1.7087696e-07 7.6565284e-05 +0.00056127242 -0.0015536649 -0.0032040277 0.0038204322 19.281295 0 0.41393721 4.2177642 0.30957174 0.30957174 2.2023477e-05 2.4827161e-05 +-0.0069062292 0.00078383055 0.0039238425 0.0073296828 10.051707 0 4.2846351 3.0209921 0.30957174 0.30957174 1.0832637e-05 6.8811891e-05 +-0.0047479565 -0.00026011372 -0.0032333871 0.0014003697 -1.3576608 0 5.5495776 4.6809332 0.30957174 0.30957174 3.0910454e-06 1.2485196e-05 +-0.00083129422 -0.00070060033 -0.00050769209 -0.0024004433 -21.890588 0 0.24477411 0.16422283 0.30957174 0.30957174 4.5471154e-06 5.9753884e-06 +-0.023737452 0.00023718034 0.0029193538 0.0014182361 -17.361663 0 4.9959201 2.3941407 0.30957174 0.30957174 6.2368114e-05 1.0587231e-05 +0.019994809 -0.0019506322 0.00015428983 -0.0067688574 10.534253 0 1.2185694 0.39727611 0.30957174 0.30957174 7.8548872e-05 4.5470956e-05 +-0.005304593 -0.00093528684 -0.0051455186 0.00098270075 16.565705 0 6.1006042 4.8994702 0.30957174 0.30957174 1.1057515e-05 2.7650083e-05 +-0.0011478989 -0.0050412159 -0.010623534 0.010310051 -10.932819 0 0.34930895 4.3203221 0.30957174 0.30957174 0.00023164905 0.00021921712 +0.010318465 0.0022076418 0.0012566058 0.00045542564 -6.6379339 0 3.0418242 2.2902048 0.30957174 0.30957174 5.6084242e-05 1.7976657e-06 +-0.01225827 0.0030030862 -0.0070131512 -0.010383856 3.5639497 0 3.9371638 6.0596968 0.30957174 0.30957174 9.8648818e-05 0.00015653784 +0.00076048918 0.00022245183 0.0020897105 0.0068278099 10.302279 0 3.156867 3.2166074 0.30957174 0.30957174 5.142647e-07 5.0644521e-05 +0.003269906 6.612929e-05 -0.0010015671 0.00034662363 -10.656117 0 2.1272784 4.756011 0.30957174 0.30957174 1.213603e-06 1.1304905e-06 +0.00084999829 0.0015383165 0.0016945898 0.0056601603 17.885384 0 3.4553098 3.2227585 0.30957174 0.30957174 2.1635903e-05 3.4673408e-05 +0.010327747 0.00018127916 0.003915124 0.0010872431 3.5910023 0 2.1036481 2.2138885 0.30957174 0.30957174 1.2008427e-05 1.6625687e-05 +-0.019112788 0.0021582291 0.0055102972 -0.0021475561 1.4061774 0 4.2871756 1.5762092 0.30957174 0.30957174 8.2532438e-05 3.5185596e-05 +-0.031225251 3.2662294e-05 -0.00070414114 -0.0055347213 -6.8037993 0 5.0771609 0.24673712 0.30957174 0.30957174 0.00010704408 3.0885301e-05 +0.0038813125 -0.00043592658 0.0052948687 0.0044793991 -3.774098 0 1.1482747 2.6432568 0.30957174 0.30957174 3.3848179e-06 4.8166948e-05 +-0.022815542 0.0050866908 0.0040801532 -0.011941519 12.848727 0 3.9734318 0.70603404 0.30957174 0.30957174 0.00029284418 0.00015823019 +-0.013294255 -0.00032947878 -0.0030949053 -0.0098343343 -12.328587 0 5.3087295 0.067076161 0.30957174 0.30957174 2.0390562e-05 0.00010558863 +-0.014414265 0.001711357 -0.0048550439 -0.0005451782 -12.891687 0 4.2621449 5.1976152 0.30957174 0.30957174 4.94875e-05 2.4058416e-05 +-0.013747156 -0.0010996017 -0.00052540118 0.0015111233 4.3489437 0 5.7163773 3.853034 0.30957174 0.30957174 3.1760495e-05 2.5433263e-06 +-0.0088024071 0.0021527796 -0.00014561258 0.0054839917 -9.7800381 0 3.9378004 3.5426553 0.30957174 0.30957174 5.0722822e-05 2.9852365e-05 +-0.024987116 0.0026327922 -0.0071478594 0.0019275965 6.3154048 0 4.3217909 4.8253145 0.30957174 0.30957174 0.00013168243 5.5193967e-05 +0.014265784 -6.5939737e-05 -0.0018431144 0.00074851557 -24.740221 0 1.9030158 4.7037449 0.30957174 0.30957174 2.2380608e-05 3.980508e-06 +0.044843198 -0.00015857461 -0.00069762464 0.0039615768 11.74479 0 1.9128951 3.6915955 0.30957174 0.30957174 0.00022098098 1.6057838e-05 +0.010164937 6.8034856e-05 0.0001782731 -0.0019426117 -19.969628 0 2.0059911 0.46655554 0.30957174 0.30957174 1.1384977e-05 3.7752666e-06 +0.0011229639 -0.0031790193 0.0059673877 0.0039439376 -15.680635 0 0.41305872 2.5253783 0.30957174 0.30957174 9.2199285e-05 5.1328869e-05 +-0.0027623688 -0.0010218553 -0.0036170993 0.00076857152 10.723272 0 0.085819696 4.8789647 0.30957174 0.30957174 1.0349577e-05 1.3775986e-05 +0.014412082 -0.00052431703 0.0072613555 0.0061628764 19.122596 0 1.6250847 2.6448459 0.30957174 0.30957174 2.5305816e-05 9.0831041e-05 +0.0042583543 0.00062154499 0.0058777628 -0.0016165417 -5.7166253 0 2.8710437 1.6787742 0.30957174 0.30957174 5.5097678e-06 3.7421802e-05 +-0.019161626 0.00068111387 0.0028173097 -0.0027492102 -2.5176192 0 4.7735436 1.1759893 0.30957174 0.30957174 4.4532577e-05 1.5498979e-05 +0.0066474656 0.0018150256 -0.00060901186 0.0063921863 3.6546696 0 3.1336169 3.6116502 0.30957174 0.30957174 3.4860096e-05 4.0903575e-05 +0.016764661 0.00087644042 0.0038773164 -0.0018850267 8.0435758 0 2.3895476 1.4957603 0.30957174 0.30957174 3.7850596e-05 1.8680727e-05 +0.019056724 0.0038246189 -0.00050904525 -0.0044434775 8.5503028 0 3.0153713 0.25931574 0.30957174 0.30957174 0.00017311579 1.984608e-05 +-0.025608346 -0.00064035831 0.0063703773 0.0043607878 23.880813 0 5.3106554 2.5415935 0.30957174 0.30957174 7.5725751e-05 5.9775226e-05 +0.022173414 -0.0027042346 -0.0074201491 0.00040028738 12.20247 0 1.1071807 5.0332304 0.30957174 0.30957174 0.00012058881 5.5666373e-05 +0.0023770707 0.0022329495 0.0066667269 -0.0057258504 -20.803329 0 3.3995583 1.239486 0.30957174 0.30957174 4.6040222e-05 7.7327819e-05 +0.012815999 -0.00047386059 0.0025174246 -0.0025348159 18.570824 0 1.6202191 1.1603155 0.30957174 0.30957174 2.0076308e-05 1.2762425e-05 +0.0039654508 0.0012612374 0.0040018822 0.0041706351 -10.578146 0 3.1835459 2.7470841 0.30957174 0.30957174 1.6216687e-05 3.3399162e-05 +0.0078162157 0.00065960921 -0.0039358227 -0.00066963985 -7.2520812 0 2.6004831 5.2538779 0.30957174 0.30957174 1.0669978e-05 1.6061769e-05 +0.013991379 0.0016816972 -6.0328988e-05 0.0079895475 0.7030157 0 2.775766 3.5235053 0.30957174 0.30957174 4.7252078e-05 6.3320395e-05 +-0.020288588 -0.0011988518 -0.002377435 -0.0031466736 3.1879901 0 5.5804842 6.0065396 0.30957174 0.30957174 5.8279567e-05 1.5519765e-05 +-0.0016153618 0.00074813481 -0.00063065676 -0.0012287412 -7.7945271 0 3.7486267 6.1799848 0.30957174 0.30957174 5.3850215e-06 1.8985669e-06 +-0.019166306 -0.00067525677 -0.0090667321 -0.00098812394 -21.833345 0 5.3972415 5.1943733 0.30957174 0.30957174 4.4479898e-05 8.3844248e-05 +-0.026976951 -0.00030616011 -0.00012567384 -0.0067316272 18.41502 0 5.1897052 0.35548114 0.30957174 0.30957174 8.0744711e-05 4.4964317e-05 +-0.0043490056 0.0024302077 0.0053537321 0.0056871682 16.045788 0 3.7098753 2.7566328 0.30957174 0.30957174 5.5875458e-05 6.0978452e-05 +-0.0061937298 0.00031729588 -0.0022037751 0.0022024325 -18.368002 0 4.6500673 4.3056551 0.30957174 0.30957174 5.1283985e-06 9.7077014e-06 +-0.010340672 0.0024538173 0.0058125331 0.0027567809 6.6131817 0 3.9491862 2.3848237 0.30957174 0.30957174 6.6587955e-05 4.1599343e-05 +0.0020921532 -0.0017345841 0.0032096647 0.0015086035 -21.3153 0 0.50594109 2.3813557 0.30957174 0.30957174 2.7888635e-05 1.2643409e-05 +-0.006380983 0.0017308419 -0.0048233961 -0.00057979171 -12.62736 0 3.9004511 5.2053611 0.30957174 0.30957174 3.1759779e-05 2.3788242e-05 +-0.033122971 -0.00039290824 -0.010612939 -0.006225721 -4.5532761 0 5.194328 5.6136733 0.30957174 0.30957174 0.00012184604 0.00015199885 +-0.0045065857 0.00096043654 -0.0093718765 0.0042224773 15.209593 0 3.9915463 4.6664124 0.30957174 0.30957174 1.0632334e-05 0.00010623321 +-0.011662839 0.0035424073 -0.001874666 -0.0020742023 -17.736933 0 3.8627087 5.9185342 0.30957174 0.30957174 0.00012924244 7.8105481e-06 +-0.011978722 0.00085858534 -0.0091111307 -0.00011830832 12.885648 0 4.5082623 5.0995686 0.30957174 0.30957174 2.2467025e-05 8.3703289e-05 +-0.018193394 0.0017678074 -0.0015860073 -0.0066738831 -19.596983 0 4.3621474 0.13915143 0.30957174 0.30957174 6.4804242e-05 4.6716489e-05 +-0.0070007113 -0.00018837734 0.004008629 -0.0052585544 -7.225989 0 5.3270678 1.0295495 0.30957174 0.30957174 5.7034215e-06 4.3628899e-05 +0.027207299 0.0026267461 -0.0091949309 0.0077489454 4.9128095 0 2.666453 4.3904224 0.30957174 0.30957174 0.00014411384 0.00014479659 +-0.0073907898 -0.0015488543 0.0021890935 0.0040420088 -7.7563012 0 6.174955 3.0161256 0.30957174 0.30957174 2.784937e-05 2.1036924e-05 +0.0052508804 0.00088239266 -0.0027056899 0.0027090991 10.166981 0 2.9372341 4.3047208 0.30957174 0.30957174 1.0119457e-05 1.4660309e-05 +-0.0062376206 -0.0022222885 -0.0055067903 7.6035586e-05 20.497722 0 0.075404228 5.0729941 0.30957174 0.30957174 4.9258454e-05 3.0577675e-05 +0.0011600668 0.003718085 0.0018418886 0.0021718015 13.957915 0 3.4816552 2.8084998 0.30957174 0.30957174 0.00012607718 8.0987918e-06 +0.004888941 0.0023026697 0.0048486751 0.007034925 3.2507007 0 3.2869066 2.9086333 0.30957174 0.30957174 5.0924399e-05 7.2791295e-05 +-0.0019089773 0.0012738029 0.004061936 0.0046143931 -21.230847 0 3.678949 2.7900544 0.30957174 0.30957174 1.5180686e-05 3.7754278e-05 +-0.029734062 0.0019073797 -0.0012412268 -0.0063364438 2.3875748 0 4.5578581 0.1793253 0.30957174 0.30957174 0.00013019623 4.1379071e-05 +0.020031614 0.001530832 -0.0011327292 0.0087640664 21.439185 0 2.5532312 3.6454635 0.30957174 0.30957174 6.5397065e-05 7.7481328e-05 +-0.0070787735 0.00092624506 0.0036139567 -0.00089602157 -1.874055 0 4.2139452 1.7039532 0.30957174 0.30957174 1.3316026e-05 1.3963514e-05 +0.03130363 0.0033541902 -0.0043328567 -0.0024246554 11.0041 0 2.7183862 5.5934186 0.30957174 0.30957174 0.00021005825 2.4758104e-05 +0.0037076789 -0.0016062062 0.0066348832 0.004620631 -1.1152763 0 0.62247941 2.5496103 0.30957174 0.30957174 2.5010357e-05 6.5558126e-05 +-0.020259577 -0.0013017734 -0.0050446273 0.01128397 23.927798 0 5.616245 3.9393336 0.30957174 0.30957174 6.0494895e-05 0.00015195414 +-0.0093466108 0.0021014875 0.0023607995 0.0021515964 -9.7022676 0 3.9700932 2.6801257 0.30957174 0.30957174 4.9819305e-05 1.0210741e-05 +0.0094890192 -0.0019311107 -0.0072773686 -0.005558389 -12.365841 0 0.86898287 5.7350463 0.30957174 0.30957174 4.3855068e-05 8.4037682e-05 +0.010066771 0.0024601402 -0.0023800336 -0.0012690324 13.722735 0 3.0937028 5.5731793 0.30957174 0.30957174 6.6257373e-05 7.3081579e-06 +0.025552186 -0.0022270443 -0.0021756589 0.012337447 8.3123626 0 1.2740597 3.6918381 0.30957174 0.30957174 0.00011685497 0.00015575391 +-0.0021155025 -0.0011176084 -0.00080616291 0.012863778 -14.559997 0 0.16942082 3.5789891 0.30957174 0.30957174 1.1869345e-05 0.00016479395 +0.021920659 0.0038012735 0.00043599585 0.0038769118 -19.943068 0 2.9515281 3.4029987 0.30957174 0.30957174 0.00018437711 1.5100553e-05 +0.018750118 -0.0015649991 -0.0062782236 -0.0022950601 7.1549394 0 1.2950208 5.4345473 0.30957174 0.30957174 6.0904849e-05 4.4962113e-05 +-0.0066471652 0.00019015243 -0.00079220079 -0.0010423433 14.202663 0 4.8317707 6.0036877 0.30957174 0.30957174 5.1798514e-06 1.7103925e-06 +0.027695322 0.00052376453 0.00060012119 -0.0085295793 24.40146 0 2.1156955 0.44511286 0.30957174 0.30957174 8.670131e-05 7.2528528e-05 +0.0074560243 0.0026630042 0.0055591526 -0.013598815 -12.27528 0 3.2176979 0.76521899 0.30957174 0.30957174 7.0702732e-05 0.00021458856 +0.011226358 -0.00048339717 0.0059227359 0.0045865799 -8.4102312 0 1.5712962 2.6001069 0.30957174 0.30957174 1.596393e-05 5.6231371e-05 +-0.026814494 -0.00031299507 0.0042738392 0.00035299145 0.13427279 0 5.1926214 2.0268397 0.30957174 0.30957174 7.9823944e-05 1.8538195e-05 +-0.006427795 -0.00085511084 0.00011168055 0.0012591304 14.088858 0 5.9675759 3.4267105 0.30957174 0.30957174 1.1196515e-05 1.5851643e-06 +0.0066964733 -0.0016320533 -0.0047150402 0.0058993004 18.169431 0 0.79750812 4.194142 0.30957174 0.30957174 2.9186421e-05 5.6933174e-05 +-0.040947452 0.0016762402 -0.0016506318 -0.0057957865 -12.377123 0 4.7297567 0.094701284 0.30957174 0.30957174 0.00020965777 3.6066323e-05 +-0.02830496 -0.0020364804 -0.004811988 -0.0039479415 17.201355 0 5.6668511 5.7697912 0.30957174 0.30957174 0.000125729 3.8804199e-05 +0.005006217 0.00074965926 -0.0019519844 0.0014927436 7.4436993 0 2.8833026 4.43774 0.30957174 0.30957174 7.8706236e-06 6.0515693e-06 +0.0016251602 0.00015668475 -0.0043476644 -0.0064984946 -21.8418 0 2.6657656 6.0640931 0.30957174 0.30957174 5.1357324e-07 6.0945235e-05 +0.014281775 -0.0023607709 0.0063610052 -0.0052535583 -16.456791 0 0.96053044 1.258744 0.30957174 0.30957174 7.3159851e-05 6.8168933e-05 +-0.023252427 -0.0026036045 -0.0052738386 -0.0026031997 -12.347361 0 5.8819826 5.5419944 0.30957174 0.30957174 0.00012110396 3.4761956e-05 +0.010808002 -0.00011239184 0.0059550097 0.00046712564 -24.705275 0 1.8506505 2.0227483 0.30957174 0.30957174 1.293844e-05 3.5967662e-05 +0.021605656 0.0014408571 -0.0033927374 -0.0064111319 -6.9149176 0 2.4910083 6.1673918 0.30957174 0.30957174 7.0156077e-05 5.2374762e-05 +0.0073987839 0.0020404545 -0.0021868327 -0.0064374073 8.2618246 0 3.1370631 0.044343759 0.30957174 0.30957174 4.3935887e-05 4.5926354e-05 +-0.037176745 0.00078848148 -0.0065442641 0.00019485976 -13.649681 0 4.8958399 5.0571629 0.30957174 0.30957174 0.00015738725 4.3214175e-05 +-0.021909615 0.00064453607 -0.0042486728 0.00059740293 -4.7642509 0 4.8248618 4.9481108 0.30957174 0.30957174 5.6480664e-05 1.8552375e-05 +-0.026185593 -0.0020995784 -0.00028982399 -0.0022480944 14.607233 0 5.7175252 0.24505401 0.30957174 0.30957174 0.00011542869 5.0977459e-06 +0.0034217645 0.0001339692 -0.0020852364 0.0030476663 -5.7239748 0 2.2876843 4.1197303 0.30957174 0.30957174 1.4488137e-06 1.3596823e-05 +-0.0048721576 -0.0058556415 -0.0026022567 -0.0062716623 2.1315881 0 0.28321361 6.261299 0.30957174 0.30957174 0.00031495308 4.5842643e-05 +0.017944814 0.00028504136 -0.005056525 0.0038126884 -6.1974411 0 2.0887956 4.4445228 0.30957174 0.30957174 3.6090111e-05 4.0195926e-05 +0.010425455 0.00087206452 0.00088527173 -0.00070877813 -1.0411508 0 2.5962195 1.273927 0.30957174 0.30957174 1.8859323e-05 1.288399e-06 +0.021522161 -0.0010890489 -0.0038693417 0.0016094824 -3.9707024 0 1.5131772 4.6953731 0.30957174 0.30957174 6.1653048e-05 1.766334e-05 +0.0052059477 -0.00050710556 -0.0026700002 0.0071725761 -19.695721 0 1.2193234 3.8749141 0.30957174 0.30957174 5.3176955e-06 5.8216877e-05 +0.025712181 1.0120373e-05 -0.0045443859 0.0066738137 5.5195191 0 1.9486821 4.1174864 0.30957174 0.30957174 7.257629e-05 6.4999436e-05 +0.020225793 0.0019869665 0.003241667 0.0035388229 12.554327 0 2.6750859 2.7702467 0.30957174 0.30957174 8.0872016e-05 2.3016073e-05 +0.0082860847 -0.0010711439 0.0003322145 0.00060757023 -0.64814905 0 1.078333 3.0120911 0.30957174 0.30957174 1.7988837e-05 4.7742292e-07 +0.0011446278 -0.00029682452 -1.5611505e-05 -0.0037437692 -19.52397 0 0.77475293 0.3700963 0.30957174 0.30957174 9.464066e-07 1.3902724e-05 +-0.0042324736 0.0017616156 0.0071848418 0.0041271184 -2.2455352 0 3.7737714 2.4629957 0.30957174 0.30957174 3.023556e-05 6.8938141e-05 +-0.013357413 -0.0032462497 0.0062322547 0.0022448595 19.298632 0 6.2332174 2.288249 0.30957174 0.30957174 0.00011558233 4.4156268e-05 +0.0095013745 -0.0029395819 -0.0079479382 -0.0041041856 19.294565 0 0.71526559 5.5600557 0.30957174 0.30957174 8.8625657e-05 8.0392806e-05 +-0.01603816 0.0019533014 0.002471529 0.0098066038 24.63303 0 4.249457 3.2670766 0.30957174 0.30957174 6.2992915e-05 0.00010155011 +-0.0043421477 0.0025370323 0.0074020104 -0.001636158 -21.310379 0 3.7016119 1.729257 0.30957174 0.30957174 6.0702566e-05 5.7891759e-05 +-0.016126722 0.0018787924 -0.001465362 -0.0032400867 -3.7117633 0 4.2715807 6.2296973 0.30957174 0.30957174 6.0704663e-05 1.2578065e-05 +-0.0097040906 0.00012628976 -0.0062010247 0.0030703677 22.848507 0 4.9686899 4.6301586 0.30957174 0.30957174 1.0482917e-05 4.8117096e-05 +0.022482148 -0.0020854861 0.0091822414 -0.005939123 6.0821665 0 1.2435108 1.3746666 0.30957174 0.30957174 9.5105427e-05 0.00011998883 +0.0202727 0.0048144472 0.0057533546 0.0084543108 -19.151054 0 3.0828991 2.9145768 0.30957174 0.30957174 0.00025626176 0.00010426835 +-0.011109561 -0.00075416679 -0.00056096174 0.0041062419 20.174678 0 5.6405178 3.6527575 0.30957174 0.30957174 1.8730053e-05 1.7042128e-05 +0.0049750066 -0.0021415883 0.0022892864 -0.0064872658 -14.619444 0 0.62399514 0.71610252 0.30957174 0.30957174 4.4496308e-05 4.7027881e-05 +0.015887817 0.0025212833 -0.0045676084 0.0012234556 19.527695 0 2.9107202 4.8269999 0.30957174 0.30957174 8.5617326e-05 2.2517858e-05 +0.0041147532 -0.001364635 -0.0009113549 0.0089251318 -18.179421 0 0.69395665 3.618475 0.30957174 0.30957174 1.8822399e-05 7.9851211e-05 +0.011310797 -0.00032710892 -0.003019622 -0.004540903 -0.50689128 0 1.6875056 6.0669004 0.30957174 0.30957174 1.5018929e-05 2.9645517e-05 +-0.0034138674 -0.0014003846 0.0041352945 -0.0014730754 14.496404 0 0.1128126 1.6054495 0.30957174 0.30957174 1.9143585e-05 1.9392467e-05 +-0.022957674 0.0003748221 -0.002913449 0.00051122967 20.605711 0 4.9390458 4.9143621 0.30957174 0.30957174 5.9138283e-05 8.8166216e-06 +0.0013311338 4.0522475e-05 0.005337762 0.00064353056 -24.333332 0 2.2156076 2.0641184 0.30957174 0.30957174 2.0947398e-07 2.9134744e-05 +0.021494839 -0.0013308233 0.0044189549 -0.003217776 -24.530539 0 1.4315726 1.3195684 0.30957174 0.30957174 6.685359e-05 2.9956704e-05 +-0.02686004 0.002043184 0.0079210855 0.0063402374 14.79848 0 4.4807239 2.6161396 0.30957174 0.30957174 0.00011722791 0.00010312864 +0.024501028 0.00089481408 -0.0014978706 -0.011199513 -8.2085742 0 2.2662663 0.24027406 0.30957174 0.30957174 7.3192976e-05 0.00012667679 +0.0092387462 0.00072715389 -0.0079020521 0.002632532 -0.94778913 0 2.5671223 4.7675345 0.30957174 0.30957174 1.4186561e-05 6.9825633e-05 +-0.0098246877 8.4356434e-05 0.0014958299 -0.00063030212 -20.613587 0 5.0086335 1.5491991 0.30957174 0.30957174 1.0660991e-05 2.6498152e-06 +-0.0025523367 0.0021574901 -0.0028483028 0.0084708775 -17.000106 0 3.6450376 3.8427236 0.30957174 0.30957174 4.311713e-05 7.935452e-05 +-0.012828359 -0.00028889474 -0.0084537507 -0.0099369586 -22.817336 0 5.2890253 5.9485536 0.30957174 0.30957174 1.8825917e-05 0.0001699932 +0.0014591012 0.00052435568 -0.0046469369 0.0016068404 1.716489 0 3.2194239 4.756274 0.30957174 0.30957174 2.7383255e-06 2.4331111e-05 +0.015714131 -0.0019589263 -0.00723486 -0.0041020758 24.295166 0 1.0962988 5.599005 0.30957174 0.30957174 6.2063912e-05 6.9460854e-05 +-0.029028111 0.00081749601 -0.0012852406 0.0096613752 -12.673425 0 4.8355646 3.6492106 0.30957174 0.30957174 9.8589319e-05 9.4252728e-05 +0.0074286172 0.002941368 -0.0024419753 0.0012856802 3.6454281 0 3.2454371 4.6054125 0.30957174 0.30957174 8.4869073e-05 7.6514621e-06 +-5.3578682e-05 0.0010859801 -0.0068941839 0.00051967822 -21.105306 0 3.5213089 5.0120584 0.30957174 0.30957174 1.0743483e-05 4.8185106e-05 +0.0044573175 0.00041802641 0.005851585 0.0025429214 9.5932411 0 2.6520913 2.3520854 0.30957174 0.30957174 3.772842e-06 4.0934335e-05 +0.0047936907 -0.0007652408 -0.0044542739 0.0059099758 18.107891 0 0.97670643 4.1656564 0.30957174 0.30957174 7.8570087e-06 5.4647684e-05 +-0.0039028195 0.0023818991 0.0065200931 -0.0011980711 -2.841534 0 3.693863 1.7648108 0.30957174 0.30957174 5.3353657e-05 4.4281928e-05 +-0.0052138782 0.0011826479 -0.0019876325 0.0080195498 -22.502997 0 3.966633 3.7607481 0.30957174 0.30957174 1.5725121e-05 6.7776039e-05 +-0.0087477686 -1.3185368e-06 0.0035281027 0.00326645 -17.851223 0 5.0880623 2.6879586 0.30957174 0.30957174 8.4005308e-06 2.3132399e-05 +0.0034459217 0.0011912271 2.7133168e-05 0.0009854791 -18.423739 0 3.2084073 3.4881426 0.30957174 0.30957174 1.4229939e-05 9.6405852e-07 +0.016021441 0.00017650266 0.0016492729 -0.0050924954 -19.214417 0 2.0451166 0.68989139 0.30957174 0.30957174 2.8462065e-05 2.8466089e-05 +-0.0081908829 -0.00012511556 0.0017443296 -0.0033327885 -1.0397514 0 5.2249471 0.85982315 0.30957174 0.30957174 7.5075977e-06 1.4085155e-05 +0.0028714291 0.0023390693 -0.0028731433 0.0046433995 -6.5020952 0 3.3819383 4.0736307 0.30957174 0.30957174 5.0744758e-05 2.9709064e-05 +0.020496455 -0.00012544024 -0.0068028424 0.0052565026 1.468116 0 1.889404 4.4327466 0.30957174 0.30957174 4.6261168e-05 7.4063318e-05 +0.019663919 -0.00067710465 0.0038193258 0.00057454175 17.666863 0 1.6411453 2.0932175 0.30957174 0.30957174 4.6623821e-05 1.5033591e-05 +0.0009704135 0.00011921964 -0.0073880976 -0.0046864082 2.4409788 0 2.7866511 5.6482957 0.30957174 0.30957174 2.3285176e-07 7.6813779e-05 +-0.028145522 -0.00024165442 -0.0072477818 -0.0024373053 2.5248433 0 5.1647425 5.4086472 0.30957174 0.30957174 8.7494046e-05 5.885098e-05 +-0.0085113248 0.0038670299 0.00023254676 0.0013097145 -24.944456 0 3.7529681 3.3387662 0.30957174 0.30957174 0.00014417343 1.7560008e-06 +-0.0072022412 0.0012948197 0.010471233 0.0067947705 8.4422412 0 4.0640833 2.5169962 0.30957174 0.30957174 2.0966782e-05 0.00015633613 +0.0013019153 0.0010555219 0.003523204 -0.0025129698 -2.5195787 0 3.3813089 1.3293579 0.30957174 0.30957174 1.0335068e-05 1.8778109e-05 +0.0029117239 0.00060616435 -0.0056042552 -1.0587839e-05 11.009424 0 3.0306319 5.0885632 0.30957174 0.30957174 4.2778101e-06 3.1663816e-05 +0.0082246031 0.00039601837 -0.0014642402 -0.0053836771 -20.716429 0 2.3584472 0.10668278 0.30957174 0.30957174 8.8543942e-06 3.0911095e-05 +-0.0021089357 -0.0023089825 0.0029699799 0.0048145638 1.6092551 0 0.27436818 2.9595239 0.30957174 0.30957174 4.9053977e-05 3.188528e-05 +-0.0095578027 -0.001782569 -0.0045131282 -0.0076899127 13.971151 0 6.1254878 6.1232109 0.30957174 0.30957174 3.8973825e-05 7.9190966e-05 +0.018430006 -0.0021132369 0.00079722465 0.0062312655 7.8997997 0 1.1379328 3.3876188 0.30957174 0.30957174 7.7967799e-05 3.9155454e-05 +-0.010254556 -0.0029740318 0.0045738407 -0.0033933582 -22.681538 0 0.012451911 1.3106764 0.30957174 0.30957174 9.2114908e-05 3.2512327e-05 +0.016702139 0.0022057195 0.0024639242 -0.0032954458 -21.571876 0 2.8223837 1.0202101 0.30957174 0.30957174 7.4942473e-05 1.6892562e-05 +0.015252302 0.00044692279 0.0062601648 -0.013689817 -21.206452 0 2.2059382 0.80627553 0.30957174 0.30957174 2.7357226e-05 0.00022540484 +-0.010456679 0.00083288514 0.010854169 -0.0010988288 8.8821185 0 4.4590068 1.845015 0.30957174 0.30957174 1.8322404e-05 0.00011997104 +-0.029106988 -0.0015194858 0.0059991882 0.0047785651 -15.418346 0 5.530579 2.6137684 0.30957174 0.30957174 0.00011403698 5.893369e-05 +-0.017521098 0.0045319198 -0.0035545396 -0.0043461613 -5.8082143 0 3.9172677 5.9679687 0.30957174 0.30957174 0.0002207914 3.1474131e-05 +0.0040274497 -0.00048124219 0.010554791 -0.0013725758 -15.025896 0 1.117356 1.8168136 0.30957174 0.30957174 3.8902988e-06 0.00011418049 +-0.0083211505 -4.0008728e-05 -0.0018749552 -0.0036809549 0.92739881 0 5.1304599 6.1830815 0.30957174 0.30957174 7.6157102e-06 1.6983984e-05 +-0.009266416 0.0020094124 0.0048718891 0.0050369513 -23.972833 0 3.9845178 2.7430937 0.30957174 0.30957174 4.620744e-05 4.9094521e-05 +0.0092427362 0.0009105188 -0.0029837337 0.001386056 18.489908 0 2.676463 4.6549059 0.30957174 0.30957174 1.6930127e-05 1.0880857e-05 +0.001853011 0.00021739583 0.010056025 0.0049202271 -8.808651 0 2.7636988 2.3969356 0.30957174 0.30957174 8.0745352e-07 0.00012596087 +-0.0005861777 0.00011642088 0.0044535789 0.003929394 20.896541 0 4.0208265 2.6640207 0.30957174 0.30957174 1.611867e-07 3.5311341e-05 +0.018313581 0.001895374 0.00087204354 -0.0033902877 -22.451385 0 2.7010506 0.62802653 0.30957174 0.30957174 6.9542719e-05 1.2167771e-05 +-0.017367809 0.00070440798 0.0038904499 -0.00061674373 -1.4572297 0 4.732784 1.789128 0.30957174 0.30957174 3.7633207e-05 1.563628e-05 +-0.0018888253 0.00010013663 -0.0083897758 0.0032906554 13.498952 0 4.6367856 4.7156575 0.30957174 0.30957174 4.8298996e-07 8.1702985e-05 +-0.0044808736 -0.0010340866 -0.00097804904 -0.0029056897 -8.4774386 0 6.2134806 0.047151908 0.30957174 0.30957174 1.1945104e-05 9.3391414e-06 +0.0097314168 0.0026011235 0.002825582 0.0058358737 9.2540472 0 3.1261952 3.0617932 0.30957174 0.30957174 7.2028551e-05 4.1831035e-05 +-0.0025310071 0.0010572698 -0.0040989131 -0.0032319477 -7.3525137 0 3.7728782 5.7504281 0.30957174 0.30957174 1.0885868e-05 2.7299073e-05 +0.0066634802 -0.0032518584 0.001960526 0.0026861322 -8.0669032 0 0.59556457 2.8815294 0.30957174 0.30957174 0.00010120217 1.1031959e-05 +0.0089779683 -0.0025835325 -0.011105286 -0.0056138482 18.613118 0 0.73874274 5.5514753 0.30957174 0.30957174 6.9650265e-05 0.00015559318 +0.01009733 -0.0021845249 0.0054087619 0.0066158675 -19.418081 0 0.84386004 2.8265641 0.30957174 0.30957174 5.4663734e-05 7.290897e-05 +-0.012828911 0.00052907861 0.010051038 0.0013506232 -17.695435 0 4.7273218 2.0776055 0.30957174 0.30957174 2.0617138e-05 0.00010365632 +-0.01592016 -0.0016987307 -0.0043812131 -0.003121169 -15.077328 0 5.857889 5.7018564 0.30957174 0.30957174 5.4109944e-05 2.9014428e-05 +0.010367531 -0.00012658773 0.00048683125 0.0089760118 -10.608353 0 1.8343262 3.4612683 0.30957174 0.30957174 1.194543e-05 8.0156255e-05 +0.0018812124 0.0018283489 -0.0066856692 0.0010335194 24.312033 0 3.4034186 4.934537 0.30957174 0.30957174 3.0839864e-05 4.6122067e-05 +-0.035713608 0.0038261506 0.0084334606 0.0073860078 -23.824135 0 4.313474 2.6603566 0.30957174 0.30957174 0.00027337243 0.00012581504 +0.0083634583 -0.00014143264 -0.0040470357 0.0028735532 -22.455303 0 1.7922514 4.4730847 0.30957174 0.30957174 7.8608357e-06 2.4702552e-05 +-0.0096939978 0.0011222833 -0.0053561336 -0.00056104791 20.623313 0 4.2747223 5.1902195 0.30957174 0.30957174 2.178958e-05 2.9234257e-05 +-0.026852622 0.00015732132 0.0073948765 0.0011937416 -0.16308284 0 5.0333708 2.1038717 0.30957174 0.30957174 7.9381619e-05 5.6543469e-05 +-0.0091287137 0.00022960234 0.0017722976 -0.0031498745 1.9687386 0 4.8614606 0.8902856 0.30957174 0.30957174 9.628313e-06 1.3008128e-05 +-0.014119352 -0.0019300219 -0.0027030041 -0.0078900495 -20.895062 0 5.9808637 0.041750218 0.30957174 0.30957174 5.5817e-05 6.9115303e-05 +-0.01575739 0.0016383026 0.0059302966 0.0011998696 -18.773975 0 4.3284499 2.1431582 0.30957174 0.30957174 5.1707006e-05 3.6883148e-05 +0.0050254214 -0.00053039581 -0.0016955236 0.00015093639 2.6462729 0 1.1793617 4.998617 0.30957174 0.30957174 5.33505e-06 2.9208326e-06 +0.015420888 -0.00028318337 0.0029194086 -0.005150413 22.131699 0 1.7793501 0.89346304 0.30957174 0.30957174 2.683589e-05 3.4904686e-05 +0.016713076 0.001800153 -0.0017542133 0.0070929811 15.080008 0 2.7209876 3.7602436 0.30957174 0.30957174 6.0183067e-05 5.3005928e-05 +-0.005803232 -0.00099206879 -0.0071653565 -0.0025378289 -8.8857127 0 6.0866455 5.4245365 0.30957174 0.30957174 1.2662468e-05 5.8149363e-05 +0.0057237815 -0.0014717238 -0.00044071578 0.0017913706 17.549319 0 0.77781398 3.7590138 0.30957174 0.30957174 2.3327124e-05 3.3788747e-06 +0.00064482392 -0.0016567268 -0.0034741173 0.0083041781 -17.038841 0 0.41700122 3.915023 0.30957174 0.30957174 2.504855e-05 8.0569657e-05 +0.006754238 -0.0016413079 0.0067927632 -0.0017100325 -8.4879665 0 0.7986081 1.700393 0.30957174 0.30957174 2.954767e-05 4.9418335e-05 +0.0068480309 0.002003633 -0.0040694099 0.0047844797 -11.869002 0 3.1569499 4.224712 0.30957174 0.30957174 4.1718053e-05 3.9401242e-05 +-0.012454772 0.0017454962 0.0004579688 0.0010962501 4.3821046 0 4.1803678 3.1172751 0.30957174 0.30957174 4.4782811e-05 1.4034921e-06 +-0.022007144 -0.0020917023 0.003591956 -0.0028126578 -2.8160697 0 5.8002931 1.2847179 0.30957174 0.30957174 9.302209e-05 2.08544e-05 +-0.011004308 0.0018885232 0.0024759875 0.0087214221 -21.363802 0 4.0849675 3.2371336 0.30957174 0.30957174 4.5782194e-05 8.1628655e-05 +0.01205943 0.0035825733 -0.00039879259 0.0038473208 -9.0525965 0 3.1619315 3.6200146 0.30957174 0.30957174 0.00013288216 1.4842523e-05 +-0.0006037204 8.4311494e-05 -0.00089224238 -0.0076024907 -24.618273 0 4.1820811 0.25652924 0.30957174 0.30957174 1.0476468e-07 5.8133104e-05 +-0.017208456 0.00025463787 -0.0020662287 -0.0085191171 12.336419 0 4.9527031 0.13448834 0.30957174 0.30957174 3.3099023e-05 7.6292626e-05 +-0.046296157 -0.0011160796 0.004484185 -0.0033187855 4.4056894 0 5.3028612 1.3118334 0.30957174 0.30957174 0.00024663573 3.1197107e-05 +0.010263922 0.00032991328 -0.00034828009 0.0054134007 -22.958289 0 2.2299374 3.5806633 0.30957174 0.30957174 1.2556288e-05 2.919024e-05 +-0.011063364 0.00081998174 -0.0054030322 -0.0025024092 10.572918 0 4.4928308 5.517336 0.30957174 0.30957174 1.9561359e-05 3.5642148e-05 +-0.011248791 -0.0030229635 0.0020514899 0.0036568983 -21.400515 0 6.2696794 3.0011783 0.30957174 0.30957174 9.7134959e-05 1.7507692e-05 +-0.0083544498 -0.00072460522 -0.0022676445 0.0027832524 -12.367066 0 5.7553534 4.2035399 0.30957174 0.30957174 1.2444989e-05 1.2867987e-05 +-0.01033679 -0.0019827191 0.0017255639 -0.004845136 8.8220387 0 6.1376708 0.71901171 0.30957174 0.30957174 4.7540143e-05 2.6287367e-05 +-0.017287188 0.0024950869 -0.0031469823 0.0046577477 17.827751 0 4.1661366 4.1138572 0.30957174 0.30957174 8.951656e-05 3.1503422e-05 +0.0063572339 0.00020075661 -0.0018845503 -0.0077420501 -6.0031951 0 2.2252008 0.13365402 0.30957174 0.30957174 4.803711e-06 6.3035159e-05 +0.00016520961 -0.00016519788 0.0042442033 -0.0029305383 -24.054206 0 0.48364715 1.3445789 0.30957174 0.30957174 2.5159425e-07 2.6678715e-05 +0.0032011746 0.0010940523 0.0047507769 0.00086811748 -16.346477 0 3.2050971 2.1244041 0.30957174 0.30957174 1.2028413e-05 2.35014e-05 +-0.0040441491 0.00031261351 9.3128358e-05 0.005351643 3.647434 0 4.4731791 3.498351 0.30957174 0.30957174 2.6856523e-06 2.8417246e-05 +0.0017542436 0.00029538813 -0.002380338 0.0013598323 16.406408 0 2.9381545 4.571147 0.30957174 0.30957174 1.1326554e-06 7.5463893e-06 +-0.0063623629 -0.0013872394 -0.00027939614 -0.00063110786 -0.04334764 0 6.1910614 6.2376992 0.30957174 0.30957174 2.1974123e-05 4.737751e-07 +-0.014498168 0.0010233016 0.0061316873 -0.0063750455 -14.033453 0 4.515284 1.1442996 0.30957174 0.30957174 3.2613628e-05 7.8216663e-05 +-0.0055032796 -0.00096450523 0.0094534358 0.0053524008 23.400583 0 6.0979044 2.4568079 0.30957174 0.30957174 1.1798899e-05 0.0001185125 +0.024946727 8.0730908e-05 0.0095025147 -0.0011718623 22.577349 0 1.9745672 1.8233772 0.30957174 0.30957174 6.8377896e-05 9.2396031e-05 +-0.0087465465 -1.5294253e-05 -0.0046742929 -0.002783183 18.482378 0 5.1026166 5.6201748 0.30957174 0.30957174 8.4002987e-06 2.9710596e-05 +-0.011667827 0.00018035292 -0.0014194355 0.0021924083 -24.504992 0 4.9468027 4.0941707 0.30957174 0.30957174 1.5241144e-05 6.7990093e-06 +0.021252338 -0.00019862287 -0.0025600589 -0.0024045952 -19.728667 0 1.8601658 5.8367332 0.30957174 0.30957174 4.9941458e-05 1.2342653e-05 +-0.0093259138 0.0018126013 0.011160069 0.0081509858 22.557053 0 4.0300335 2.572054 0.30957174 0.30957174 3.9476671e-05 0.00019146377 +-0.0064703204 0.0022918046 -0.00017757641 -0.0050547524 -18.396142 0 3.8164321 0.3388981 0.30957174 0.30957174 5.244162e-05 2.5375714e-05 +0.036882334 0.0018510552 -0.002136524 0.00040315373 -5.9662818 0 2.3739074 4.9016598 0.30957174 0.30957174 0.00018054278 4.7631642e-06 +-0.000929949 0.0037604455 -0.00018346378 0.0035494042 -15.644103 0 3.5430338 3.5679558 0.30957174 0.30957174 0.00012891018 1.2530336e-05 +0.0017897709 0.00033313943 0.010306247 0.0043174853 -23.400215 0 2.9830294 2.3389205 0.30957174 0.30957174 1.3626222e-06 0.00012557454 +-0.016694051 0.0012432839 -0.0013125598 -0.0024907384 -1.3202587 0 4.4905953 6.1691345 0.30957174 0.30957174 4.4674761e-05 7.8904718e-06 +0.0076590306 0.00084688621 -0.00033244247 -0.0023630708 14.80508 0 2.7341097 0.23341073 0.30957174 0.30957174 1.2972994e-05 5.6503702e-06 +0.0086119818 -0.00022053165 -0.0017612922 0.010122982 0.080706975 0 1.715926 3.6895342 0.30957174 0.30957174 8.5847733e-06 0.0001047736 +-0.015238587 -1.078569e-05 0.0044162149 0.0026284854 -21.743396 0 5.0931367 2.4784103 0.30957174 0.30957174 2.5492873e-05 2.6515009e-05 +0.0068330639 0.00067946982 -0.0039440834 -0.0010384082 -16.480264 0 2.6811195 5.3421376 0.30957174 0.30957174 9.3311816e-06 1.6752174e-05 +-0.0096407755 0.0025119854 -0.012695401 0.00013726557 9.5404072 0 3.9146376 5.0759649 0.30957174 0.30957174 6.7683985e-05 0.00016250575 +-0.036147363 0.0011197376 -0.0011343276 0.002233997 -18.894127 0 4.8116589 3.9890121 0.30957174 0.30957174 0.00015485956 6.2475761e-06 +-0.0024557189 5.0741463e-05 0.0071262882 -0.0068193939 21.336684 0 4.9006428 1.185756 0.30957174 0.30957174 6.8547013e-07 9.7326069e-05 +-0.016101091 0.00075801944 0.00088847143 -0.001065354 -7.5934224 0 4.6815552 1.0734094 0.30957174 0.30957174 3.3693339e-05 1.9216182e-06 +0.0084403551 0.0024615746 0.0012624293 0.011942485 13.04491 0 3.1558883 3.4097228 0.30957174 0.30957174 6.3017365e-05 0.00014307643 +0.0072905714 -0.0016271251 0.00048597473 0.00035264055 18.843642 0 0.83142424 2.568967 0.30957174 0.30957174 2.9952317e-05 3.6144649e-07 +-0.034059196 -0.0005623167 0.0036284195 -0.0032659028 -24.557335 0 5.2359661 1.2162672 0.30957174 0.30957174 0.00013022487 2.3852626e-05 +-0.024736767 0.001169105 0.0061351083 -0.0050207139 13.432062 0 4.6801475 1.2632376 0.30957174 0.30957174 7.9624139e-05 6.2950126e-05 +-0.020157501 0.0019154821 -0.0019959614 -0.0018874696 15.881831 0 4.3731934 5.8401055 0.30957174 0.30957174 7.8028076e-05 7.5500725e-06 +-0.0059296495 -0.00044044061 0.0018892424 -0.0045768811 -24.211326 0 5.6815533 0.76864623 0.30957174 0.30957174 5.6269498e-06 2.4376792e-05 +0.020048551 -0.0018980578 0.013320714 -0.0046406712 3.8752176 0 1.2334404 1.6123799 0.30957174 0.30957174 7.6941902e-05 0.00020024959 +0.0013341341 -0.002268578 -0.0026385852 -0.0052158388 -10.849156 0 0.43876985 6.1858675 0.30957174 0.30957174 4.707631e-05 3.4003884e-05 +0.023611897 0.0014020247 -0.0037865703 0.0005006172 2.4009631 0 2.440923 4.9562938 0.30957174 0.30957174 7.9109112e-05 1.4703587e-05 +-0.014518577 0.00072383532 0.0041671872 0.0012158258 -2.7975386 0 4.6603852 2.2268029 0.30957174 0.30957174 2.7912537e-05 1.8973288e-05 +0.036477903 0.0019199048 -0.004231345 -0.0018830973 -18.97278 0 2.3921651 5.5023991 0.30957174 0.30957174 0.00017965085 2.1567615e-05 +-0.013371849 0.0018316439 -0.0019797787 0.0012395815 21.698757 0 4.1915009 4.5309293 0.30957174 0.30957174 5.0190048e-05 5.4756126e-06 +0.0071122637 -0.00120309 0.0063986462 0.0028046292 -20.010583 0 0.94994732 2.3552149 0.30957174 0.30957174 1.8738137e-05 4.9078771e-05 +0.00070761696 0.00077383109 0.0050552371 -0.0020504683 -6.1235014 0 3.4158443 1.5625807 0.30957174 0.30957174 5.5097952e-06 2.9934169e-05 +-0.0085880125 0.00088146908 0.0042565295 0.0021758784 4.0212164 0 4.33488 2.4143704 0.30957174 0.30957174 1.5174362e-05 2.2961903e-05 +0.01065017 -0.001228234 -0.0024863877 0.0067308857 19.567796 0 1.1350555 3.8723919 0.30957174 0.30957174 2.6193609e-05 5.1171012e-05 +-0.0092613591 0.00129738 -0.0045532702 0.013069822 17.919371 0 4.1805809 3.8536545 0.30957174 0.30957174 2.4748732e-05 0.0001903403 +-0.0010426416 -0.00052424815 0.0053348849 -0.0072124488 17.42298 0 0.15934531 1.0150482 0.30957174 0.30957174 2.6229245e-06 8.02918e-05 +0.013194642 0.003021991 -0.0081194348 -0.0084269381 20.58114 0 3.0689345 5.8866125 0.30957174 0.30957174 0.00010230276 0.00013690171 +-0.013393602 0.0038521778 -0.0024285355 -0.00074335523 -7.5248944 0 3.8805094 5.381461 0.30957174 0.30957174 0.00015486928 6.4939712e-06 +0.022940433 0.0019172436 0.003177153 -0.0026172473 15.3116 0 2.5958 1.2600092 0.30957174 0.30957174 9.1256078e-05 1.6971183e-05 +-0.010966187 -0.0012038565 -0.002088726 -0.0048552387 -13.009764 0 5.8720963 6.2482629 0.30957174 0.30957174 2.6403431e-05 2.7781073e-05 +0.022275252 0.0014240559 -0.0061590623 0.010971826 9.9649528 0 2.4724461 4.030883 0.30957174 0.30957174 7.294313e-05 0.00015765086 +0.017672727 -0.0036149889 0.0063484624 -0.0014136372 9.3211983 0 0.86685233 1.7277133 0.30957174 0.30957174 0.00015332878 4.2613728e-05 +-0.019423649 -0.0013319146 -0.00012111239 -0.0053413944 -11.175346 0 5.6450342 0.35144511 0.30957174 0.30957174 5.7576465e-05 2.8314588e-05 +-0.012381933 -0.00063378381 0.002136763 0.010194786 -21.324808 0 5.5229941 3.3076538 0.30957174 0.30957174 2.0489231e-05 0.00010769625 +-0.00024468418 -0.001403428 -0.0040286965 0.0015514708 8.3752684 0 0.35516326 4.7218036 0.30957174 0.30957174 1.7948494e-05 1.87503e-05 +-0.0068431231 0.00010889823 -0.0093725237 -0.010429326 8.6305019 0 4.9427297 5.9213677 0.30957174 0.30957174 5.2487002e-06 0.00019645161 +-0.0046787373 0.0023222746 8.4705964e-05 -0.0010624035 7.2441161 0 3.733559 0.45450827 0.30957174 0.30957174 5.152958e-05 1.1268083e-06 +0.011384289 0.0025637408 0.0053414273 -0.0030830999 19.831525 0 3.0623238 1.4251145 0.30957174 0.30957174 7.4101131e-05 3.8192068e-05 +0.0038457653 0.0023132148 0.0047849111 0.0013333332 -1.4034043 0 3.3353733 2.2147644 0.30957174 0.30957174 5.0367526e-05 2.4845415e-05 +-0.0040818745 -0.0019592149 0.0019050864 0.0023085614 -0.92638659 0 0.14945553 2.8219694 0.30957174 0.30957174 3.6795624e-05 8.9453025e-06 +-0.0052465665 0.0010306105 -0.0035777018 0.0048258562 -1.4162307 0 4.0255021 4.1577308 0.30957174 0.30957174 1.2697369e-05 3.600487e-05 +-0.016286977 -0.00063680974 0.001003173 -0.0067030453 14.307833 0 5.4288505 0.52405004 0.30957174 0.30957174 3.2814159e-05 4.5582072e-05 +0.012864515 -0.00025413965 -0.0035216 -0.0034820403 -3.9614501 0 1.7670457 5.8623801 0.30957174 0.30957174 1.8755973e-05 2.4529329e-05 +-0.01224789 -0.0013834495 -0.0036022877 -0.0029613458 -15.64431 0 5.8863508 5.770766 0.30957174 0.30957174 3.3902469e-05 2.1780917e-05 +0.0028230857 -0.0034279499 0.001420614 0.0055273881 3.1054242 0 0.46446193 3.2623599 0.30957174 0.30957174 0.00010791773 3.2339575e-05 +-0.011172317 -0.0011057631 -0.0030061962 0.0034968522 -14.06491 0 5.8203803 4.2299994 0.30957174 0.30957174 2.4840582e-05 2.1239986e-05 +0.020349504 0.001746135 0.0018689019 0.0068426358 0.80735863 0 2.6085483 3.247199 0.30957174 0.30957174 7.3233284e-05 4.9964338e-05 +0.0040320056 0.0013125199 0.00049828247 -0.010544132 -4.9397387 0 3.1906392 0.42190635 0.30957174 0.30957174 1.7477453e-05 0.00011053006 +0.00029281152 0.0012803998 -0.0057616225 0.00015561112 -24.992567 0 3.4907936 5.0599058 0.30957174 0.30957174 1.4943539e-05 3.3490922e-05 +-0.024759085 -0.0011578942 0.0038225558 0.0051677639 15.83953 0 5.4894177 2.8751352 0.30957174 0.30957174 7.9507764e-05 4.1220891e-05 +0.0026213031 -0.00082140491 0.0041347305 -0.0057050972 -3.4704809 0 0.7112647 1.0053027 0.30957174 0.30957174 6.9004543e-06 4.9520313e-05 +0.0068238611 -0.00034475931 0.0029960451 0.0023324664 -24.628506 0 1.5137684 2.6026676 0.30957174 0.30957174 6.1945058e-06 1.4445868e-05 +0.021341319 0.00049869639 0.00096780924 -0.0014361933 -17.011648 0 2.1548309 0.97104217 0.30957174 0.30957174 5.2263627e-05 2.9902631e-06 +0.01707985 0.00077025989 0.002083915 0.0022620079 -24.775384 0 2.3348878 2.7674041 0.30957174 0.30957174 3.7428882e-05 9.4534096e-06 +-0.0032639948 0.0009041162 0.0044487085 -0.0052339241 -19.713856 0 3.8932154 1.0827891 0.30957174 0.30957174 8.6157692e-06 4.7124797e-05 +-0.01643993 0.00088061124 -0.0008670136 -2.9275059e-05 -21.264078 0 4.6327302 5.1201691 0.30957174 0.30957174 3.6733674e-05 7.5869048e-07 +0.017089655 0.0024017346 0.0045191778 -0.00095361207 9.9221083 0 2.8527686 1.738767 0.30957174 0.30957174 8.4606948e-05 2.1491475e-05 +-0.0078338161 -0.00035546654 -0.00093505782 0.0049465135 3.9593897 0 5.4786478 3.7042095 0.30957174 0.30957174 7.8878972e-06 2.5151612e-05 +-0.032671645 -0.0005708119 0.0017581321 -0.0049914753 16.883819 0 5.2445171 0.71550969 0.30957174 0.30957174 0.00012014803 2.7829594e-05 +0.0057935707 0.00091738534 0.007905678 -0.0033351046 6.101287 0 2.9096943 1.5487862 0.30957174 0.30957174 1.1351129e-05 7.4042214e-05 +-0.0017668348 0.00018263501 -0.0027341681 -0.0064778403 7.9931724 0 4.3313485 6.2551738 0.30957174 0.30957174 6.4653964e-07 4.9159728e-05 +0.0075970333 -0.0012284858 -0.0086880521 -0.0021382214 10.969511 0 0.97070235 5.3261267 0.30957174 0.30957174 2.0083434e-05 8.0632586e-05 +0.01161521 -0.0034872414 0.012247736 -0.0047697307 -12.196327 0 0.72484175 1.5764658 0.30957174 0.30957174 0.00012558814 0.00017379624 +-0.010969714 -0.0019230098 -0.0062562831 -0.0043274089 10.353042 0 6.0980113 5.6880234 0.30957174 0.30957174 4.6896146e-05 5.8035195e-05 +0.027333291 -0.0013670382 -0.0068586791 0.0034165994 9.4929626 0 1.517601 4.6277611 0.30957174 0.30957174 9.9038905e-05 5.9003714e-05 +0.032909942 -0.00014153298 0.0033595177 -0.0035457833 16.952728 0 1.9059407 1.136785 0.30957174 0.30957174 0.00011907801 2.3849282e-05 +-0.0015808437 0.0038903992 -0.0043252945 -0.0018202428 2.6362502 0 3.5604707 5.4821339 0.30957174 0.30957174 0.00013814663 2.214717e-05 +0.010370751 0.00099213937 -0.0024354171 -0.0022203493 2.435111 0 2.6619223 5.8218859 0.30957174 0.30957174 2.0773516e-05 1.0869695e-05 +-0.029249316 9.1433407e-05 -0.007148427 -0.0059371245 -5.0368721 0 5.058221 5.7757951 0.30957174 0.30957174 9.399284e-05 8.6480989e-05 +0.0043607386 -0.0020309532 0.0048716449 -0.0081117915 21.973347 0 0.6057816 0.9187241 0.30957174 0.30957174 3.9661617e-05 8.9195491e-05 +-0.022434375 0.00060016139 0.0095932737 0.0073975246 -24.62905 0 4.8476555 2.5980535 0.30957174 0.30957174 5.8532032e-05 0.000147062 +0.0077166947 -0.00071216852 -0.0058661315 -0.013031246 9.4042922 0 1.2460276 6.2314524 0.30957174 0.30957174 1.1157062e-05 0.0002031323 +0.0087616801 -0.0010597927 0.005846442 0.0026138809 -10.480703 0 1.1112793 2.3625103 0.30957174 0.30957174 1.8658548e-05 4.1236647e-05 +0.0096928197 -0.0028807355 0.0017087298 0.00086426688 24.957752 0 0.72812329 2.4101074 0.30957174 0.30957174 8.5909043e-05 3.6844761e-06 +-0.01428211 -0.001814169 0.0036709271 -0.0021011105 -12.914259 0 5.9447919 1.4287378 0.30957174 0.30957174 5.2373028e-05 1.7964526e-05 +0.00020475529 0.00047447037 0.0092583953 0.0085980715 13.81195 0 3.4685546 2.6894851 0.30957174 0.30957174 2.0553247e-06 0.00015974571 +0.031319116 -0.00089920954 -0.0078316555 0.0018718804 0.025976705 0 1.6892855 4.8539052 0.30957174 0.30957174 0.00011504447 6.531042e-05 +-0.010746638 0.0018329078 -0.0013559368 -0.0043797389 1.0041605 0 4.0877845 0.071764553 0.30957174 0.30957174 4.3281585e-05 2.0880561e-05 +0.0022530813 0.0003200075 0.0075283651 0.0092231126 -6.6570102 0 2.8578909 2.8273414 0.30957174 0.30957174 1.4901132e-06 0.00014151627 +-0.029899302 0.00088306143 0.0010260946 -0.0052048327 12.793803 0 4.8238714 0.57049336 0.30957174 0.30957174 0.00010524062 2.7932688e-05 +0.015033962 0.0021730399 0.0028817612 -0.0023175901 3.008617 0 2.8663513 1.2717449 0.30957174 0.30957174 6.782721e-05 1.3700037e-05 +-0.014268185 0.0014212148 0.0062023695 0.0010555834 6.1045144 0 4.3498227 2.112334 0.30957174 0.30957174 4.0748111e-05 3.9888228e-05 +-0.037640841 -0.0023250854 -0.0070405535 0.0026341992 3.2043286 0 5.5992221 4.7313234 0.30957174 0.30957174 0.00020478115 5.685637e-05 +0.040639615 0.0035191906 -0.0047804271 8.3476588e-05 15.873022 0 2.6129876 5.06937 0.30957174 0.30957174 0.00029412223 2.3045684e-05 +-0.0025092893 0.00098625293 -0.0052903476 -0.0017801624 -12.306402 0 3.7882541 5.4088343 0.30957174 0.30957174 9.5518581e-06 3.1359282e-05 +-0.022711854 0.00020517652 0.004527662 0.0026129869 -3.3578527 0 5.0045811 2.4650121 0.30957174 0.30957174 5.7009561e-05 2.7439325e-05 +0.0088922734 -0.00078239387 -0.0099722594 0.0064201986 -13.720662 0 1.2694442 4.5183698 0.30957174 0.30957174 1.425656e-05 0.00014114228 +-0.020025398 -0.0013293701 -0.0018774155 -0.0065131417 -14.118982 0 5.6305712 0.091489365 0.30957174 0.30957174 6.0120711e-05 4.5631425e-05 +0.010583794 0.00026753329 0.004393252 0.00030728302 5.3976097 0 2.1714152 2.0143644 0.30957174 0.30957174 1.2948851e-05 1.9551658e-05 +-0.02080904 -0.00085776293 0.0031108496 -0.00030368126 12.30602 0 5.4458936 1.8485668 0.30957174 0.30957174 5.4237503e-05 9.8477497e-06 +-0.039667645 -0.00080496085 0.00020959061 0.00070191523 22.904526 0 5.2694791 3.2234894 0.30957174 0.30957174 0.00017863905 5.3298752e-07 +0.013266365 0.0013340027 -0.0061134111 0.0091920831 24.435387 0 2.6866791 4.1065413 0.30957174 0.30957174 3.5531072e-05 0.00012148964 +-0.028606707 -0.0015264381 -0.0015251114 0.0054984049 6.7864216 0 5.5391319 3.7885627 0.30957174 0.30957174 0.00011106028 3.2332927e-05 +0.013653339 -0.00044977668 -0.0034795485 -0.00054587926 -10.411999 0 1.6535603 5.2410648 0.30957174 0.30957174 2.2306751e-05 1.2501528e-05 +-0.0062689964 -0.0023146868 0.0066448973 0.013682727 23.253016 0 0.085308406 3.0605998 0.30957174 0.30957174 5.3120263e-05 0.00023021779 +-0.031550715 0.00020679736 -0.010383531 -0.0050099352 12.519858 0 5.0270532 5.5330604 0.30957174 0.30957174 0.00010966681 0.00013359312 +0.014410572 -0.00058523453 0.0015665249 -0.0094960259 24.419514 0 1.5907649 0.53910301 0.30957174 0.30957174 2.591675e-05 9.1919374e-05 +0.018201416 0.0001674161 0.011668971 -0.0057786224 5.8637539 0 2.0286891 1.4885069 0.30957174 0.30957174 3.6623509e-05 0.00017039735 +-0.002882336 0.00011771851 0.0051181967 0.00098795107 5.4416126 0 4.7305168 2.1342735 0.30957174 0.30957174 1.0382465e-06 2.7377636e-05 +-0.011853312 0.0014265491 -0.0047921558 0.0066569488 -24.608321 0 4.2553781 4.1436866 0.30957174 0.30957174 3.3961746e-05 6.7108603e-05 +-0.017087612 0.00037460349 -0.0067904162 -0.0035698894 -0.87846195 0 4.8895817 5.5673679 0.30957174 0.30957174 3.3331699e-05 5.9126691e-05 +0.00057212127 0.00061258847 -0.00021137816 -0.0044098556 20.114489 0 3.4137247 0.32601397 0.30957174 0.30957174 3.4543594e-06 1.9334627e-05 +-0.00064267405 -0.00098580555 -0.0012108051 -0.0029725597 -21.033903 0 0.3028554 6.2678338 0.30957174 0.30957174 8.8979481e-06 1.0242663e-05 +-0.019277209 0.00029000399 0.0081312706 -0.0030756046 -11.306209 0 4.9504972 1.5861632 0.30957174 0.30957174 4.1560434e-05 7.6039395e-05 +0.0055905976 -0.00090562252 0.0088940642 -0.0043465409 -15.708378 0 0.96988631 1.4937234 0.30957174 0.30957174 1.0902131e-05 9.8488875e-05 +-0.028930867 0.0012336859 -0.0019960982 -0.0083613716 -18.011359 0 4.7161818 0.1381175 0.30957174 0.30957174 0.0001057471 7.3364119e-05 +0.0075377579 0.0016980206 -0.0028579282 -0.00075268588 -3.162084 0 3.062444 5.3422167 0.30957174 0.30957174 3.2502117e-05 8.7962907e-06 +0.027453357 -0.00021067013 -0.00061901789 -0.0050080481 12.92365 0 1.8753071 0.25032711 0.30957174 0.30957174 8.3141767e-05 2.5264054e-05 +0.0166109 0.00091059169 -0.0018277385 -0.0048747942 5.4966059 0 2.4082371 0.012908235 0.30957174 0.30957174 3.7843177e-05 2.6939329e-05 +0.012350508 -0.0019670097 -0.0064272789 -0.00095101865 15.300214 0 0.97778883 5.2324183 0.30957174 0.30957174 5.1990175e-05 4.2543787e-05 +0.003949641 0.00062407422 -0.00070087776 -0.0072306414 -24.372844 0 2.9086947 0.27688778 0.30957174 0.30957174 5.2603007e-06 5.2354662e-05 +-0.019600894 0.00081894958 -0.0039473501 -0.010595147 -11.740161 0 4.7230172 0.015004416 0.30957174 0.30957174 4.828524e-05 0.00012705802 +-0.013857994 -0.0010184602 0.0021602189 -0.0031678109 -20.47484 0 5.6766314 0.97657873 0.30957174 0.30957174 3.0530816e-05 1.4658471e-05 +0.0033639443 0.0012635625 -0.0013842638 0.00079636269 -1.9901519 0 3.2315558 4.5681339 0.30957174 0.30957174 1.5786191e-05 2.5608722e-06 +0.0058732236 0.0034044476 0.0013290996 0.0039445106 9.9127035 0 3.3287265 3.188427 0.30957174 0.30957174 0.00010936681 1.721426e-05 +0.0061424017 -0.0029212235 0.0030065153 0.0032152725 -4.7571514 0 0.60115303 2.7599835 0.30957174 0.30957174 8.187708e-05 1.9367205e-05 +0.013233236 0.0024614607 0.0036873733 -0.0028203516 -4.9291047 0 2.9827253 1.2960616 0.30957174 0.30957174 7.4415776e-05 2.1597624e-05 +-0.012795993 0.00095983443 0.00093022892 0.0089821231 18.776694 0 4.4872599 3.4118611 0.30957174 0.30957174 2.6366909e-05 8.089856e-05 +-0.0019787419 -0.0016779861 -0.0034187987 -0.00073249975 -2.5556189 0 0.24556321 5.2960976 0.30957174 0.30957174 2.6078523e-05 1.2315682e-05 +-0.016165682 0.00055600678 0.0018749088 0.00083097348 10.6506 0 4.7830663 2.3592882 0.30957174 0.30957174 3.1504049e-05 4.2288724e-06 +0.0075164548 0.00090078555 0.0074973529 -0.0046162942 22.250222 0 2.7742994 1.3968141 0.30957174 0.30957174 1.3593562e-05 7.7806376e-05 +0.0087299709 -0.0004082759 -0.0010584378 0.0046302088 5.6874823 0 1.5423626 3.7423957 0.30957174 0.30957174 9.8848022e-06 2.2394905e-05 +-0.01548348 0.00078740181 0.00037555342 -0.0032605751 12.908914 0 4.6528705 0.48990159 0.30957174 0.30957174 3.1965561e-05 1.0687576e-05 +-0.024816892 -0.0017791258 -0.0068766423 -0.0039533501 -21.852138 0 5.6652072 5.6049441 0.30957174 0.30957174 9.6443055e-05 6.3176297e-05 +0.012418012 -3.571951e-05 0.00060559326 0.001167775 -7.9491265 0 1.9189001 3.0341606 0.30957174 0.30957174 1.6940005e-05 1.7224045e-06 +-0.017200331 -0.00016806614 0.0041760957 0.0027235829 15.604426 0 5.1754639 2.5192969 0.30957174 0.30957174 3.2734982e-05 2.4939864e-05 +0.011348094 0.002013193 0.00090126864 -0.0072604803 -16.494764 0 2.961766 0.49879841 0.30957174 0.30957174 5.1056808e-05 5.3107238e-05 +-0.019411152 -0.00018547292 0.0026861094 0.015248126 -16.295744 0 5.1735102 3.3401295 0.30957174 0.30957174 4.1676548e-05 0.00023789933 +0.0041947282 0.00010844846 0.0034050908 0.0064364061 -20.684918 0 2.1763912 3.0259237 0.30957174 0.30957174 2.038744e-06 5.2781508e-05 +0.010310707 -0.0018315471 0.003605674 -0.0070100199 7.7505181 0 0.92784304 0.85267986 0.30957174 0.30957174 4.2228459e-05 6.1849902e-05 +-0.008271444 -0.0012320035 0.0018704906 0.0011345531 14.829614 0 6.022342 2.4867279 0.30957174 0.30957174 2.1337098e-05 4.8040587e-06 +0.018962772 0.0001025686 0.0048635293 0.00025692494 10.156093 0 1.9943289 1.9974484 0.30957174 0.30957174 3.9570182e-05 2.3912215e-05 +0.0044249253 0.00044473047 0.0041785379 0.0097085719 7.0002367 0 2.6864339 3.1065037 0.30957174 0.30957174 3.9511294e-06 0.00011109673 +-0.0029773285 0.00078327776 0.0059293045 0.011660295 21.23955 0 3.9112022 3.0421774 0.30957174 0.30957174 6.5619381e-06 0.00017030634 +0.0019552148 0.00079923503 0.0018181802 0.0034706358 -13.365235 0 3.2535295 3.029983 0.30957174 0.30957174 6.2385196e-06 1.5280643e-05 +-0.011431079 0.0024830827 -0.0012936031 0.0023953007 -13.796634 0 3.9838254 4.0144737 0.30957174 0.30957174 7.0510196e-05 7.3781232e-06 +0.013069559 -0.0013271819 -0.0011822292 0.0083703297 -24.865914 0 1.1986209 3.6573339 0.30957174 0.30957174 3.4796742e-05 7.0904962e-05 +-0.0038879155 0.0011116245 0.0038442705 -0.00092502879 -14.054512 0 3.8824834 1.7108004 0.30957174 0.30957174 1.2915915e-05 1.5747645e-05 +0.024214413 0.00033496056 -0.0050832368 0.0072948312 5.5958341 0 2.0704469 4.1282998 0.30957174 0.30957174 6.5388459e-05 7.8834209e-05 +-0.0099221346 7.1879093e-05 0.0085493297 -0.0044947695 -14.430152 0 5.0207936 1.4644019 0.30957174 0.30957174 1.0854473e-05 9.3726455e-05 +0.01996493 -0.00076243225 0.0041820578 0.0016055562 16.044422 0 1.6103169 2.3089521 0.30957174 0.30957174 4.9052245e-05 2.0189146e-05 +-0.01094179 0.0014135107 -0.00061238502 -0.0040297147 3.5383372 0 4.2202526 0.22227621 0.30957174 0.30957174 3.1343455e-05 1.6485369e-05 +-0.024186213 -0.00059529565 0.0075024637 -0.0041551169 -10.766487 0 5.3072509 1.4427484 0.30957174 0.30957174 6.7444719e-05 7.3871195e-05 +0.0018086349 -0.00081871293 -0.0012203512 -0.0081985167 7.1609271 0 0.61221769 0.22534809 0.30957174 0.30957174 6.4650301e-06 6.8173576e-05 +-0.0036895102 5.5778809e-05 0.0045068112 0.0028790177 4.5533779 0 4.9498326 2.5098916 0.30957174 0.30957174 1.5226795e-06 2.8698642e-05 +-0.0044866152 0.0018792743 0.0037758879 0.0019217728 -5.3697713 0 3.7722117 2.4126117 0.30957174 0.30957174 3.438111e-05 1.80369e-05 +0.010156477 0.00084436752 -0.0016455621 -0.0054993521 -17.431517 0 2.5932635 0.081314268 0.30957174 0.30957174 1.7818528e-05 3.2728282e-05 +-0.022306608 0.0014774634 -0.0017626353 -0.0042234555 7.1340967 0 4.5438076 6.2592232 0.30957174 0.30957174 7.4508199e-05 2.0825554e-05 +0.011119846 0.00061312361 -0.00087487631 -0.002502207 -5.2925545 0 2.4105592 0.035407072 0.30957174 0.30957174 1.6998434e-05 6.9820617e-06 +0.0096585058 -0.001749794 0.0081711697 0.0047632129 -13.233809 0 0.9190808 2.4693442 0.30957174 0.30957174 3.8131637e-05 8.9817036e-05 +0.017596775 0.0011879827 -0.0021872979 -0.0044098028 -3.0563641 0 2.4964629 6.1937968 0.30957174 0.30957174 4.6848153e-05 2.4112392e-05 +-0.010942504 0.00038643596 -0.0018955161 0.0038250299 10.964787 0 4.775446 3.9792169 0.30957174 0.30957174 1.450485e-05 1.8134821e-05 +0.006270523 0.00066347824 0.0015637366 0.0028675417 -7.0964933 0 2.7120916 3.0132275 0.30957174 0.30957174 8.3263503e-06 1.0621512e-05 +0.008374886 -0.0012983075 -0.00057762448 -0.009217373 -13.146115 0 0.99046147 0.31120635 0.30957174 0.30957174 2.3054403e-05 8.4609361e-05 +-0.016032381 0.0033164869 -0.00012979211 -0.0091611097 24.571116 0 4.0037807 0.36001802 0.30957174 0.30957174 0.00012841159 8.32643e-05 +-0.0033301124 -0.0016546868 -0.0030606779 -0.0023366991 -7.9873056 0 0.15686319 5.7348364 0.30957174 0.30957174 2.6158755e-05 1.4860126e-05 +0.010968121 -0.0028201254 -0.0019509407 0.0029579395 -23.142782 0 0.77781988 4.1026973 0.30957174 0.30957174 8.565399e-05 1.2515857e-05 +-0.030433694 -3.608389e-05 -0.002642 -0.0034915567 20.523807 0 5.0974894 6.0058105 0.30957174 0.30957174 0.00010168838 1.9129459e-05 +0.002815689 -0.00024355516 0.0071314932 0.0035199702 -22.147312 0 1.2777435 2.4003816 0.30957174 0.30957174 1.4106837e-06 6.3562785e-05 +-0.017645381 0.0017767886 0.0038610484 -0.00053367989 17.08026 0 4.3444186 1.8088422 0.30957174 0.30957174 6.2938204e-05 1.531173e-05 +-0.0011310679 -0.0021010056 -0.013397127 0.00023415025 -18.564344 0 0.31527092 5.0693547 0.30957174 0.30957174 4.0351274e-05 0.00018100051 +0.011418461 -0.0030758549 0.0019186331 0.0043177713 9.7549524 0 0.76127587 3.0947205 0.30957174 0.30957174 0.00010049561 2.2203564e-05 +-0.017899782 0.0030588741 0.0035991033 -0.0013523925 -13.401904 0 4.0868984 1.5883265 0.30957174 0.30957174 0.00012040659 1.4873316e-05 +0.025832021 0.0020079702 -0.0035842756 -0.0046009346 20.024863 0 2.5612305 5.9917215 0.30957174 0.30957174 0.00010998196 3.394919e-05 +0.00019889119 0.001868791 -0.0011611278 -0.013122045 17.905959 0 3.5042101 0.28532766 0.30957174 0.30957174 3.1817747e-05 0.00017215499 +0.0033334451 -0.00098633121 -0.0035052112 -0.0028716664 -9.0347535 0 0.72956547 5.7690853 0.30957174 0.30957174 1.0081876e-05 2.0566451e-05 +-0.0067878477 -0.0012214575 -0.0026191944 -0.002616279 0.80109361 0 6.1097095 5.8674712 0.30957174 0.30957174 1.8648772e-05 1.3705671e-05 +-0.014041521 -0.0013223099 -0.003349003 -0.0042958086 -17.6369 0 5.7957189 5.9913688 0.30957174 0.30957174 3.7571883e-05 2.9612005e-05 +0.013625093 0.0010245369 0.0035253268 0.0038412777 -7.6408108 0 2.5456696 2.7693123 0.30957174 0.30957174 2.994124e-05 2.7165343e-05 +-0.014436789 0.0028440815 -0.0046559217 -0.0013766967 -10.127088 0 4.0242754 5.3719846 0.30957174 0.30957174 9.6563743e-05 2.3734287e-05 +-0.017742156 0.003911977 0.0081478554 -0.0043932035 8.5495196 0 3.9778401 1.4539783 0.30957174 0.30957174 0.00017396198 8.6072901e-05 +-0.019542389 -0.00044891541 -0.002003574 -0.0063042463 14.883153 0 5.2929677 0.064230749 0.30957174 0.30957174 4.3760147e-05 4.3469193e-05 +0.014099512 0.0010894224 -0.00072693435 0.0061114891 -13.396558 0 2.5584026 3.6352382 0.30957174 0.30957174 3.2634637e-05 3.7581031e-05 +0.0062252821 -0.00014840439 -0.0023008384 -0.0013688056 20.020538 0 1.7312584 5.6198017 0.30957174 0.30957174 4.4549364e-06 7.1954905e-06 +-0.00061703128 0.0017822156 -0.007554726 0.00389425 -0.90305153 0 3.5538812 4.6140394 0.30957174 0.30957174 2.8975839e-05 7.2581699e-05 +0.0064382135 -0.0029352379 0.0031667317 -9.7420224e-05 21.598999 0 0.61058945 1.9145912 0.30957174 0.30957174 8.3033266e-05 1.0119352e-05 +0.013063457 -0.00037461221 -0.0032435054 -0.0062915036 21.111361 0 1.6895827 6.178171 0.30957174 0.30957174 2.0012231e-05 4.9869041e-05 +-0.026589194 -0.0006006801 0.0011712344 0.0078225636 14.265591 0 5.289647 3.3660783 0.30957174 0.30957174 8.0897531e-05 6.2080679e-05 +0.0034140119 0.0010341491 -0.0023027371 -0.0011213908 -19.294116 0 3.1682106 5.5366803 0.30957174 0.30957174 1.1021656e-05 6.5931731e-06 +-0.0021686746 -0.00052232651 0.001607533 0.0029480901 -7.6661164 0 6.2298281 3.0132613 0.30957174 0.30957174 3.0015632e-06 1.1226187e-05 +-0.0021568052 0.0010202446 -0.0027483161 0.0021367629 -2.3180219 0 3.7439259 4.4297613 0.30957174 0.30957174 9.9926022e-06 1.2143651e-05 +0.010813362 0.0025608156 0.0086095825 0.0063809193 18.381174 0 3.0818306 2.579025 0.30957174 0.30957174 7.2573348e-05 0.00011511607 +0.0070524878 0.00081540829 0.00096024221 -0.0019970248 -12.984393 0 2.7564119 0.82567853 0.30957174 0.30957174 1.1516782e-05 4.8854424e-06 +-0.029700697 -0.0020411425 -0.00013805019 -0.0045500816 20.642383 0 5.6460291 0.34372232 0.30957174 0.30957174 0.00013478979 2.0555052e-05 +0.0080979879 0.00023237956 0.006412199 -0.0029232952 9.3736509 0 2.2007777 1.5204067 0.30957174 0.30957174 7.6907994e-06 4.9928023e-05 +-0.0032068499 0.004679227 -0.0012608892 0.0039875643 -22.312304 0 3.5909858 3.8244915 0.30957174 0.30957174 0.00020058025 1.73749e-05 +-0.0053469047 -0.00088408215 -0.0032862175 -0.0017299117 -21.940632 0 6.0713812 5.5679055 0.30957174 0.30957174 1.0258358e-05 1.3855656e-05 +-0.012251632 -0.0016988568 -0.0035233883 0.00028743478 17.935429 0 5.9878397 5.0059457 0.30957174 0.30957174 4.2768503e-05 1.2597414e-05 +-0.0017900812 -0.001160013 -0.0053419873 -0.0055511701 -15.733093 0 0.20649036 5.8872312 0.30957174 0.30957174 1.2609621e-05 5.9335774e-05 +0.0049232677 0.0023075266 -0.0049684326 0.0012325234 6.6429634 0 3.2858233 4.8454175 0.30957174 0.30957174 5.1165346e-05 2.6393382e-05 +0.00027660361 0.001756303 0.0054216886 -0.0024464809 9.4790158 0 3.4986057 1.5242478 0.30957174 0.30957174 2.8107185e-05 3.55712e-05 +-0.028702619 -0.0006579579 0.0058326266 -0.00082742196 -5.7038977 0 5.2925479 1.8053006 0.30957174 0.30957174 9.4382241e-05 3.4975944e-05 +0.0085658246 -0.0028263948 0.0058374378 0.0080865067 13.028055 0 0.69547719 2.886779 0.30957174 0.30957174 8.0825032e-05 9.92163e-05 +0.012133829 0.0010865405 -0.0034981018 -0.0045873461 20.86298 0 2.6293447 6.002079 0.30957174 0.30957174 2.6916706e-05 3.3210054e-05 +0.019121284 0.0025824442 0.00265052 -0.001216755 6.3689952 0 2.8333802 1.5178019 0.30957174 0.30957174 0.00010088765 8.5510463e-06 +0.00566184 -0.0035002005 0.0011450199 -0.008362478 12.967049 0 0.55004102 0.51147307 0.30957174 0.30957174 0.00011512171 7.0687343e-05 +-0.022767991 0.0011737358 0.0016893292 -0.0057738843 15.95646 0 4.6476505 0.66113245 0.30957174 0.30957174 6.9455938e-05 3.5945272e-05 +-0.010092863 -0.0001843258 0.0069110463 0.0064396156 6.5708818 0 5.2515438 2.69115 0.30957174 0.30957174 1.1492031e-05 8.928525e-05 +-0.0062783414 0.0017505074 -0.0038088022 0.0047605787 -2.7918181 0 3.8909776 4.1946412 0.30957174 0.30957174 3.224079e-05 3.7105091e-05 +0.010698258 -0.0025596584 0.0072771176 -0.0027377538 -16.408597 0 0.80446469 1.5879295 0.30957174 0.30957174 7.2247554e-05 6.0822819e-05 +0.030806074 0.00068234035 0.0031199707 -0.0018397351 -1.7456145 0 2.1441921 1.4158568 0.30957174 0.30957174 0.00010842115 1.3170826e-05 +-0.0041194701 -0.00036311236 -0.0095379629 -0.00014140399 14.394988 0 5.7632262 5.1013937 0.30957174 0.30957174 3.0639959e-06 9.1734159e-05 +0.013475085 -0.0024051442 -0.008961654 -0.0025702256 -2.4387883 0 0.92570356 5.3638507 0.30957174 0.30957174 7.262826e-05 8.7518566e-05 +-0.0014944832 -0.0011249575 0.005090738 0.00026176198 24.941348 0 0.22948467 1.9960559 0.30957174 0.30957174 1.1773369e-05 2.6194837e-05 +0.008402708 0.00028498818 -0.0085883721 -0.0027353936 -13.702722 0 2.2447493 5.3926907 0.30957174 0.30957174 8.4907076e-06 8.1783289e-05 +0.0010757763 0.0017083141 0.0081884597 0.0065950914 -6.2489063 0 3.4468729 2.6191667 0.30957174 0.30957174 2.6711278e-05 0.00011074099 +0.019028765 0.00029269508 -0.0028593154 0.0067743052 23.031589 0 2.0843081 3.9182066 0.30957174 0.30957174 4.0529984e-05 5.3762471e-05 +0.0042158317 0.0029856197 0.0031687878 -0.0021262144 0.84204712 0 3.3621067 1.3578597 0.30957174 0.30957174 8.3151391e-05 1.4607303e-05 +0.019481958 -0.0012941899 0.0070224834 0.0031438494 12.104187 0 1.4009081 2.3630028 0.30957174 0.30957174 5.6923039e-05 5.952115e-05 +-0.00054695398 0.00024560906 -0.0053638343 -0.004237852 -16.964096 0 3.755656 5.7514059 0.30957174 0.30957174 5.8235305e-07 4.6819423e-05 +0.017977042 -0.00047840719 0.0021339175 0.00036418821 -2.8102953 0 1.7072648 2.1127932 0.30957174 0.30957174 3.756197e-05 4.7222844e-06 +-0.027974309 -0.0009999994 0.0054382365 -0.001425634 -10.988417 0 5.401494 1.6907001 0.30957174 0.30957174 9.5016665e-05 3.1831498e-05 +0.0067964487 4.1324745e-05 -0.00018877667 -0.001804247 8.5302331 0 2.0004282 0.26920692 0.30957174 0.30957174 5.0863441e-06 3.2649124e-06 +-0.026422295 -0.0016049538 -0.0040455184 -0.001828335 -8.7667276 0 5.592082 5.5081173 0.30957174 0.30957174 0.00010010409 1.9815413e-05 +-0.0099799393 0.0018508554 -0.00027859681 0.001699573 23.519857 0 4.0503538 3.6796706 0.30957174 0.30957174 4.2139378e-05 2.9434407e-06 +0.01357599 -0.0033239908 0.00014609248 -0.011075416 -15.436826 0 0.79578626 0.38759771 0.30957174 0.30957174 0.00012088145 0.00012169452 +0.010169907 -0.0010191461 0.0016780985 0.0021856673 5.0380635 0 1.2052173 2.8571875 0.30957174 0.30957174 2.081544e-05 7.5774842e-06 +0.0030856291 -0.0019850983 -0.0014465567 0.0022448702 7.5757734 0 0.54330941 4.0920123 0.30957174 0.30957174 3.6941746e-05 7.1082778e-06 +0.0019547426 0.002832307 0.003648214 -0.005195776 10.834059 0 3.4402738 0.9902911 0.30957174 0.30957174 7.349454e-05 4.0195762e-05 +-0.010118251 0.00078090354 -0.015271484 -0.0030202092 -20.974131 0 4.4739253 5.2803982 0.30957174 0.30957174 1.6793851e-05 0.00024416726 +-0.0093033111 0.0020237041 0.0023042756 0.0036943462 1.3799325 0 3.9832643 2.9545551 0.30957174 0.30957174 4.6807719e-05 1.8890806e-05 +-0.00164575 -0.0026580148 -0.00099085622 0.0090064304 -12.438193 0 0.30643457 3.6263548 0.30957174 0.30957174 6.4655467e-05 8.1449696e-05 +-0.0088280063 -8.6419686e-05 0.0098003282 0.0018305248 5.7782124 0 5.1756281 2.128291 0.30957174 0.30957174 8.623359e-06 0.00010015311 +0.0100538 0.00079657971 -0.0027852844 0.0083820375 13.225271 0 2.5702722 3.8391435 0.30957174 0.30957174 1.6876394e-05 7.7511501e-05 +-0.016190736 -0.00047699822 0.0049424908 -0.0041099411 -13.981731 0 5.348884 1.2553984 0.30957174 0.30957174 3.0849567e-05 4.1382381e-05 +0.0079315447 0.00012589126 0.0034619806 0.0091365695 10.091811 0 2.0886876 3.1509963 0.30957174 0.30957174 7.050376e-06 9.4884931e-05 +0.0087829321 0.0037614723 -0.0037900511 -0.0023992945 12.890152 0 3.2649691 5.6473941 0.30957174 0.30957174 0.00013735378 2.0191651e-05 +-0.023223796 -0.0012331639 -0.00093402115 0.0086597086 -3.8068108 0 5.5372122 3.6242049 0.30957174 0.30957174 7.3060207e-05 7.5263696e-05 +0.013180827 -0.00035711533 -0.0026991569 -0.0064557242 -6.3475595 0 1.703127 6.2585737 0.30957174 0.30957174 2.023375e-05 4.8684222e-05 +-0.0041236359 -0.00023951 0.0022289563 0.00027858856 9.6064881 0 5.5733395 2.0684427 0.30957174 0.30957174 2.3892488e-06 5.0857305e-06 +-0.013553767 -0.00016326311 0.0069718641 0.0037929488 2.9979386 0 5.1959798 2.4399492 0.30957174 0.30957174 2.0409347e-05 6.3273255e-05 +0.0023980418 -0.0015315699 0.0041311462 0.0023060255 0.47141487 0 0.54451933 2.4507693 0.30957174 0.30957174 2.1999207e-05 2.2480245e-05 +-0.018454846 7.26949e-05 0.012082966 -0.002486523 23.583322 0 5.0508222 1.7437393 0.30957174 0.30957174 3.7436134e-05 0.00015332101 +-0.0035754699 0.0020463283 0.0023537076 -0.0023774288 -12.477422 0 3.7054003 1.1587439 0.30957174 0.30957174 3.9548535e-05 1.1191565e-05 +-0.0015719611 -0.001498807 0.0093950413 -0.0046268979 3.8492468 0 0.25966999 1.4906906 0.30957174 0.30957174 2.0734773e-05 0.00011022141 +-0.00064233019 0.0012940632 -0.0053926682 0.0057455107 14.774212 0 3.5703288 4.2736752 0.30957174 0.30957174 1.5299851e-05 6.2061903e-05 +0.038421202 -0.0017166567 0.0054938346 0.0097083659 -14.87793 0 1.5585649 2.9974474 0.30957174 0.30957174 0.00018889608 0.00012391851 +0.00051735704 -2.4903973e-05 0.0036694854 0.0032433339 -8.459936 0 1.5318494 2.6648995 0.30957174 0.30957174 3.5032432e-08 2.4009046e-05 +-0.0026245553 -0.0017545275 0.00033718039 0.0020586558 -9.7439637 0 0.21154013 3.3522477 0.30957174 0.30957174 2.8798177e-05 4.3184128e-06 +0.0061335626 -0.00090599183 0.0045941026 -0.0074576069 15.537779 0 1.0134287 0.93005467 0.30957174 0.30957174 1.1607045e-05 7.6444026e-05 +0.0022795985 0.00069393725 0.0010775918 0.003531915 -4.5696379 0 3.1697888 3.2174889 0.30957174 0.30957174 4.9570741e-06 1.3544227e-05 +-0.0010588882 0.0002770654 0.00019668555 0.0003684251 -11.737593 0 3.9131346 3.0221491 0.30957174 0.30957174 8.2237029e-07 1.7364006e-07 +-0.011513587 -0.0013088838 -0.0074616548 0.0037087032 19.476091 0 5.8895595 4.6286444 0.30957174 0.30957174 3.0158305e-05 6.9773417e-05 +0.0091854456 0.0027510396 -0.0048069783 -0.0026509216 1.7162689 0 3.1645647 5.5872374 0.30957174 0.30957174 7.8203905e-05 3.0265967e-05 +-0.0034089564 0.0014553116 0.0012987723 0.00087067739 14.480084 0 3.7675842 2.5319197 0.30957174 0.30957174 2.0568755e-05 2.4525094e-06 +-0.00065159284 0.0021491588 0.0034685494 0.0030758441 -17.004174 0 3.5491634 2.666532 0.30957174 0.30957174 4.2121759e-05 2.1513226e-05 +-0.005516672 0.0010424144 0.0073076683 -0.0025758888 -21.094914 0 4.0421966 1.6087416 0.30957174 0.30957174 1.3239419e-05 6.041889e-05 +0.005509882 0.0021086768 -0.0082851476 0.0045555635 2.0723512 0 3.2365504 4.5873838 0.30957174 0.30957174 4.3837703e-05 8.978859e-05 +-0.021892551 -0.00041801078 0.0094480461 -0.0013567227 -0.98355624 0 5.2588986 1.8036112 0.30957174 0.30957174 5.4206041e-05 9.1819061e-05 +0.0056947877 0.00079184956 0.0044846651 0.0058721717 5.8076589 0 2.8475939 2.8597515 0.30957174 0.30957174 9.2719481e-06 5.4479752e-05 +-0.0044835905 0.0013483392 5.4597354e-05 -0.00015890308 -6.4252972 0 3.8659013 0.70775534 0.30957174 0.30957174 1.8767819e-05 2.8051189e-08 +0.0028738601 -0.00094380023 -0.0029117298 0.0024565146 3.8526345 0 0.69689323 4.3898851 0.30957174 0.30957174 9.0209142e-06 1.4532953e-05 +-0.034228218 0.002447043 0.0061898397 0.0023691254 -10.319418 0 4.5094376 2.3079372 0.30957174 0.30957174 0.00018315866 4.4193815e-05 +0.024715258 0.0010062855 0.0045772103 0.003524218 -15.862376 0 2.3002588 2.5973228 0.30957174 0.30957174 7.6280868e-05 3.3441326e-05 +-0.00161743 0.00074820313 -0.00094538082 0.004087213 21.469568 0 3.7488935 3.7449866 0.30957174 0.30957174 5.3866867e-06 1.7471264e-05 +0.013364449 -0.0015388208 0.0057978185 0.0014523742 -7.7521185 0 1.1358462 2.1886423 0.30957174 0.30957174 4.117783e-05 3.5981053e-05 +-0.023423754 -0.00035869776 -6.469266e-05 -0.0062361297 -0.89396735 0 5.2252906 0.36384224 0.30957174 0.30957174 6.1403641e-05 3.857908e-05 +0.010346852 -0.00024342929 0.0042390046 -0.0018473055 4.0180177 0 1.7339749 1.5370895 0.30957174 0.30957174 1.2292237e-05 2.1500585e-05 +-0.01021117 0.00010210393 -0.010053864 0.0030717309 7.1949557 0 4.9958531 4.7924303 0.30957174 0.30957174 1.1541193e-05 0.0001112634 +0.0073855321 0.00072167854 -0.0086804119 -0.0057792704 -8.8210311 0 2.6724286 5.6703405 0.30957174 0.30957174 1.073225e-05 0.00010909368 +-0.036895505 0.0020171761 0.0019342872 0.0058204101 10.753698 0 4.6246157 3.1926095 0.30957174 0.30957174 0.00018650309 3.7375214e-05 +0.012850964 -0.0017977517 -0.0028925928 -0.002370209 -15.130518 0 1.0396573 5.7691749 0.30957174 0.30957174 4.7570068e-05 1.4007765e-05 +0.029211001 -0.0011005798 0.0053352014 0.0010585412 -14.145591 0 1.6144808 2.1394159 0.30957174 0.30957174 0.00010470476 2.9807858e-05 +0.003676416 3.4027826e-05 -0.002315428 0.0053695579 -21.304781 0 2.0292114 3.9259752 0.30957174 0.30957174 1.4942973e-06 3.4003929e-05 +-0.0029224885 -0.0029317707 -0.0067191389 0.0023085449 12.484207 0 0.26530452 4.7582344 0.30957174 0.30957174 7.9235238e-05 5.0801142e-05 +-0.0085909663 -0.00023425371 -0.0031108698 -0.0097282532 0.16679145 0 5.3301515 0.06243666 0.30957174 0.30957174 8.6019337e-06 0.00010363007 +0.021594728 0.0027929595 -0.0059026201 -0.00092881847 -22.00274 0 2.8121083 5.2415245 0.30957174 0.30957174 0.00012225137 3.5980667e-05 +0.0059457684 -5.2525732e-05 0.002234612 0.002928685 -4.2818127 0 1.8647962 2.8601987 0.30957174 0.30957174 3.9059864e-06 1.3542038e-05 +0.017099429 -0.0014046639 -0.0027632392 0.0079332256 16.072242 0 1.3026803 3.8535933 0.30957174 0.30957174 5.0071283e-05 7.012491e-05 +0.015810839 -0.0014367899 -0.0028420135 -0.0095376315 12.86917 0 1.253631 0.082469184 0.30957174 0.30957174 4.6247421e-05 9.8373755e-05 +0.0023965094 0.001823464 -0.0068706396 -0.0077596224 11.819093 0 3.3726059 5.9287446 0.30957174 0.30957174 3.0919346e-05 0.00010731537 +-0.025037385 0.00070727825 0.0052986268 0.0042583218 14.249397 0 4.834824 2.6181076 0.30957174 0.30957174 7.3372871e-05 4.6290992e-05 +-0.00054188843 0.0012389618 -0.007591263 0.00026968361 5.1321727 0 3.5638696 5.0514656 0.30957174 0.30957174 1.4015368e-05 5.8169179e-05 +0.0024012841 0.0015772411 -0.0018072868 -0.0016536766 -24.081915 0 3.3502926 5.823691 0.30957174 0.30957174 2.3294292e-05 6.0054458e-06 +-0.0017861056 -0.0013548235 -0.0037220333 -0.00090189249 11.476197 0 0.23057574 5.3225675 0.30957174 0.30957174 1.7070894e-05 1.4773296e-05 +0.0090601154 -0.0020529225 -0.00083945354 -0.00023649377 7.7295849 0 0.82545194 5.3591837 0.30957174 0.30957174 4.7402506e-05 7.6590374e-07 +-0.0069057503 0.0021474525 0.0048256635 -0.0028387325 -10.614439 0 3.8552551 1.4168971 0.30957174 0.30957174 4.7243563e-05 3.1470103e-05 +0.0020793238 -0.00032385936 0.00067129786 0.0019817893 9.3258119 0 0.9882525 3.1868154 0.30957174 0.30957174 1.4300664e-06 4.3500461e-06 +-0.039731123 0.0048269441 -0.001651868 -0.0033704306 11.305197 0 4.2506862 6.1985682 0.30957174 0.30957174 0.00038553272 1.401886e-05 +0.017503358 -0.001155211 0.014343426 -0.00047237464 -8.275172 0 1.4037854 1.9124413 0.30957174 0.30957174 4.5788682e-05 0.00020763231 +-0.0029315113 0.00043415851 -0.0035140871 -0.0042620033 15.94468 0 4.1537593 5.963986 0.30957174 0.30957174 2.6604564e-06 3.0467267e-05 +-0.0017911654 0.00017997312 0.0033609606 0.0029691282 13.529052 0 4.3454884 2.6646473 0.30957174 0.30957174 6.4725029e-07 2.0132579e-05 +-0.038547569 0.0019317494 -0.0087593771 0.0073193325 -23.312655 0 4.6584416 4.3946068 0.30957174 0.30957174 0.00019711235 0.00013049159 +-0.010510569 0.00075390438 0.0070919582 0.0029104301 -4.11172 0 4.507928 2.3316797 0.30957174 0.30957174 1.7304803e-05 5.9107983e-05 +0.013393709 -0.00016203492 -0.0059090689 0.0087925763 -12.097574 0 1.8353357 4.111379 0.30957174 0.30957174 1.9932222e-05 0.00011188602 +0.0034371182 -0.0019988562 0.0023037654 -0.0037222877 12.342515 0 0.56087115 0.93214877 0.30957174 0.30957174 3.7692722e-05 1.9093992e-05 +-0.0017376442 -0.0025265808 -0.0033211795 -0.0036535141 -20.607169 0 0.29894461 5.9156575 0.30957174 0.30957174 5.8482174e-05 2.4360384e-05 +-0.018735534 -0.0017337154 0.0025439378 -0.010954749 16.160878 0 5.7870745 0.60427376 0.30957174 0.30957174 6.5914633e-05 0.00012556055 +0.0061786882 -0.0012149333 -9.131155e-05 0.0049393124 5.0216977 0 0.88348131 3.5345282 0.30957174 0.30957174 1.763688e-05 2.4207943e-05 +0.006074727 -0.0011267485 0.004358515 -0.0013062828 -9.7304839 0 0.90870501 1.6561327 0.30957174 0.30957174 1.5615946e-05 2.0844087e-05 +0.002672083 -0.00023377762 -0.0024889324 -0.0090198449 -20.88889 0 1.2722063 0.10297169 0.30957174 0.30957174 1.2816562e-06 8.6945038e-05 +-0.0098950115 0.0006007266 -0.0084887174 -0.0086490557 16.907905 0 4.5815222 5.8773841 0.30957174 0.30957174 1.4035726e-05 0.00014684702 +-0.0054744354 0.0041284597 -0.0062805968 -0.00082147197 -1.6744487 0 3.6604445 5.2157062 0.30957174 0.30957174 0.0001585518 4.0436811e-05 +-0.0012987992 -0.0004877999 0.0053550242 0.003496902 -7.7822669 0 0.089933222 2.5198766 0.30957174 0.30957174 2.3527453e-06 4.1039493e-05 +-0.00030500576 0.00074282028 -0.00047403935 0.0018466286 -19.63156 0 3.5609374 3.7691347 0.30957174 0.30957174 5.0366022e-06 3.6090093e-06 +0.018169658 -0.00055867447 -0.0057060342 -0.0031478814 -2.1754372 0 1.6720026 5.5873918 0.30957174 0.30957174 3.9084583e-05 4.2653272e-05 +0.0091462658 -0.00077536462 0.0029971414 -0.00042910019 -6.5115578 0 1.2875148 1.8040277 0.30957174 0.30957174 1.4659773e-05 9.238721e-06 +0.033805539 -0.0021071085 -0.0002469024 5.1107711e-05 -23.225842 0 1.4286978 4.8841818 0.30957174 0.30957174 0.00016589952 6.4048613e-08 +-0.010006767 -0.0015760862 -0.0045786832 0.00088553618 -10.509506 0 6.0487841 4.8971517 0.30957174 0.30957174 3.3620688e-05 2.191307e-05 +-0.0037237466 0.00085385635 0.0074514229 -0.0058786379 -9.8392419 0 3.9623946 1.2810874 0.30957174 0.30957174 8.1635788e-06 9.0255269e-05 +-0.011721313 -0.00086131275 -0.0064849709 0.012122989 -4.9093857 0 5.6765685 4.0104781 0.30957174 0.30957174 2.1840051e-05 0.00018817618 +-0.0045193836 0.0028428888 0.0015691685 -0.0093559849 -11.026284 0 3.6886671 0.54180133 0.30957174 0.30957174 7.586431e-05 8.9309023e-05 +0.00059709313 -0.0010499703 -0.0037694244 0.0059943536 1.7929003 0 0.43664693 4.0809061 0.30957174 0.30957174 1.0081657e-05 4.9966117e-05 +-0.019910124 0.0016703916 0.0050102493 -0.0084299061 5.6456074 0 4.4341331 0.91412191 0.30957174 0.30957174 6.8934087e-05 9.5795937e-05 +-0.012717807 0.003948948 -0.00097225717 0.0017586805 -15.391945 0 3.8557205 4.0243539 0.30957174 0.30957174 0.00015980897 4.0209377e-06 +-0.013141941 0.00090526893 0.0010492429 0.0024167852 -5.87807 0 4.5263014 3.1033253 0.30957174 0.30957174 2.6424893e-05 6.9035074e-06 +-0.00026187591 -0.0020850589 -0.0048889926 -0.010845127 15.534901 0 0.36051355 6.2309159 0.30957174 0.30957174 3.9610277e-05 0.00014076283 +-0.0068016016 0.0017909711 -0.0027288176 0.0037091762 8.5202523 0 3.9108845 4.154055 0.30957174 0.30957174 3.429751e-05 2.1153891e-05 +-0.0075484437 0.001179751 -0.004160526 -0.0021351956 10.53573 0 4.1282212 5.5575535 0.30957174 0.30957174 1.8933528e-05 2.197328e-05 +0.0014897658 -0.0026964869 0.00046897814 0.00053702428 -0.94333921 0 0.4348761 2.7940075 0.30957174 0.30957174 6.6478295e-05 5.0779655e-07 +-0.0060015701 -0.00091710653 -0.0075946359 0.0022580265 8.6646729 0 6.0345279 4.7999045 0.30957174 0.30957174 1.1615795e-05 6.3206133e-05 +0.0090467291 0.0001772792 0.0011206681 0.0016909578 18.491022 0 2.1217429 2.9268682 0.30957174 0.30957174 9.270801e-06 4.102353e-06 +-0.010338998 -0.0023906477 0.00048094846 0.0012037735 -17.142201 0 6.214233 3.1329829 0.30957174 0.30957174 6.3796477e-05 1.6705506e-06 +-0.016959227 -0.0023278584 -0.0018588813 0.003401298 6.5133718 0 5.9828897 4.0194854 0.30957174 0.30957174 8.0936579e-05 1.4958892e-05 +0.0095456176 0.00033672597 -0.0016001417 0.00069937601 -3.2646276 0 2.2560122 4.6776098 0.30957174 0.30957174 1.1035611e-05 3.0664975e-06 +0.01057701 -0.00023398951 -0.0056650696 0.0021780437 -12.63851 0 1.7462382 4.7223542 0.30957174 0.30957174 1.2779845e-05 3.7060144e-05 +0.0032878305 -0.00069413446 0.0041274937 -8.9803699e-05 3.8857954 0 0.85379488 1.9235184 0.30957174 0.30957174 5.5757746e-06 1.7183079e-05 +0.021421796 -0.00044036385 -0.004740815 0.0029990077 8.0964245 0 1.7599807 4.5263098 0.30957174 0.30957174 5.2142424e-05 3.1579864e-05 +-0.013538689 0.0013805384 -0.0053980589 0.0033584985 -23.817008 0 4.3381445 4.5337642 0.30957174 0.30957174 3.7483133e-05 4.0564883e-05 +0.012435012 -0.00031561359 0.0037440843 0.0001862656 -11.616292 0 1.7178836 1.9944036 0.30957174 0.30957174 1.7882167e-05 1.4166854e-05 +0.0096472577 -0.0017891374 -0.0024066112 0.0067395357 -10.179862 0 0.908766 3.861448 0.30957174 0.30957174 3.9376128e-05 5.0893061e-05 +-0.012973721 -0.00021775524 -0.0013103042 0.005813257 20.078632 0 5.2384091 3.7393353 0.30957174 0.30957174 1.8909326e-05 3.5251596e-05 +0.0091666176 -0.0018995842 0.0059917799 3.8160103e-05 -11.722633 0 0.86145503 1.9514138 0.30957174 0.30957174 4.2094676e-05 3.6195531e-05 +0.0097407783 0.0018353937 0.00052891728 0.0045805396 -15.654743 0 2.9883605 3.4000027 0.30957174 0.30957174 4.110243e-05 2.1093725e-05 +-0.029353753 -0.0016302626 -0.00013530109 0.0011981458 -14.808558 0 5.5550623 3.6292508 0.30957174 0.30957174 0.00011879906 1.4424012e-06 +-0.0081611549 -0.00066575557 -0.0031339424 0.0010902579 -15.878562 0 5.7257648 4.7544095 0.30957174 0.30957174 1.134919e-05 1.1080709e-05 +-0.0063196772 -0.00018386149 0.0038734242 0.0015313173 24.66498 0 5.345757 2.3188112 0.30957174 0.30957174 4.6922516e-06 1.7451691e-05 +-0.0091766422 0.0017956407 0.00090168893 0.00094942279 10.356885 0 4.0271548 2.7522209 0.30957174 0.30957174 3.8616001e-05 1.7137857e-06 +-0.0146384 0.0016714884 0.011462827 -0.00047639252 5.6349783 0 4.2816109 1.9038962 0.30957174 0.30957174 4.8973763e-05 0.00013269262 +-0.0078859963 0.0015134468 0.005245014 0.0059942739 9.638223 0 4.0354744 2.7930351 0.30957174 0.30957174 2.7692136e-05 6.3375213e-05 +-0.0043309535 -0.0016827161 0.0039055307 -0.0045934356 18.035806 0 0.098935324 1.0829438 0.30957174 0.30957174 2.7852608e-05 3.6306552e-05 +0.001564577 0.00071740819 -0.0047077777 -0.0080625952 18.580431 0 3.2809061 6.1254435 0.30957174 0.30957174 4.9570873e-06 8.6823655e-05 +0.0039969756 0.0014966258 0.0029577752 -0.00067448276 -16.512346 0 3.2307076 1.7226466 0.30957174 0.30957174 2.2157767e-05 9.2709981e-06 +0.01850351 -0.00062934001 0.0058536754 0.010712798 -4.9647631 0 1.6446484 3.0123796 0.30957174 0.30957174 4.1193377e-05 0.00014838092 +0.0088621515 -0.00025474286 -0.0012337461 -0.0023323116 20.65075 0 1.6889971 6.1675604 0.30957174 0.30957174 9.2127791e-06 6.9302305e-06 +0.0035538878 0.0018792205 -0.0041183729 -0.0010372604 7.429035 0 3.3111959 5.3315034 0.30957174 0.30957174 3.3555983e-05 1.8166468e-05 +-0.013211155 -0.00088451291 0.0027581698 -0.0030453168 1.997821 0 5.6343496 1.1143015 0.30957174 0.30957174 2.6286726e-05 1.6868481e-05 +0.0030328436 -0.00049144304 0.0052167349 0.0050709365 12.312844 0 0.96974282 2.7122663 0.30957174 0.30957174 3.2098068e-06 5.2942642e-05 +-0.016196639 0.0021600743 -0.010298415 0.007438486 -23.545493 0 4.2045783 4.4650056 0.30957174 0.30957174 7.1301554e-05 0.00016180559 +-0.0065074256 -0.002578962 -0.0060210352 -0.0038252329 0.51840057 0 0.10407809 5.6490009 0.30957174 0.30957174 6.5235554e-05 5.1062481e-05 +-0.045452434 0.0012482971 0.0022936832 -0.0058285061 -6.8387086 0 4.8415429 0.75199007 0.30957174 0.30957174 0.00024098555 3.9000664e-05 +0.0018338697 0.0018036808 -0.0060138137 0.004126142 7.2018902 0 3.4047386 4.4891278 0.30957174 0.30957174 3.0004398e-05 5.3348157e-05 +-0.017290293 0.00047449002 -0.0086844919 -0.0084919808 -8.4940814 0 4.841725 5.8568221 0.30957174 0.30957174 3.4869189e-05 0.00014756585 +-0.0287526 0.0014318282 0.0010592155 0.0051175304 18.329783 0 4.6608201 3.3101796 0.30957174 0.30957174 0.00010942938 2.7108439e-05 +-0.0032505293 0.0010718716 -0.00093396475 0.0040037293 3.3981861 0 3.8372595 3.746871 0.30957174 0.30957174 1.162574e-05 1.6779634e-05 +-0.0069229645 -0.00077762394 -0.0041293024 -0.00032655608 11.618596 0 5.8835604 5.1649721 0.30957174 0.30957174 1.0769761e-05 1.7295912e-05 +-0.034589227 -0.00016637005 0.0097205171 0.0038714577 18.865773 0 5.1304763 2.3213341 0.30957174 0.30957174 0.00013159094 0.00011012569 +-0.0096734654 -0.0027892218 0.00020278811 -0.0060455967 -19.360788 0 0.010520677 0.40810393 0.30957174 0.30957174 8.1141233e-05 3.6295165e-05 +-0.010671821 -1.5900611e-05 0.0050901764 -0.00025797956 -1.6863648 0 5.100261 1.8948668 0.30957174 0.30957174 1.250456e-05 2.6187123e-05 +-0.007768981 0.00033990469 0.0090920478 -0.0031641949 -0.60762693 0 4.7074343 1.6127009 0.30957174 0.30957174 7.678271e-06 9.3270376e-05 +-0.0098777051 0.0011740644 -0.0024453038 -0.00081041715 -19.41495 0 4.2615851 5.4042983 0.30957174 0.30957174 2.3267451e-05 6.6797197e-06 +0.0071553781 0.0016315367 0.00058974383 0.010070428 17.529472 0 3.0671988 3.456922 0.30957174 0.30957174 2.9868878e-05 0.00010094413 +0.015253838 0.0011965687 -0.0020739939 -0.0033874331 -8.0552638 0 2.5655369 6.1044771 0.30957174 0.30957174 3.8585456e-05 1.5718435e-05 +0.011864184 0.00042633735 -0.0017533573 0.0015690083 -21.381745 0 2.261447 4.3607541 0.30957174 0.30957174 1.7107836e-05 5.5412039e-06 +0.0087346523 0.0023003393 -0.0058900923 -0.00013425076 -10.114683 0 3.1209576 5.1092937 0.30957174 0.30957174 5.6578162e-05 3.4993876e-05 +0.029950789 0.00038329485 -0.0083234202 -0.0086418178 1.8704677 0 2.0611499 5.8867958 0.30957174 0.30957174 9.9813732e-05 0.00014392123 +0.0056483155 0.00064046335 -0.0006645915 -0.00077492803 15.753829 0 2.7466837 5.9445716 0.30957174 0.30957174 7.2388721e-06 1.0409401e-06 +0.0052138033 -5.3853385e-05 0.00032996993 -0.00055923844 23.956345 0 1.851282 0.91092015 0.30957174 0.30957174 3.0105687e-06 4.1998652e-07 +-0.035800652 0.00058279161 0.0053870824 -0.0037726889 -1.5918725 0 4.9394724 1.3379644 0.30957174 0.30957174 0.00014379368 4.337532e-05 +0.040207677 0.00081100637 -0.0042228841 0.0030212111 2.5433331 0 2.1268099 4.4695142 0.30957174 0.30957174 0.00018346331 2.703203e-05 +0.0087151751 0.00093191193 0.0090952366 -0.0017050421 -7.3775867 0 2.717357 1.7612468 0.30957174 0.30957174 1.624916e-05 8.6281332e-05 +0.0079115367 0.00074006386 0.0049310846 0.00040810567 8.2329782 0 2.6508159 2.0270056 0.30957174 0.30957174 1.1860363e-05 2.4679014e-05 +0.032364705 9.1192789e-05 0.00058531533 -0.0072601643 -2.5286017 0 1.9707581 0.45539932 0.30957174 0.30957174 0.00011506432 5.2629167e-05 +0.0098030269 0.0014181645 0.0038558445 -0.0054925462 15.396525 0 2.866764 0.9901998 0.30957174 0.30957174 2.8870188e-05 4.4912862e-05 +-0.011292037 0.0037786518 0.011757722 0.0048098359 -5.1636503 0 3.8328855 2.3305682 0.30957174 0.30957174 0.00014406327 0.00016231841 +0.007438261 -0.0013996151 0.007991686 -0.0085067623 -13.547182 0 0.90243219 1.1325413 0.30957174 0.30957174 2.3918273e-05 0.00013616755 +0.0086113693 0.0021442659 -0.0039122162 -0.0086497597 -3.8392289 0 3.1006622 6.2296707 0.30957174 0.30957174 5.0024377e-05 8.9643574e-05 +-0.0056268108 -0.0013173402 -0.0039203041 -0.0028349059 -20.27975 0 6.21903 5.7089233 0.30957174 0.30957174 1.9283926e-05 2.3465776e-05 +-0.012856447 -0.001569797 -0.0011270314 -0.00067993519 -18.504863 0 5.9251899 5.6259456 0.30957174 0.30957174 4.0592743e-05 1.7391279e-06 +-0.01908434 -0.00046708786 0.002397749 -0.0010712907 -11.841093 0 5.3060529 1.5279307 0.30957174 0.30957174 4.1969506e-05 6.9344503e-06 +0.0032582967 0.00046489402 -0.0064878581 0.0066582157 2.1538096 0 2.8600956 4.2923914 0.30957174 0.30957174 3.1342245e-06 8.6408805e-05 +0.00056423343 2.6459384e-05 0.011867648 -0.0056869687 15.282435 0 2.3488112 1.5013835 0.30957174 0.30957174 4.1326e-08 0.00017406927 +0.02461119 0.0031353631 0.0026734061 -0.0046741437 21.649828 0 2.8046455 0.89735026 0.30957174 0.30957174 0.00015604284 2.8876324e-05 +0.0096929528 0.00081873598 0.0054704254 0.0081700843 -24.869606 0 2.6009255 2.9221254 0.30957174 0.30957174 1.6420191e-05 9.6380044e-05 +0.00064349306 0.0005144088 -0.0046127263 0.0048854509 11.481806 0 3.3794224 4.2766392 0.30957174 0.30957174 2.4559474e-06 4.5125332e-05 +0.021394539 -0.0026909286 0.0017576685 -0.00035841844 -14.948097 0 1.0918799 1.7455211 0.30957174 0.30957174 0.0001162097 3.2420076e-06 +-0.012943639 -7.581971e-05 -0.0082116826 -0.001819152 18.185477 0 5.1399985 5.3029924 0.30957174 0.30957174 1.844416e-05 7.1263974e-05 +0.00045090822 0.0014310061 -0.0011612268 -0.0022830845 19.050732 0 3.4813161 6.1836757 0.30957174 0.30957174 1.8676306e-05 6.5297675e-06 +0.029060755 -0.0011368333 -0.0057270294 0.0053770026 -21.924026 0 1.6027747 4.3368534 0.30957174 0.30957174 0.00010448255 6.1744612e-05 +0.035007087 -0.0049832966 0.0037306455 0.0037640785 -4.7572227 0 1.0312136 2.7308963 0.30957174 0.30957174 0.00036074667 2.8084894e-05 +0.0017527926 -0.00074936594 0.00092886202 0.0059402027 -14.18392 0 0.6256425 3.3595363 0.30957174 0.30957174 5.4526301e-06 3.5870508e-05 +-0.00364744 -0.0027752095 0.0027396533 0.004409734 20.276288 0 0.23100988 2.9563316 0.30957174 0.30957174 7.1618938e-05 2.6855403e-05 +-0.016695509 0.0019284204 -0.0051626672 -0.00050533824 3.216389 0 4.2758692 5.1834776 0.30957174 0.30957174 6.4475239e-05 2.7123705e-05 +0.01726334 -0.00021845912 0.0018756224 0.0010838941 8.2685245 0 1.8303285 2.4655863 0.30957174 0.30957174 3.3150799e-05 4.7119637e-06 +-0.0023764885 0.00029966261 0.0029594647 -0.001451634 13.992473 0 4.2322207 1.4922753 0.30957174 0.30957174 1.4379881e-06 1.0920031e-05 +-0.0096863594 -0.00058782021 0.0014972915 0.0062401907 -23.461754 0 5.5916841 3.278553 0.30957174 0.30957174 1.3447474e-05 4.0885273e-05 +-0.0014745029 0.00041829832 -0.0013550191 0.001060077 4.6980538 0 3.8851113 4.4267499 0.30957174 0.30957174 1.832572e-06 2.9657208e-06 +-0.0105806 -0.0010769415 -0.0026421059 -0.0016276364 -13.19038 0 5.834327 5.6351988 0.30957174 0.30957174 2.2854517e-05 9.6654081e-06 +0.0025553295 -0.00090144924 -0.0043161952 0.00060282613 19.619228 0 0.67598558 4.9490287 0.30957174 0.30957174 8.1191891e-06 1.9141866e-05 +0.0011329221 0.0020032374 0.0032834944 0.0036906449 5.0614168 0 3.4538886 2.784775 0.30957174 0.30957174 3.6696467e-05 2.4379946e-05 +0.01702603 -0.0036409136 -0.0062764892 0.0011360225 14.555866 0 0.84857149 4.9090487 0.30957174 0.30957174 0.00015257898 4.0995562e-05 +-0.0056697892 0.00095564133 0.0073987946 -0.0027908757 11.328349 0 4.0931839 1.5870654 0.30957174 0.30957174 1.1848089e-05 6.2914414e-05 +-0.0080139393 5.0415193e-05 -0.0022765482 -0.00089523433 13.219255 0 5.0294453 5.4585994 0.30957174 0.30957174 7.0733856e-06 6.0198838e-06 +0.018605025 -0.0014134512 -0.0034150617 0.0088623633 -23.86234 0 1.3397243 3.8864339 0.30957174 0.30957174 5.619809e-05 8.9664124e-05 +-0.0072151507 0.00020491099 -0.0072520213 0.002487369 -22.113761 0 4.8335325 4.7587568 0.30957174 0.30957174 6.0973039e-06 5.9157507e-05 +-0.0057375165 -0.00032187861 -0.0029100483 -0.0028370422 18.069682 0 5.5591316 5.8553274 0.30957174 0.30957174 4.557544e-06 1.652114e-05 +-0.0022184018 -0.0010724992 -0.0049863785 -0.0024376839 3.0217484 0 0.15101904 5.5381968 0.30957174 0.30957174 1.1018349e-05 3.096091e-05 +0.0080750932 -0.0021351794 -0.00045793368 -0.001143217 -20.253627 0 0.76781427 6.2736808 0.30957174 0.30957174 4.8687808e-05 1.50779e-06 +-0.0059891043 0.0030266135 0.0021765837 0.0029684939 -13.670746 0 3.7297979 2.8793362 0.30957174 0.30957174 8.7383069e-05 1.351684e-05 +0.030035728 0.0010075511 0.0052875165 -0.00080444833 14.183194 0 2.24166 1.795316 0.30957174 0.30957174 0.00010828223 2.8827641e-05 +-0.008264135 0.00030631272 0.0060934384 0.00017567713 -9.0731918 0 4.761066 1.9736862 0.30957174 0.30957174 8.3520315e-06 3.746328e-05 +0.010794962 0.00030662295 0.0043372702 0.0024251205 1.1240746 0 2.1982889 2.4514754 0.30957174 0.30957174 1.3648888e-05 2.4798918e-05 +-0.018800693 0.00039534571 0.00090603191 -0.0094361685 -3.0129246 0 4.8974276 0.47079925 0.30957174 0.30957174 4.0226221e-05 8.9148885e-05 +0.0024250272 0.0023540682 0.001432405 0.00043748814 -5.3302836 0 3.4032853 2.2392599 0.30957174 0.30957174 5.1126433e-05 2.258358e-06 +-0.022483098 -0.0015108246 0.001499743 -0.0041486349 17.302558 0 5.6359831 0.72378939 0.30957174 0.30957174 7.628412e-05 1.9339568e-05 +-0.0033884476 0.001995213 0.0013410424 -0.00042824925 15.471914 0 3.7002099 1.6383369 0.30957174 0.30957174 3.7523702e-05 1.9949692e-06 +-0.0061502172 -0.0014007615 -0.00072903568 0.0013005103 7.7046772 0 6.2083499 4.0302904 0.30957174 0.30957174 2.2026141e-05 2.2134769e-06 +-0.0075217573 0.00033728908 -0.0012382525 -0.0020640844 20.323381 0 4.6988933 6.1135483 0.30957174 0.30957174 7.2471532e-06 5.7717632e-06 +0.0092716147 -0.0043129955 -0.0014161256 0.0035495779 -7.0068624 0 0.60604718 3.8983015 0.30957174 0.30957174 0.00017888873 1.4519385e-05 +0.0058116229 -2.5137914e-05 -0.0035608267 0.0006225045 -13.190786 0 1.9057148 4.91499 0.30957174 0.30957174 3.7134701e-06 1.3167226e-05 +0.016401972 0.0013411334 0.0041383052 0.0040060861 -18.28802 0 2.5852889 2.7102052 0.30957174 0.30957174 4.5917199e-05 3.3184132e-05 +-0.015059671 0.00011778342 -0.0045797086 0.0039561638 11.199297 0 5.0155639 4.3782253 0.30957174 0.30957174 2.5023102e-05 3.6669383e-05 +-0.017421833 -0.0017283774 -0.0050807164 -0.0048894326 9.0190838 0 5.8215552 5.8488484 0.30957174 0.30957174 6.0531878e-05 4.9737353e-05 +0.0008306681 0.0018020536 0.0059597953 0.0046756831 11.321868 0 3.4653336 2.606399 0.30957174 0.30957174 2.9657511e-05 5.7493943e-05 +-0.0066749446 -0.00029227125 0.0040269708 0.0012794226 3.1769349 0 5.4662177 2.2503888 0.30957174 0.30957174 5.669247e-06 1.7972373e-05 +0.0040799613 0.0006659704 -0.0063688887 -0.0071898559 -4.7777863 0 2.9238412 5.9285309 0.30957174 0.30957174 5.8675166e-06 9.2169438e-05 +0.013130009 -0.0017027748 -0.0038902349 -0.003936048 -13.183809 0 1.07675 5.8738819 0.30957174 0.30957174 4.5337348e-05 3.0624499e-05 +0.011995213 0.00055900541 -0.00039921137 0.0051199213 20.693223 0 2.3465594 3.5943394 0.30957174 0.30957174 1.864184e-05 2.6162303e-05 +-0.0049107058 -0.00593902 0.0022993821 -0.0032726794 17.465959 0 0.28377872 0.99059277 0.30957174 0.30957174 0.00032395284 1.5954085e-05 +0.020741861 0.00012453615 0.0026701765 -0.0058586838 4.437857 0 1.9997357 0.80500906 0.30957174 0.30957174 4.7370063e-05 4.1234599e-05 +0.025032259 -0.0016349115 0.0058560339 0.0045904825 1.3834959 0 1.4083962 2.6059984 0.30957174 0.30957174 9.3136579e-05 5.5474824e-05 +0.027558766 -0.00052567213 0.0043439454 0.0077662778 -18.64601 0 1.7730566 3.0024453 0.30957174 0.30957174 8.5891249e-05 7.8851056e-05 +0.011894573 -0.00064810358 -0.012623441 -0.0025298065 8.9764043 0 1.4843767 5.2829163 0.30957174 0.30957174 1.9357632e-05 0.00016699844 +0.012973282 0.0021497129 -0.0041132468 -0.00030601234 -1.3123219 0 2.930786 5.160351 0.30957174 0.30957174 6.057298e-05 1.7149604e-05 +0.004086932 -0.0019220589 -0.01311424 -0.0082917587 -13.96381 0 0.60361643 5.6468396 0.30957174 0.30957174 3.5486472e-05 0.00024158259 +-0.0016045434 -0.0026218524 -0.0012948054 0.00041501882 -23.146671 0 0.30721882 4.7788612 0.30957174 0.30957174 6.2901484e-05 1.8610355e-06 +-0.0036301007 -0.0016639693 0.00048853409 0.00089736523 -18.348408 0 0.13923897 3.0139351 0.30957174 0.30957174 2.6668586e-05 1.0393642e-06 +-0.013135924 0.00064329183 -0.00039002789 0.0021722039 24.39563 0 4.66708 3.6949714 0.30957174 0.30957174 2.2711976e-05 4.8336787e-06 +-0.0072388981 -0.0016582505 0.0067051651 0.00063287974 1.9075627 0 6.2106009 2.0384482 0.30957174 0.30957174 3.0801412e-05 4.5723035e-05 +-0.0086318165 -0.00097947012 0.0027938128 -0.0058828416 -0.96716514 0 5.8886373 0.82082829 0.30957174 0.30957174 1.691848e-05 4.2197009e-05 +-0.0076242088 0.00027340189 -0.0013978452 0.0015880986 22.536375 0 4.7709571 4.2416893 0.30957174 0.30957174 7.0620916e-06 4.4715636e-06 +0.0086861082 -0.00054699359 -0.0010153272 0.0026749874 18.488761 0 1.4242788 3.88136 0.30957174 0.30957174 1.1008051e-05 8.1369913e-06 +-0.01170888 -0.0021676963 0.0030800809 0.0023384233 -11.079201 0 6.1222557 2.5905593 0.30957174 0.30957174 5.7854307e-05 1.4988242e-05 +-0.0092001608 -0.00016375433 0.0033220557 0.007340934 -11.67858 0 5.2474289 3.0878722 0.30957174 0.30957174 9.536122e-06 6.4579588e-05 +0.031421509 0.0010179836 -0.0014930835 0.0060108471 -21.38887 0 2.2320727 3.7612697 0.30957174 0.30957174 0.00011782402 3.8085609e-05 +-0.019690095 0.00045082866 0.0095840895 0.011433524 1.1115343 0 4.8810668 2.8142634 0.30957174 0.30957174 4.4411973e-05 0.00022227199 +-0.01570854 -0.0006530411 -0.00027841256 0.00086458224 3.0022718 0 5.4486983 3.8298035 0.30957174 0.30957174 3.0973186e-05 8.1960367e-07 +-0.012695067 0.00090074437 -0.0021190892 0.0044674725 -12.271985 0 4.5128974 3.9619523 0.30957174 0.30957174 2.5082986e-05 2.4324076e-05 +0.021179081 0.00081779997 0.0021427473 0.0051817785 3.5989954 0 2.2833257 3.1209143 0.30957174 0.30957174 5.5333173e-05 3.126251e-05 +-0.0053322307 0.0005283056 0.0018108325 -0.0019811531 -11.660275 0 4.3524743 1.1188571 0.30957174 0.30957174 5.6637437e-06 7.1990757e-06 +-0.0144917 -0.00092171902 0.011271584 0.003641828 13.780752 0 5.6118134 2.25524 0.30957174 0.30957174 3.0793214e-05 0.00014123994 +-0.014987117 0.0024501919 -0.0012634609 -0.0066887021 13.995419 0 4.1072164 0.1861189 0.30957174 0.30957174 7.9345014e-05 4.598633e-05 +-0.0031059558 0.00093318258 -0.0060538452 -0.0097283192 -5.904292 0 3.8661995 6.0971883 0.30957174 0.30957174 8.9917305e-06 0.00013082274 +0.010336006 0.0014088129 0.0028976006 -0.0042940429 11.075262 0 2.8378689 0.97167947 0.30957174 0.30957174 2.9807677e-05 2.6754244e-05 +0.015996685 0.0019790325 0.0014484064 -0.011005954 6.4261212 0 2.7901184 0.50620479 0.30957174 0.30957174 6.3768776e-05 0.00012226655 +-0.0053433695 0.0047392556 0.0015160856 0.0013302901 17.218535 0 3.6390369 2.6612901 0.30957174 0.30957174 0.00020773586 4.072615e-06 +-0.016217958 0.00092129447 -0.0017003862 -0.00015603714 14.031196 0 4.6091581 5.1774628 0.30957174 0.30957174 3.6605672e-05 2.9390334e-06 +-0.0030918086 0.0018078705 0.014901977 -0.0071456536 15.982098 0 3.7014726 1.5011318 0.30957174 0.30957174 3.0822437e-05 0.00027452666 +0.0020020352 0.0019097868 0.0012849198 -0.0078392602 -5.0731445 0 3.4013174 0.53806484 0.30957174 0.30957174 3.3664502e-05 6.262157e-05 +-0.019195158 0.0020506937 -0.0073443004 -0.00095041259 10.577479 0 4.3148772 5.214353 0.30957174 0.30957174 7.8755853e-05 5.5274426e-05 +0.0047201981 -0.0015915405 -0.0014285433 -0.003489543 -18.3684 0 0.68905407 6.2660658 0.30957174 0.30957174 2.5519922e-05 1.4135821e-05 +-0.016550679 0.00047918381 0.0046163855 -6.4907857e-05 10.158702 0 4.8288218 1.9311509 0.30957174 0.30957174 3.2162329e-05 2.1488917e-05 +-0.0038755785 0.0020524802 0.002074921 0.0079749726 21.488513 0 3.7202838 3.2593717 0.30957174 0.30957174 4.0023706e-05 6.7426318e-05 +0.0032253191 0.0016295598 -0.0059416773 -0.005880639 -3.2677494 0 3.3019414 5.8628655 0.30957174 0.30957174 2.5331609e-05 6.9893606e-05 +0.017060654 0.0011004805 0.0016919859 -0.0061188428 12.790686 0 2.4763421 0.64617239 0.30957174 0.30957174 4.2984319e-05 4.0023653e-05 +0.026222029 -8.8085133e-05 -0.01124217 0.00070897352 2.549528 0 1.9145059 5.0242168 0.30957174 0.30957174 7.5552771e-05 0.00012791523 +-0.00082981975 0.00024851887 -0.00049003355 0.0003570268 16.37534 0 3.8672367 4.4609001 0.30957174 0.30957174 6.3820246e-07 3.6852784e-07 +-0.0088406423 -0.0013470688 0.00583404 0.0055100573 0.27083044 0 6.0331645 2.6978912 0.30957174 0.30957174 2.5109659e-05 6.4428716e-05 +0.010788098 -0.00046872151 0.0051508104 0.0064819033 21.25952 0 1.5682296 2.8404679 0.30957174 0.30957174 1.477751e-05 6.8422463e-05 +-0.0093138018 0.0011864331 -0.0011741129 0.00028680766 2.4590664 0 4.2271847 4.8489699 0.30957174 0.30957174 2.2345387e-05 1.4713722e-06 +0.029484115 -0.0014823567 0.013686159 0.008294551 1.1942449 0 1.5156204 2.4863638 0.30957174 0.30957174 0.00011544735 0.00025708113 +-0.0025274873 -0.0024440853 -0.0016536031 0.0025962447 -22.495257 0 0.26126118 4.0867038 0.30957174 0.30957174 5.5116621e-05 9.4426773e-06 +0.0054614631 0.0021845608 -0.0012178716 -0.0058688555 -22.20249 0 3.2480422 0.16806872 0.30957174 0.30957174 4.6747115e-05 3.5660261e-05 +-3.0131858e-05 -0.0026187149 0.0088447983 -0.0010862357 -23.08151 0 0.37303714 1.8238762 0.30957174 0.30957174 6.2469177e-05 8.0038543e-05 +0.0091353518 0.00091975867 -0.0026583351 -0.012378634 -2.17257 0 2.6873029 0.16108843 0.30957174 0.30957174 1.6867533e-05 0.00015911592 +0.012178429 0.00093694444 0.0051009602 -0.0044931349 -13.372875 0 2.5563778 1.2269928 0.30957174 0.30957174 2.4278282e-05 4.6256925e-05 +-0.017159358 0.00042531939 0.00097898853 0.0049692863 24.225382 0 4.8646239 3.3198306 0.30957174 0.30957174 3.3970985e-05 2.5460367e-05 +0.012275958 -0.0017498146 0.0018461174 -8.8460746e-05 15.845328 0 1.0305725 1.8976026 0.30957174 0.30957174 4.4434855e-05 3.4436938e-06 +0.0076806474 0.0015342008 -0.0023011423 0.0050697208 12.149061 0 3.0133761 3.9450484 0.30957174 0.30957174 2.7917399e-05 3.0832667e-05 +0.030725684 0.00050262451 -0.0011655325 0.0033305978 -5.848557 0 2.0930233 3.8550597 0.30957174 0.30957174 0.00010593822 1.2372726e-05 +0.030587103 -0.0020940168 0.0033482801 0.0032490873 -10.714642 0 1.3874795 2.7114037 0.30957174 0.30957174 0.00014264792 2.1773579e-05 +0.015659967 0.00029974621 -0.0012609831 -0.0088155464 16.635116 0 2.117723 0.23108074 0.30957174 0.30957174 2.7739571e-05 7.8688515e-05 +0.014236703 0.0014921015 0.0007110179 -0.0049742562 -20.376082 0 2.7073363 0.51741977 0.30957174 0.30957174 4.2530824e-05 2.5052822e-05 +0.0087149698 0.0033384954 0.0095703936 -0.0028877698 9.7247268 0 3.2368049 1.654282 0.30957174 0.30957174 0.00010986667 0.00010061086 +-0.025854986 0.0019372001 -0.0022755325 -0.0059849418 -10.556839 0 4.4877877 0.0082649623 0.30957174 0.30957174 0.00010756892 4.0750155e-05 +-0.026709917 0.00063532766 -0.0010640424 0.0064854033 6.4059742 0 4.8733102 3.6798135 0.30957174 0.30957174 8.1993986e-05 4.2861776e-05 +0.0033870994 -0.0013408914 -0.0033240602 -0.0052976156 21.009216 0 0.64480102 6.0934552 0.30957174 0.30957174 1.7637977e-05 3.8977252e-05 +0.013274749 0.00089366826 0.002079564 -0.0017048288 -19.250058 0 2.495203 1.2623752 0.30957174 0.30957174 2.6619927e-05 7.2427797e-06 +0.013410625 0.00060989398 -0.0041125628 0.002372118 -4.2990507 0 2.3378524 4.5670114 0.30957174 0.30957174 2.313125e-05 2.263249e-05 +-0.0084679982 -0.00072808001 0.0072558763 -0.0049588432 -22.462961 0 5.751118 1.3493585 0.30957174 0.30957174 1.2700663e-05 7.7468208e-05 +0.010589229 0.0047250288 -0.00013587669 -0.0010594765 -2.7060684 0 3.2746632 0.24571925 0.30957174 0.30957174 0.00021568449 1.1320272e-06 +-0.012492895 0.00017408063 -0.0033806381 0.0042533457 10.256849 0 4.960431 4.1914247 0.30957174 0.30957174 1.7409213e-05 2.9466547e-05 +-0.0014405789 0.0015468254 0.011796964 0.0060054731 6.695474 0 3.6177757 2.4126988 0.30957174 0.30957174 2.2023538e-05 0.00017607692 +-0.0043722707 0.00068479124 0.0037906217 0.0064155397 5.9501996 0 4.1272271 2.9786659 0.30957174 0.30957174 6.3703219e-06 5.5312286e-05 +0.0076921856 0.00085156756 0.0049831856 0.0073816582 -0.43706074 0 2.7347062 2.9183199 0.30957174 0.30957174 1.3101296e-05 7.9082853e-05 +-0.0134015 -0.0019976729 -0.00019382739 -0.0020373493 -23.183498 0 6.0227162 0.27868018 0.30957174 0.30957174 5.6068735e-05 4.1551049e-06 +-0.0085277868 -0.0030853755 0.00147144 -0.0008814477 -10.361046 0 0.079711735 1.4089573 0.30957174 0.30957174 9.4700421e-05 2.9534531e-06 +-0.02650534 -0.0026276735 -0.0072293996 -0.00072460586 19.303341 0 5.8212039 5.1857836 0.30957174 0.30957174 0.00014001919 5.3211073e-05 +-0.010934771 0.0013723999 0.0032044261 -0.0041145234 3.0481288 0 4.2345315 1.039925 0.30957174 0.30957174 3.0283293e-05 2.7144466e-05 +-0.026636728 0.00087504028 -0.0027982906 0.00058572669 -24.504903 0 4.7959196 4.8819744 0.30957174 0.30957174 8.4863466e-05 8.234564e-06 +-7.1098925e-06 8.6789794e-05 -0.0031454967 0.0040877676 20.592087 0 3.5248857 4.1756794 0.30957174 0.30957174 6.862164e-08 2.6549535e-05 +0.017833988 0.0050516577 -0.0022497524 0.0018034155 -3.9132651 0 3.1461666 4.4149282 0.30957174 0.30957174 0.00026737911 8.3286545e-06 +0.03075434 4.299098e-05 0.0031363804 -0.0010941387 2.2174577 0 1.9578298 1.6119601 0.30957174 0.30957174 0.00010384715 1.110453e-05 +0.0026990192 -0.0010228089 -0.00024730955 -0.0037083195 12.570461 0 0.65626514 0.30716719 0.30957174 0.30957174 1.0329359e-05 1.37021e-05 +0.0096467156 0.0010412076 -0.0028971666 -0.0023055198 12.448586 0 2.7220292 5.7549023 0.30957174 0.30957174 2.0091347e-05 1.3734439e-05 +-0.0050546603 -0.00011962211 -3.54559e-05 0.001237095 -11.84169 0 5.2990196 3.5447791 0.30957174 0.30957174 2.9351074e-06 1.5192969e-06 +0.005973405 -0.0014657192 -0.0028270396 -0.0006310847 19.426846 0 0.79497838 5.3045999 0.30957174 0.30957174 2.3486987e-05 8.4523506e-06 +0.013573359 0.0010790106 -0.010729016 -0.0061498011 -17.565401 0 2.5718458 5.6036692 0.30957174 0.30957174 3.0830599e-05 0.0001535644 +0.0087547438 -0.00092409183 0.011425365 0.0025703505 -7.2728015 0 1.179311 2.1646492 0.30957174 0.30957174 1.619283e-05 0.00013815638 +0.0027039674 -0.0015902752 -0.0047677341 -0.0033494915 2.6542342 0 0.55883216 5.6952997 0.30957174 0.30957174 2.3840017e-05 3.4044966e-05 +0.0072525544 0.0019803473 -0.0038638067 0.0080995486 20.090072 0 3.1336358 3.9641672 0.30957174 0.30957174 4.1499148e-05 8.0122934e-05 +-0.0026134928 -0.00063192924 -0.0038745696 0.0057744477 21.834888 0 6.231303 4.1106415 0.30957174 0.30957174 4.3875037e-06 4.8209296e-05 +0.010096395 5.0704293e-06 -0.0029897302 -0.00039427937 18.886252 0 1.9496713 5.2167622 0.30957174 0.30957174 1.1190593e-05 9.1655502e-06 +-0.018103299 -0.0031654646 -0.011852963 0.0011583272 -4.3866576 0 6.0968647 4.9900566 0.30957174 0.30957174 0.00012725462 0.00014296886 +-0.029483946 0.00056341486 0.011030756 0.0086410789 15.446945 0 4.9143432 2.6056725 0.30957174 0.30957174 9.8321126e-05 0.00019673395 +-0.010511025 8.4743143e-05 -0.0069642357 0.0063453921 -12.958983 0 5.0133783 4.3517938 0.30957174 0.30957174 1.2193762e-05 8.8834376e-05 +0.045149009 0.001612561 0.0093461304 0.0084838831 20.44706 0 2.259649 2.6781343 0.30957174 0.30957174 0.00024746064 0.0001594565 +-0.013779681 0.0011134235 -0.0065145473 0.0018665134 -19.563904 0 4.4521733 4.809792 0.30957174 0.30957174 3.2137415e-05 4.6240985e-05 +-0.0052031672 -0.00045299794 -0.0034329621 -0.00030009612 2.6937193 0 5.7571965 5.1731822 0.30957174 0.30957174 4.841296e-06 1.1970629e-05 +0.0082234826 0.0010455748 -0.00011953263 0.002735423 -3.6110827 0 2.8036708 3.5599187 0.30957174 0.30957174 1.7382355e-05 7.4364409e-06 +-0.0036015131 -0.00051950932 -0.0086750624 0.0035708554 -12.923703 0 6.0069612 4.6990528 0.30957174 0.30957174 3.8824351e-06 8.8518089e-05 +-0.00044382777 8.4947233e-05 0.0027275464 0.0069134876 11.568894 0 4.0366421 3.1373351 0.30957174 0.30957174 8.7357769e-08 5.4909991e-05 +-0.020648534 0.0023167151 -0.0010206039 0.0040970565 16.456681 0 4.2903868 3.7619417 0.30957174 0.30957174 9.5696299e-05 1.7700267e-05 +0.0025017944 0.00022872235 -0.00061627198 -0.0083411256 -24.429703 0 2.6395256 0.29995173 0.30957174 0.30957174 1.1636386e-06 6.9394694e-05 +-0.0034325137 -0.0002173174 -0.0034697233 -0.00034594475 0.17203139 0 5.609821 5.1852664 0.30957174 0.30957174 1.7236163e-06 1.2255829e-05 +-0.0050760437 0.0013838715 0.010874863 0.00025376799 11.390521 0 3.8986922 1.9682391 0.30957174 0.30957174 2.0273908e-05 0.00011929057 +0.028483382 0.0011815882 -0.0013083276 -0.0048024977 -9.7416164 0 2.3063969 0.10626203 0.30957174 0.30957174 0.00010178047 2.4603166e-05 +0.00095193054 -7.8821304e-05 0.0047974797 -0.0087328873 12.712654 0 1.2988681 0.88008385 0.30957174 0.30957174 1.5607153e-07 9.8850096e-05 +0.0073218216 0.002125703 -0.0022444722 0.0015792638 -11.622401 0 3.1543911 4.477351 0.30957174 0.30957174 4.7046794e-05 7.5526285e-06 +0.0086478708 -0.00018611341 -0.0063444993 -0.00027799826 6.1673539 0 1.7515062 5.1301248 0.30957174 0.30957174 8.5252784e-06 4.065746e-05 +0.036552095 -0.0015407497 0.00038449594 0.0026434749 0.52174705 0 1.5784765 3.3702939 0.30957174 0.30957174 0.00016829301 7.0804982e-06 +-0.009905176 0.0011974998 0.0020612834 0.0046963638 -13.330746 0 4.2531244 3.0993032 0.30957174 0.30957174 2.3833395e-05 2.6161018e-05 +-0.011066672 0.000638599 0.003957333 -0.0029137387 9.3256549 0 4.6027298 1.3143004 0.30957174 0.30957174 1.7159407e-05 2.4209371e-05 +-0.012064219 0.0012421543 -0.011989748 0.004507845 -10.746587 0 4.3333154 4.7297303 0.30957174 0.30957174 3.0032823e-05 0.00016508226 +0.001705221 0.0030585777 0.0038681301 0.0030571613 11.076873 0 3.4547662 2.6099774 0.30957174 0.30957174 8.5536494e-05 2.4355063e-05 +0.0082287486 0.0028582756 -0.004120409 -0.0029241165 -0.11400505 0 3.2097869 5.7000468 0.30957174 0.30957174 8.185449e-05 2.5597488e-05 +0.0032002972 -0.00076317396 -0.0021065228 0.0061913799 -16.16651 0 0.80571906 3.8463255 0.30957174 0.30957174 6.4299405e-06 4.249684e-05 +-0.0069230313 1.5015614e-05 -0.0061770083 -0.0046792366 23.299504 0 5.0669342 5.7310854 0.30957174 0.30957174 5.2634855e-06 6.0184679e-05 +0.01274272 0.0028308307 -0.0012630677 0.0069418928 -23.977469 0 3.0569355 3.697308 0.30957174 0.30957174 9.0824172e-05 4.9408563e-05 +-0.0050049067 -0.0021714881 0.0072640177 -0.0068300251 -8.077359 0 0.126484 1.194532 0.30957174 0.30957174 4.5703809e-05 9.9468133e-05 +-0.00078058279 0.004049128 0.0040350959 0.010278693 20.012333 0 3.5370524 3.1390392 0.30957174 0.30957174 0.00014941911 0.00012121196 +-0.012490052 -0.0015706184 -0.0095803402 -0.0027722301 -6.3631316 0 5.9398001 5.3662019 0.30957174 0.30957174 3.9596761e-05 0.00010015423 +-0.013836674 0.0001227075 -0.00032026887 0.0054464485 10.766195 0 5.0060798 3.5751062 0.30957174 0.30957174 2.1154355e-05 2.9527352e-05 +-0.0030772173 -0.00079770168 -0.0069295491 0.001357879 4.1400835 0 6.2569063 4.8947126 0.30957174 0.30957174 6.8360587e-06 5.0239015e-05 +0.013101749 -0.0013815893 0.0025068989 -0.0098009884 5.5140133 0 1.1797965 0.62666774 0.30957174 0.30957174 3.623174e-05 0.00010161842 +0.0021418189 -0.0020801868 0.0042868782 0.0041587216 -18.410781 0 0.48685207 2.7112646 0.30957174 0.30957174 3.9921475e-05 3.5682253e-05 +-0.014460043 -0.00051308376 -0.009491176 -0.0045249817 19.678922 0 5.3993165 5.5284242 0.30957174 0.30957174 2.5351672e-05 0.00011112665 +0.0026588088 -0.0014520157 0.00035759982 -7.5185935e-05 -21.458125 0 0.57267101 1.7394921 0.30957174 0.30957174 1.9981794e-05 1.3452728e-07 +0.025379279 -0.001345557 -0.0077496822 -0.0067885269 -22.349362 0 1.4951734 5.8020493 0.30957174 0.30957174 8.720096e-05 0.00010625862 +-0.0055294648 -0.0017852216 0.0050553872 -0.012745054 14.263364 0 0.046545358 0.75471032 0.30957174 0.30957174 3.2388162e-05 0.00018688824 +-0.0050781246 1.3506838e-06 -0.0019091307 0.0028481947 -2.769715 0 5.0842663 4.1101639 0.30957174 0.30957174 2.8308744e-06 1.172111e-05 +0.00099020928 -0.00096748179 0.00074029546 0.0079054492 -4.3079711 0 0.48618684 3.4217649 0.30957174 0.30957174 8.6342059e-06 6.2543297e-05 +0.022790382 0.00035022636 -0.00066064295 -0.0018475959 -22.237405 0 2.0841792 0.028316471 0.30957174 0.30957174 5.8135678e-05 3.8260156e-06 +-0.013934218 0.0018206363 0.0049969927 -0.0066346308 7.761239 0 4.2146564 1.0237318 0.30957174 0.30957174 5.1509569e-05 6.8835885e-05 +-0.0058883343 0.0019793098 0.0032004767 0.0032010718 -15.297023 0 3.8315535 2.7265284 0.30957174 0.30957174 3.9493746e-05 2.0490556e-05 +-0.0085309004 0.0014741203 -0.0032859227 -0.0096613694 20.275738 0 4.0818589 0.043980754 0.30957174 0.30957174 2.7784115e-05 0.00010347261 +0.017540695 0.0010727824 0.0074338768 0.0051951419 4.2406477 0 2.4533944 2.5512416 0.30957174 0.30957174 4.4259379e-05 8.2484278e-05 +-0.0046925985 0.0011284276 -0.00050498425 0.0021530653 -7.7952698 0 3.944148 3.7480823 0.30957174 0.30957174 1.4016757e-05 4.8552945e-06 +9.9184416e-05 -0.00035243 0.0022080093 -0.0017020822 6.4331203 0 0.405185 1.2922952 0.30957174 0.30957174 1.1325275e-06 7.7887058e-06 +0.011257575 0.00022966777 0.003571046 0.0015679428 -12.43604 0 2.1288424 2.3558446 0.30957174 0.30957174 1.4392862e-05 1.529489e-05 +0.011418027 -0.0021549129 0.0054588009 -0.0024336082 -9.5539263 0 0.9011288 1.5287406 0.30957174 0.30957174 5.6612527e-05 3.5915979e-05 +0.0091369273 0.00019965582 0.0051989583 -0.0014167392 -5.8379308 0 2.1415822 1.6811042 0.30957174 0.30957174 9.5276833e-06 2.9240424e-05 +0.015170435 -0.00047710491 -0.0057871414 -0.0047381621 15.711812 0 1.6660829 5.7687765 0.30957174 0.30957174 2.7337867e-05 5.6032669e-05 +0.018389635 -0.00070404803 0.0018172442 -0.0036599746 6.4627354 0 1.6095332 0.83840038 0.30957174 0.30957174 4.163961e-05 1.6616397e-05 +-0.0057709479 -0.00029768153 -0.0015655999 -0.0017782401 1.6106538 0 5.5259576 5.9315648 0.30957174 0.30957174 4.4632165e-06 5.607653e-06 +-0.0049178247 0.00024764192 0.0033721026 0.0079157826 2.2300826 0 4.6566144 3.1102422 0.30957174 0.30957174 3.2136029e-06 7.3616728e-05 +0.0075604245 -0.00074635387 0.0032564815 0.0075490993 19.76457 0 1.2126882 3.1056753 0.30957174 0.30957174 1.134918e-05 6.7219215e-05 +-0.0061468953 -0.0002170131 0.00047943518 -0.0016363444 -13.416394 0 5.3978447 0.66151318 0.30957174 0.30957174 4.5768525e-06 2.8877038e-06 +0.025979926 -0.00041155639 0.00066760529 -0.0047679932 -19.200241 0 1.8017813 0.51453322 0.30957174 0.30957174 7.5637638e-05 2.2999267e-05 +-0.014450573 0.002728072 -0.00036729829 0.0026100698 -24.514415 0 4.0425893 3.6568231 0.30957174 0.30957174 9.0718944e-05 6.8933875e-06 +0.0010014315 -0.0032288667 -0.0028431976 -0.001676254 14.437681 0 0.40833441 5.6158568 0.30957174 0.30957174 9.508063e-05 1.0936777e-05 +0.026569479 0.0020789408 0.0059332015 -0.0028554856 -23.046017 0 2.5643399 1.4997075 0.30957174 0.30957174 0.00011686635 4.3577713e-05 +-0.00063264105 -0.0009518125 -0.0058771307 0.0034156389 -6.1788948 0 0.30146389 4.563747 0.30957174 0.30957174 8.2965494e-06 4.6394488e-05 +-0.016547052 -0.001899653 0.011217532 0.0030440366 24.904248 0 5.8944637 2.2080347 0.30957174 0.30957174 6.2930324e-05 0.00013605001 +0.0043943452 0.0013227064 -0.0018088711 -0.0058222628 -15.233509 0 3.1661782 0.070764681 0.30957174 0.30957174 1.8057154e-05 3.692333e-05 +0.00071578714 -0.00012242219 -0.0074752671 0.0094641563 5.4988424 0 0.94492639 4.188367 0.30957174 0.30957174 1.9276836e-07 0.00014518114 +0.0012069607 0.00044499023 0.0054970605 0.011297287 13.465781 0 3.2265002 3.0598348 0.30957174 0.30957174 1.9637232e-06 0.00015706071 +0.0076283383 -0.002235705 -0.0062747869 0.0069393338 22.732298 0 0.7326892 4.2550832 0.30957174 0.30957174 5.1920191e-05 8.7458895e-05 +0.012658203 0.0025579818 0.0012570319 0.011511981 -17.131866 0 3.0182601 3.4062509 0.30957174 0.30957174 7.71947e-05 0.00013304714 +-0.0035378036 0.0013141796 0.0073404942 -0.00041874625 -14.102493 0 3.8032367 1.8885721 0.30957174 0.30957174 1.7106489e-05 5.4496027e-05 +-0.0085851494 0.0019669351 0.00024048667 0.0075038563 11.238133 0 3.9627197 3.4835945 0.30957174 0.30957174 4.3333756e-05 5.5910866e-05 +0.010933066 0.00074491545 0.0015901648 0.00047722788 -12.401869 0 2.5005688 2.2344287 0.30957174 0.30957174 1.8176641e-05 2.7751419e-06 +-0.014563427 -0.0013843486 -0.00065110865 0.0051771132 -4.1933339 0 5.8003452 3.6420119 0.30957174 0.30957174 4.0740377e-05 2.7013178e-05 +-0.0097880127 0.0033101341 -0.00077489715 -0.0073747235 19.766384 0 3.8297709 0.26876257 0.30957174 0.30957174 0.00011032853 5.4552144e-05 +-0.0028551226 1.8501129e-05 -0.0080069078 -0.0011921261 -3.6881286 0 5.0277291 5.2333127 0.30957174 0.30957174 8.9798994e-07 6.6042861e-05 +0.0084820599 -0.0012957074 0.0045427345 0.0060672742 -10.798228 0 0.99742088 2.8693072 0.30957174 0.30957174 2.3191291e-05 5.7318821e-05 +-0.025386701 0.00049028152 0.0039915369 -0.0050824105 19.636881 0 4.9125461 1.0439997 0.30957174 0.30957174 7.2939258e-05 4.1684275e-05 +0.0086802976 0.00053170168 -0.005673922 -0.0045041379 12.494769 0 2.4540492 5.7537077 0.30957174 0.30957174 1.0846711e-05 5.2579042e-05 +-0.0035774127 -0.00089281527 -0.00096087216 0.0049359931 -16.969709 0 6.2430923 3.7096833 0.30957174 0.30957174 8.6661712e-06 2.5097825e-05 +0.0018558905 -0.00036893321 0.0021550188 0.0061274721 -18.70076 0 0.87885 3.1751572 0.30957174 0.30957174 1.618001e-06 4.1924287e-05 +0.0070427799 0.0013487755 0.0015555476 -0.0037973785 -13.914761 0 2.9954029 0.765943 0.30957174 0.30957174 2.2016757e-05 1.6742938e-05 +-0.0022413579 0.0013480177 -0.0029248313 -0.00049558109 -22.835638 0 3.6964324 5.2532022 0.30957174 0.30957174 1.7104606e-05 8.8679883e-06 +-0.013294272 -0.0031832699 0.011105932 0.0012871588 15.051479 0 6.2276178 2.0595553 0.30957174 0.30957174 0.00011170893 0.00012599056 +-0.0058827221 0.0018535632 0.0044285514 0.0014852455 21.187624 0 3.8511446 2.266248 0.30957174 0.30957174 3.5096044e-05 2.1960058e-05 +-0.010335859 -0.0018219777 -0.014223643 0.0012827058 20.448493 0 6.1005047 4.9974746 0.30957174 0.30957174 4.1966985e-05 0.00020559325 +-0.019377616 0.0034336704 0.0027552231 -0.0018203802 23.525338 0 4.0705395 1.3649631 0.30957174 0.30957174 0.00014862078 1.0940126e-05 +0.010195217 -0.0003778014 0.0074759156 0.0027450009 -22.243579 0 1.6195435 2.2943744 0.30957174 0.30957174 1.2710706e-05 6.3819015e-05 +0.013457655 0.00086337546 -0.015091667 0.0017940426 4.8273825 0 2.4739753 4.9693161 0.30957174 0.30957174 2.6671831e-05 0.00023280763 +-0.020010125 0.0049519796 0.0033472036 0.00010612248 -13.2109 0 3.933404 1.9765347 0.30957174 0.30957174 0.00026733633 1.1306274e-05 +0.0048662408 0.00039795593 -0.0021302733 -0.0033467124 -13.13398 0 2.5853611 6.086956 0.30957174 0.30957174 4.0421942e-06 1.5684976e-05 +0.0032653925 1.7164269e-05 -0.0049273851 0.002087069 -20.62922 0 1.9929427 4.688942 0.30957174 0.30957174 1.1732126e-06 2.8797678e-05 +0.0077025718 -0.0010264468 6.6233555e-05 0.00052405354 9.4695248 0 1.0633733 3.3891586 0.30957174 0.30957174 1.6110602e-05 2.7683412e-07 +-0.0059932814 0.0015393609 0.0048140082 0.00065643327 3.9056746 0 3.9197955 2.0795371 0.30957174 0.30957174 2.5528995e-05 2.379101e-05 +-0.011453789 -0.0032762648 0.00049571937 -0.0039840471 -22.838381 0 0.0078550093 0.49908884 0.30957174 0.30957174 0.0001121808 1.5992028e-05 +-0.0012182408 -0.00025881959 0.0013504848 -0.0035327429 8.8156629 0 6.1805591 0.74215114 0.30957174 0.30957174 7.731363e-07 1.4218035e-05 +-0.0082618221 -0.0015070802 0.00079469813 0.0001774728 21.704013 0 6.115745 2.1630918 0.30957174 0.30957174 2.8183168e-05 6.6793526e-07 +0.0056095248 0.002240611 -0.003903946 0.001330327 18.283151 0 3.2476808 4.7607362 0.30957174 0.30957174 4.9186475e-05 1.7120494e-05 +-0.0033159775 0.0033357582 -0.0065488339 -0.00059314351 23.260396 0 3.6245888 5.1762887 0.30957174 0.30957174 0.00010256968 4.3585807e-05 +-0.00088779187 -0.0020514516 -0.0054045302 -0.00072292781 -9.800178 0 0.32682857 5.2186005 0.30957174 0.30957174 3.8422915e-05 2.996545e-05 +0.012392932 -0.0017929147 0.001220568 -0.0046275962 7.3169923 0 1.0234079 0.63419483 0.30957174 0.30957174 4.6142558e-05 2.2743422e-05 +-0.0093957199 0.0005116993 -0.0050378179 -0.0016991663 2.3713255 0 4.6261627 5.4095389 0.30957174 0.30957174 1.2076228e-05 2.8450319e-05 +0.0081804408 0.00061798576 -0.0035676259 0.000517598 -2.3042054 0 2.547833 4.9437617 0.30957174 0.30957174 1.0825163e-05 1.3097451e-05 +0.0097410769 0.0026189677 0.00039957578 0.0032027285 22.965215 0 3.1282448 3.3907719 0.30957174 0.30957174 7.2897725e-05 1.0335491e-05 +0.013834204 0.00078776486 0.010003345 0.0084230598 -4.1683747 0 2.423606 2.6409448 0.30957174 0.30957174 2.666273e-05 0.00017125689 +0.0073932123 0.0020186136 0.0001474246 -0.0031019761 13.391476 0 3.1336116 0.4221771 0.30957174 0.30957174 4.3119261e-05 9.5663626e-06 +0.020318644 -0.00022295062 0.00080431116 0.0053648943 4.9689257 0 1.8454729 3.365885 0.30957174 0.30957174 4.5773934e-05 2.9201553e-05 +-0.00082804524 -0.00088751573 0.0023758694 0.00019743869 -15.479016 0 0.27223509 2.0273404 0.30957174 0.30957174 7.2505815e-06 5.7294369e-06 +0.026355009 0.00065577685 -0.0053723941 -0.010640353 -9.1861413 0 2.1679938 6.1866453 0.30957174 0.30957174 8.0167044e-05 0.00014139956 +0.0039352618 0.0040704722 0.00026567382 -0.0028623793 -9.6042622 0 3.4101582 0.46760094 0.30957174 0.30957174 0.00015263097 8.1981239e-06 +-0.014551558 -0.00056553015 -0.0015851558 0.0033530367 15.491706 0 5.426946 3.9606508 0.30957174 0.30957174 2.6158442e-05 1.3685149e-05 +0.01598731 -0.00031423548 -0.0013052638 0.0007851029 -21.358526 0 1.7679263 4.5487541 0.30957174 0.30957174 2.8957846e-05 2.3290045e-06 +0.014724751 -0.00229823 0.0015442538 0.0034935996 -21.594763 0 0.98726486 3.0966816 0.30957174 0.30957174 7.1916121e-05 1.4510708e-05 +0.0048825909 -0.00077411651 0.0029473526 -0.00060776208 4.2351066 0 0.97990549 1.7433407 0.30957174 0.30957174 8.075902e-06 9.1240888e-06 +0.01435394 -0.0020269573 -8.3156273e-05 0.0067913622 -14.402257 0 1.0351006 3.5282365 0.30957174 0.30957174 6.0044354e-05 4.5756631e-05 +0.0024751112 -0.0015704354 -0.0095293512 0.0051900978 3.9972195 0 0.54562013 4.5913706 0.30957174 0.30957174 2.3138672e-05 0.00011826809 +0.021958353 0.0053680968 0.0024893999 -0.0039300861 -8.8174992 0 3.0938327 0.94260879 0.30957174 0.30957174 0.00031543111 2.1568315e-05 +-0.010923068 -0.0012466691 -0.0048143802 0.0043269186 -1.0517096 0 5.8915338 4.3586004 0.30957174 0.30957174 2.7255514e-05 4.193804e-05 +-0.023883842 -0.00075359171 -0.00014712087 -0.0004592308 -15.1073 0 5.3665674 0.0619008 0.30957174 0.30957174 6.7794179e-05 2.3100867e-07 +0.012210397 0.00045188354 0.010662736 0.0029894737 10.129175 0 2.2702519 2.2163421 0.30957174 0.30957174 1.8227192e-05 0.00012348543 +0.0061453173 -0.00087318279 -0.00603246 0.0022616396 7.4761825 0 1.0321045 4.7306566 0.30957174 0.30957174 1.1091148e-05 4.1760876e-05 +0.016027883 0.0030594642 0.0035990799 -0.00024096574 -0.6506144 0 2.9939847 1.8787833 0.30957174 0.30957174 0.00011346764 1.3116565e-05 +-0.022579186 0.000786885 -0.00030832545 -0.00023279619 17.197452 0 4.7792903 5.7295045 0.30957174 0.30957174 6.1606885e-05 1.4959539e-07 +0.00025108739 0.001450807 0.0066058886 0.0010159207 0.93272394 0 3.4968964 2.0964762 0.30957174 0.30957174 1.918071e-05 4.501724e-05 +0.025758203 0.0015156898 -0.0053873174 0.0025525899 20.680973 0 2.4371456 4.6473419 0.30957174 0.30957174 9.3762506e-05 3.572281e-05 +-0.007733249 -0.0017652096 0.0048328017 -0.0064887827 2.8775825 0 6.2092144 1.0183545 0.30957174 0.30957174 3.4949508e-05 6.5310216e-05 +-0.0032569132 0.00090690887 0.0034465582 -0.0030467734 11.425011 0 3.8914186 1.225216 0.30957174 0.30957174 8.6567715e-06 2.1183365e-05 +-0.0082169783 -0.0023265433 -0.004106569 0.0036609104 -22.759811 0 0.004429271 4.362634 0.30957174 0.30957174 5.6719272e-05 3.0295276e-05 +0.021710425 0.00059843075 0.00024628324 0.0048530493 17.5451 0 2.1911035 3.4647757 0.30957174 0.30957174 5.5004815e-05 2.3422798e-05 +-0.0061342207 -0.00081724364 -0.0021285725 -0.0056132485 -1.3599174 0 5.9682899 0.0091482351 0.30957174 0.30957174 1.0214797e-05 3.582154e-05 +-0.0089663347 -0.00020492511 0.0033877865 0.00061983364 -2.1718924 0 5.2919514 2.1246245 0.30957174 0.30957174 9.2080807e-06 1.1951743e-05 +0.038419849 0.0017765608 0.0033373133 -6.7333073e-06 -21.038398 0 2.3437646 1.9430953 0.30957174 0.30957174 0.00019079088 1.1228497e-05 +0.013614736 -5.6521928e-05 0.0022031687 0.0037767353 19.191045 0 1.9072968 2.9842634 0.30957174 0.30957174 2.037748e-05 1.9041916e-05 +0.0013331653 0.00012195691 0.0052985308 0.009032929 -18.63801 0 2.6398262 2.9818497 0.30957174 0.30957174 3.305981e-07 0.00010923733 +-0.0077816852 -0.0017650433 0.0033062384 -0.007264086 23.811926 0 6.2067339 0.80449675 0.30957174 0.30957174 3.5026656e-05 6.3360601e-05 +0.0098631282 -0.0011045588 -0.00058714272 -0.010798893 -9.5770958 0 1.1497256 0.31954121 0.30957174 0.30957174 2.1793146e-05 0.0001160207 +0.013169749 0.0009561132 0.0086336151 0.0059186859 -2.768428 0 2.5293979 2.5422709 0.30957174 0.30957174 2.7367333e-05 0.00010989453 +-0.0094283636 -0.00080078417 0.001109851 -0.0063498887 -20.681884 0 5.7451813 0.54871734 0.30957174 0.30957174 1.5599957e-05 4.1236866e-05 +0.0068048861 -0.00076643532 -0.0042857408 -0.0035339673 24.283037 0 1.1468706 5.7722618 0.30957174 0.30957174 1.0434444e-05 3.0905244e-05 +-0.00092672454 0.0005273891 -0.0044746019 -0.0052902752 -10.90047 0 3.7064517 5.9514195 0.30957174 0.30957174 2.6279538e-06 4.794599e-05 +0.017455217 -0.0006371127 -0.010293965 -0.013169593 23.375122 0 1.6241045 5.9900934 0.30957174 0.30957174 3.7144971e-05 0.00027886532 +-0.0010719694 -0.00070804363 0.010194669 -0.0062937656 -18.258532 0 0.20960468 1.3956336 0.30957174 0.30957174 4.6929122e-06 0.0001440697 diff --git a/examples/Diagnostics/Tunes/outputs/test_tune_4d_uncoupled/bunch.dat b/examples/Diagnostics/Tunes/outputs/test_tune_4d_uncoupled/bunch.dat new file mode 100644 index 00000000..c1a734c5 --- /dev/null +++ b/examples/Diagnostics/Tunes/outputs/test_tune_4d_uncoupled/bunch.dat @@ -0,0 +1,1015 @@ +% PARTICLE_ATTRIBUTES_CONTROLLERS_NAMES ParticlePhaseAttributes +% PARTICLE_ATTRIBUTES_CONTROLLER_DICT ParticlePhaseAttributes size 6 xAction 0 xLastPhase 0 xLastTune 0 yAction 0 yLastPhase 0 yLastTune 0 +% BUNCH_ATTRIBUTE_DOUBLE charge 1 +% BUNCH_ATTRIBUTE_DOUBLE classical_radius 1.5347e-18 +% BUNCH_ATTRIBUTE_DOUBLE macro_size 0 +% BUNCH_ATTRIBUTE_DOUBLE mass 0.938272 +% SYNC_PART_COORDS 0 0 0 x, y, z positions in [m] +% SYNC_PART_MOMENTUM 0 0 1.6960377525279 px, py, pz momentum component in GeV/c +% SYNC_PART_X_AXIS 1 0 0 nxx, nxy, pxz - x-axis ort coordinates +% info only: energy of the synchronous particle [GeV] = 1 +% info only: momentum of the synchronous particle [GeV/c] = 1.6960377525279 +% info only: beta=v/c of the synchronous particle = 0.8750256554045 +% info only: gamma=1/sqrt(1-(v/c)**2) of the synchronous particle = 2.0657889919897 +% SYNC_PART_TIME 1.9060246584653e-07 time in [sec] +% x[m] px[rad] y[m] py[rad] z[m] (pz or dE [GeV]) PhaseVars +-0.0065531414 -0.0024538659 -0.0039554139 -0.0024547054 -15.578108 0 0.089127141 5.6384829 0.30957174 0.30957174 5.9565954e-05 2.1749693e-05 +0.0067244185 0.0015019813 0.0001870957 0.0030399609 11.339613 0 3.0590884 3.4539252 0.30957174 0.30957174 2.5514154e-05 9.201928e-06 +-0.020130179 -0.0021668843 -0.0045131537 -0.00091774902 10.998651 0 5.8622753 5.2857242 0.30957174 0.30957174 8.7256338e-05 2.1370049e-05 +-0.02147704 0.00053907159 0.0044073995 0.0046012529 -12.389897 0 4.8619087 2.7479537 0.30957174 0.30957174 5.328326e-05 4.0583858e-05 +-0.0056441714 -0.0031942063 0.0014449309 0.0043188522 0.82244228 0 0.18270342 3.1905848 0.30957174 0.30957174 9.643968e-05 2.0606507e-05 +-0.0045869272 -0.0015149463 -0.003128741 -0.0071240879 21.728024 0 0.053407227 6.2406705 0.30957174 0.30957174 2.3216284e-05 6.0211068e-05 +0.0004646444 -0.00041465876 0.0013024706 -0.0032995213 -0.15138849 0 0.49669562 0.75304955 0.30957174 0.30957174 1.5899836e-06 1.250907e-05 +-0.0026087612 0.0011855278 -0.0019262376 -4.5620885e-05 11.763354 0 3.7529171 5.1101774 0.30957174 0.30957174 1.3550114e-05 3.742702e-06 +0.011703034 0.0010136363 0.0046197826 -0.0048363974 -20.392113 0 2.6130889 1.140851 0.30957174 0.30957174 2.4394673e-05 4.4717976e-05 +-0.031011777 0.00091308606 -0.0021205755 -0.0026887306 -1.0612575 0 4.8246473 5.9857277 0.30957174 0.30957174 0.00011317059 1.1704315e-05 +-0.025561411 0.00093028768 -0.0076093943 -0.00035563125 -2.1948909 0 4.7665638 5.133014 0.30957174 0.30957174 7.9610296e-05 5.8500344e-05 +-0.00096168216 0.0010037899 -0.0022658996 0.0054457754 17.835121 0 3.6206797 3.9130752 0.30957174 0.30957174 9.2800793e-06 3.4592826e-05 +0.031754674 0.0002561193 -0.0063042394 -0.0032101638 0.98805445 0 2.0184371 5.5544004 0.30957174 0.30957174 0.00011129221 5.0289239e-05 +-0.036882645 0.00073076145 0.0061171183 -0.0018738756 10.010427 0 4.9081261 1.6501059 0.30957174 0.30957174 0.0001541974 4.1207187e-05 +0.030752874 0.00045081675 -0.0060041739 0.0079291025 10.954454 0 2.0778487 4.1679183 0.30957174 0.30957174 0.00010567176 9.8706278e-05 +-0.01307366 0.0031049299 0.0029834187 0.00026619131 -6.7260973 0 3.9488694 2.0333687 0.30957174 0.30957174 0.00010658291 9.0436294e-06 +-0.0022960788 -0.00017468141 -0.0010802472 -0.010458711 3.8422701 0 5.6927183 0.27054537 0.30957174 0.30957174 8.5670172e-07 0.0001096766 +0.015535593 0.00013911156 0.0055819355 -0.0078061018 19.674894 0 2.0264852 0.99891744 0.30957174 0.30957174 2.6671471e-05 9.1854508e-05 +-0.0058679284 0.0043459207 0.00062431074 -0.0044971499 14.512262 0 3.6630441 0.51335237 0.30957174 0.30957174 0.00017582894 2.0453767e-05 +0.013932724 -0.00090658437 -0.00016331776 -0.0037608119 -21.13271 0 1.4100358 0.33054801 0.30957174 0.30957174 2.8796951e-05 1.4056232e-05 +-0.034912173 -0.0011370673 0.0053607121 -0.0016367446 -19.491218 0 5.3751035 1.651024 0.30957174 0.30957174 0.00014558048 3.1628765e-05 +0.031320576 0.004865127 -0.001858321 -0.006815964 -9.2108194 0 2.9006716 0.10605962 0.30957174 0.30957174 0.0003233029 4.9563225e-05 +0.0068231751 0.00080941263 -0.0013557678 -0.0038948743 -7.2868164 0 2.7692224 0.036799139 0.30957174 0.30957174 1.1078744e-05 1.6900473e-05 +-0.023319076 0.0027052731 0.0050568577 -0.00037462181 23.839278 0 4.2736874 1.8717455 0.30957174 0.30957174 0.00012636146 2.5919472e-05 +0.014222602 -0.00065967296 -0.0023834893 -0.0056231423 -1.8157145 0 1.5453358 6.2536458 0.30957174 0.30957174 2.6170069e-05 3.7091388e-05 +0.0086870504 -0.00094254511 0.0058864052 -0.0092961787 -19.666632 0 1.1655486 0.94245535 0.30957174 0.30957174 1.6376995e-05 0.00012065239 +0.00055711184 -0.0017053234 -0.0025458902 -0.00715952 1.5802735 0 0.41014794 0.030078698 0.30957174 0.30957174 2.6525304e-05 5.7378649e-05 +0.0074322187 0.0016282848 0.0015936596 0.0017753118 -22.600759 0 3.0513887 2.7803242 0.30957174 0.30957174 3.0215643e-05 5.686702e-06 +-0.028081993 -0.00013466427 -0.00015393525 0.0015887185 -5.6512704 0 5.1303446 3.6132666 0.30957174 0.30957174 8.6735146e-05 2.5275068e-06 +-0.018980004 0.001505113 -0.0070696351 -0.0040479532 21.403056 0 4.4611052 5.6032116 0.30957174 0.30957174 6.018219e-05 6.6640595e-05 +-0.017785205 -0.002004791 0.0023713914 0.0074390016 -8.3107904 0 5.8853245 3.2049416 0.30957174 0.30957174 7.1336236e-05 6.0560622e-05 +-0.0056875204 0.0016557158 -0.0036868103 -0.00023226966 10.137631 0 3.8764973 5.1490989 0.30957174 0.30957174 2.8523451e-05 1.3756887e-05 +0.0071094851 -0.002461612 -0.007578791 0.011159853 -17.669394 0 0.68132636 4.1162411 0.30957174 0.30957174 6.074723e-05 0.00018144158 +-0.0011128757 0.00051022412 -0.004369446 8.6842962e-05 24.509149 0 3.7509085 5.0669775 0.30957174 0.30957174 2.5073898e-06 1.9255174e-05 +0.038045244 0.0017533594 0.00073972152 -0.002538738 -16.887285 0 2.3425684 0.66001231 0.30957174 0.30957174 0.00018690035 6.9447242e-06 +0.0016816339 0.0014499955 -0.006809468 0.0074207987 -1.6102069 0 3.3892602 4.2624034 0.30957174 0.30957174 1.9462783e-05 0.00010136982 +-0.0093545698 -1.506727e-05 0.0039976694 0.0069525202 12.072819 0 5.1013605 2.9905464 0.30957174 0.30957174 9.6084307e-06 6.4058323e-05 +-0.015576416 0.00029714147 0.0072713264 0.011790707 6.6672328 0 4.9146336 2.9596507 0.30957174 0.30957174 2.7438911e-05 0.00019119985 +-0.011594328 -0.00052445256 0.00025985938 0.0041820982 -16.693002 0 5.4775397 3.453332 0.30957174 0.30957174 1.7262688e-05 1.7416601e-05 +0.0068907084 0.0021102997 0.0058266913 0.00077695611 -21.783984 0 3.1717084 2.0765994 0.30957174 0.30957174 4.5779792e-05 3.4825867e-05 +-0.0069557323 -0.0022910858 0.0039337986 -0.0056646673 -12.399361 0 0.052595243 0.98509719 0.30957174 0.30957174 5.3127049e-05 4.7429911e-05 +0.0007079716 -0.0022917308 0.0073706264 0.0054041269 -10.069777 0 0.40820007 2.5738906 0.30957174 0.30957174 4.7897745e-05 8.3737431e-05 +0.028644041 -0.0018141606 0.0055198027 0.0013829772 -4.3901508 0 1.4218061 2.1886841 0.30957174 0.30957174 0.00012005053 3.2613753e-05 +0.0044039159 0.0014881764 0.0042203877 0.0021451289 16.963621 0 3.2017879 2.4120729 0.30957174 0.30957174 2.2303321e-05 2.2521239e-05 +0.0042003418 -0.0010951778 0.0028730238 -0.0030788409 -4.4689062 0 0.77280208 1.1291827 0.30957174 0.30957174 1.28627e-05 1.7724166e-05 +0.012046832 -0.0017393145 -0.0015065601 0.0080925765 14.291593 0 1.0243842 3.7014179 0.30957174 0.30957174 4.3489337e-05 6.7248479e-05 +-0.0031030391 -0.0022950243 -0.00011010221 -0.00074264806 -15.898762 0 0.22694961 0.2259338 0.30957174 0.30957174 4.9037358e-05 5.5928789e-07 +0.0066578664 -0.00097966736 0.0061824864 -0.00022236048 -23.243868 0 1.0152684 1.9094363 0.30957174 0.30957174 1.3608812e-05 3.858377e-05 +0.019086738 -0.0006524921 0.0036423481 0.0014786035 21.724724 0 1.6432053 2.3278987 0.30957174 0.30957174 4.387043e-05 1.5543438e-05 +0.0049387976 0.00026410442 -0.008723031 0.0019343027 9.5993721 0 2.3983937 4.8701832 0.30957174 0.30957174 3.3130393e-06 8.0422822e-05 +0.0031607406 -0.0013167729 0.0016109654 -0.003477443 -12.292534 0 0.63194885 0.81123222 0.30957174 0.30957174 1.6891368e-05 1.4611195e-05 +-0.011794882 0.000183652 -0.0047598537 -0.0035217929 13.429923 0 4.9457917 5.7198146 0.30957174 0.30957174 1.5579334e-05 3.5143632e-05 +0.014621092 -0.0029696475 -0.005918874 0.00023230545 -10.432857 0 0.86981146 5.047778 0.30957174 0.30957174 0.00010380155 3.5372181e-05 +0.011286783 0.0016250809 0.0058940602 0.012607273 13.54764 0 2.8644767 3.0754483 0.30957174 0.30957174 3.8041497e-05 0.00019268128 +-0.011582495 -0.0010466926 -0.0026842104 0.0012610385 -21.3653 0 5.7754177 4.6506097 0.30957174 0.30957174 2.4706963e-05 8.8410787e-06 +-0.0026006372 0.00064853394 0.002581573 -0.0082410838 -22.475123 0 3.9305744 0.68019789 0.30957174 0.30957174 4.5738262e-06 7.4085153e-05 +0.010381531 -0.0014392665 -0.0033752192 0.011113192 -9.6018191 0 1.0440391 3.8130176 0.30957174 0.30957174 3.070131e-05 0.00013398939 +0.020975984 -0.00082319282 -0.00027904187 0.00016977818 18.389754 0 1.6017619 4.5436907 0.30957174 0.30957174 5.4473924e-05 1.0709066e-07 +-0.010430764 7.3559631e-05 -0.0073391503 -0.00036431797 19.850485 0 5.0225364 5.1358885 0.30957174 0.30957174 1.1993119e-05 5.4433862e-05 +0.010244227 0.0018632949 0.00097537519 5.5432149e-05 -14.830634 0 2.9728716 2.0014091 0.30957174 0.30957174 4.3147012e-05 9.6215989e-07 +0.015505623 -0.00064186126 -0.0046944561 -0.0033655587 -1.7122958 0 1.5844982 5.7048427 0.30957174 0.30957174 3.0145998e-05 3.3452963e-05 +0.041809595 0.0042244472 -0.015733972 2.2943842e-05 11.810633 0 2.6890756 5.0852428 0.30957174 0.30957174 0.00035446034 0.00024957642 +-0.021654569 -6.7552775e-05 0.0055849337 0.0063709602 8.2915818 0 5.1150989 2.7921176 0.30957174 0.30957174 5.1518235e-05 7.1706686e-05 +0.022134535 0.0019956208 -0.0061833373 -0.0016104935 -4.3364492 0 2.6326848 5.3395121 0.30957174 0.30957174 9.0061994e-05 4.111805e-05 +0.018499269 -0.00070324916 -0.0031162043 0.0046862362 10.328685 0 1.6117283 4.1064689 0.30957174 0.30957174 4.2073335e-05 3.1573127e-05 +0.023918145 0.0013948532 0.00025016456 0.001517336 -0.25396261 0 2.4334217 3.3511838 0.30957174 0.30957174 8.0524312e-05 2.3467847e-06 +0.0044261035 0.0013671518 -0.0018968669 0.0033282369 23.654256 0 3.1744165 4.0374096 0.30957174 0.30957174 1.9176947e-05 1.4615027e-05 +0.0079253588 0.001446299 -0.0074431583 0.00052212604 16.308261 0 2.974334 5.01722 0.30957174 0.30957174 2.5950056e-05 5.6122631e-05 +0.0055796391 -0.0020457572 -0.0010331202 -0.0020050737 -16.851762 0 0.66521383 6.1783968 0.30957174 0.30957174 4.1541476e-05 5.063851e-06 +0.00016564096 0.00087936671 0.0030315673 -0.00028433139 18.945998 0 3.4952178 1.8523318 0.30957174 0.30957174 7.0471636e-06 9.345509e-06 +-0.014158573 0.00012133334 -0.0014914195 -0.0058603387 -20.218616 0 5.0087835 0.12314928 0.30957174 0.30957174 2.2140572e-05 3.6308337e-05 +-0.00092799732 0.001996267 0.0002340455 -0.0052605526 15.573462 0 3.5668803 0.41912357 0.30957174 0.30957174 3.6396152e-05 2.7504874e-05 +0.0029295689 -0.00019645597 0.0008118266 0.0017193858 8.8017048 0 1.3967214 3.071621 0.30957174 0.30957174 1.2937231e-06 3.5968185e-06 +-0.00087612484 -0.0016070374 0.0078298682 0.0066328765 8.6875137 0 0.31452334 2.6439177 0.30957174 0.30957174 2.3609861e-05 0.00010544591 +-0.018462703 -0.00051404789 0.00074975316 -0.0038302796 -7.685929 0 5.3350794 0.56913624 0.30957174 0.30957174 3.9826949e-05 1.5119126e-05 +-0.033194976 0.005710137 -0.0049980945 0.0023579794 11.948636 0 4.0839076 4.6489998 0.30957174 0.30957174 0.00041798126 3.0699697e-05 +-0.0030112848 -0.00024264511 0.0037691056 0.0072442276 6.9390765 0 5.719885 3.0328127 0.30957174 0.30957174 1.5317694e-06 6.637646e-05 +-0.0011719289 -0.00078697992 0.003854556 0.0024900366 18.886698 0 0.21225947 2.5149593 0.30957174 0.30957174 5.7925473e-06 2.1128865e-05 +0.034388639 0.002280395 0.0058846119 0.0019411462 24.008331 0 2.4884998 2.2613178 0.30957174 0.30957174 0.0001771905 3.8648523e-05 +0.00075697382 -3.5073931e-05 -0.0057149455 0.0048477741 22.328976 0 1.5457039 4.3872071 0.30957174 0.30957174 7.4109425e-08 5.6237732e-05 +0.0064411086 -0.0014158339 -0.0044662226 -0.0082023711 -18.089897 0 0.83747799 6.1554546 0.30957174 0.30957174 2.2814941e-05 8.6844632e-05 +-0.002471486 -0.0022408433 0.0019765549 0.0023575407 2.6629438 0 0.25381077 2.8141738 0.30957174 0.30957174 4.6412174e-05 9.4516734e-06 +0.017254978 0.0003193331 -0.004250782 0.0017784013 7.1761349 0 2.1121109 4.6933298 0.30957174 0.30957174 3.361329e-05 2.1353581e-05 +-0.0088620786 0.0012062984 -0.0023200407 -0.0028312376 -20.439627 0 4.194571 5.9670171 0.30957174 0.30957174 2.1877057e-05 1.3377557e-05 +-0.0083244818 5.7702594e-05 0.0047380741 0.00070168214 -4.7756439 0 5.0236297 2.0909504 0.30957174 0.30957174 7.6375465e-06 2.3120725e-05 +0.0058376073 -3.610965e-05 -0.0020621022 0.0097254168 18.842584 0 1.8888083 3.7264842 0.30957174 0.30957174 3.7528207e-06 9.8105869e-05 +-0.017806352 -0.0024484373 -0.0063183978 0.0055422121 0.022346617 0 5.9837471 4.3706628 0.30957174 0.30957174 8.9415873e-05 7.0715336e-05 +-0.0040601306 0.0017824173 -0.0034370004 0.0040124523 19.057965 0 3.7609268 4.2282103 0.30957174 0.30957174 3.0750231e-05 2.7878861e-05 +0.0046630021 0.0037083975 -0.0070915515 -0.0086539388 9.1830694 0 3.3787243 5.9670079 0.30957174 0.30957174 0.00012766103 0.00012498516 +0.0067857929 0.00035468944 -0.00597157 0.0075058227 -3.5325348 0 2.3894761 4.1918991 0.30957174 0.30957174 6.2009012e-06 9.1832176e-05 +0.013343619 0.00014922433 -0.0029108017 -0.0032969489 -14.230386 0 2.0466183 5.9301813 0.30957174 0.30957174 1.9748879e-05 1.9323814e-05 +-0.024553261 -0.0027332548 -0.00036759548 -0.0061435721 -14.000384 0 5.8790636 0.31405136 0.30957174 0.30957174 0.00013423371 3.7574517e-05 +-0.0047776405 0.0014819187 0.00073298825 0.0017123914 -22.541451 0 3.8560523 3.1084969 0.30957174 0.30957174 2.2510702e-05 3.4502256e-06 +-0.026713266 0.00191441 0.0015113932 0.0023124905 5.4989476 0 4.5083308 2.9332824 0.30957174 0.30957174 0.00011172226 7.6073028e-06 +0.010495151 -0.00040247712 -0.010290458 0.0080172416 23.729418 0 1.609015 4.4287582 0.30957174 0.30957174 1.3567347e-05 0.00017051319 +-0.0018685172 -0.0031604437 -0.0077319204 -0.0058799409 15.369712 0 0.30948883 5.7329539 0.30957174 0.30957174 9.1371406e-05 9.4564075e-05 +-0.040580751 0.0025793289 0.0074306027 -0.0019500104 15.004581 0 4.5618573 1.6904404 0.30957174 0.30957174 0.00024138458 5.9435742e-05 +0.010066628 -0.0024914206 -0.0033261502 0.0059914338 -0.96646623 0 0.79178234 4.0261349 0.30957174 0.30957174 6.7667982e-05 4.6760479e-05 +-0.0027983167 0.0019129271 0.00032874895 0.0019849328 5.3976481 0 3.6751203 3.3504469 0.30957174 0.30957174 3.4193469e-05 4.0170572e-06 +0.0091100956 -0.00045031031 0.0043575461 -0.0010121052 19.555325 0 1.5220142 1.7186608 0.30957174 0.30957174 1.0958008e-05 2.015907e-05 +-0.013004534 -0.0025198802 0.0067115715 -0.0069680488 7.897808 0 6.1420367 1.1450089 0.30957174 0.30957174 7.6407943e-05 9.3573496e-05 +0.0040365862 -0.0013369206 0.0013728399 -0.0030568963 2.4040119 0 0.69435621 0.79944448 0.30957174 0.30957174 1.8070414e-05 1.1169109e-05 +-0.0009657902 4.7548911e-05 -0.0070432019 0.0033579208 24.237712 0 4.6650972 4.6449512 0.30957174 0.30957174 1.2298995e-07 6.1195534e-05 +-0.027149451 0.00096588737 0.016302328 0.006645286 -3.902847 0 4.7732884 2.3293319 0.30957174 0.30957174 8.9414309e-05 0.00031173513 +0.0071708731 0.0014030395 -0.0043032894 0.010186576 -24.231125 0 3.0045939 3.9185178 0.30957174 0.30957174 2.3576878e-05 0.00012159656 +-0.0084205776 0.00013513635 -0.00058066244 0.00074975135 3.2289706 0 4.9415271 4.1788081 0.30957174 0.30957174 7.9502155e-06 8.9749919e-07 +0.012156542 0.0049596989 0.0087510769 -0.00083959577 -12.314551 0 3.2530476 1.8502161 0.30957174 0.30957174 0.00024030105 7.7904843e-05 +0.0062433181 -0.0013535104 0.00056957172 0.00037774645 -8.5296565 0 0.84302833 2.5269696 0.30957174 0.30957174 2.0967289e-05 4.6859507e-07 +0.017481646 0.0031230827 0.0021616909 -0.0049714224 13.889274 0 2.9648918 0.78743904 0.30957174 0.30957174 0.00012239836 2.9226198e-05 +-0.01304874 0.0015822308 0.0027577039 -0.0043066542 -14.334919 0 4.2516486 0.94754468 0.30957174 0.30957174 4.1496595e-05 2.6064225e-05 +-0.00042382219 -0.00077313814 -0.0020712648 0.011479532 19.846054 0 0.31419473 3.6958275 0.30957174 0.30957174 5.464781e-06 0.00013503922 +-0.039444251 -2.1466408e-05 0.0014052377 0.01268929 10.632501 0 5.0916467 3.4047086 0.30957174 0.30957174 0.00017080061 0.0001617069 +-0.004841251 0.0044583764 0.00012848023 0.0094743369 13.835906 0 3.6345374 3.5022224 0.30957174 0.30957174 0.0001836411 8.9053889e-05 +0.018911202 -0.00061318542 0.0051921396 -0.0014967804 -23.527593 0 1.6578961 1.6665816 0.30957174 0.30957174 4.268503e-05 2.9400309e-05 +-0.030168934 -0.0020252106 -0.002153421 0.005672987 -14.302048 0 5.6355242 3.8813853 0.30957174 0.30957174 0.00013727704 3.6597579e-05 +-0.016348223 -0.0030062645 0.006317731 0.0030319675 -16.900427 0 6.1192948 2.3893878 0.30957174 0.30957174 0.00011166662 4.9357588e-05 +0.015865557 0.00068838178 0.0012482855 -0.007627867 -9.4404975 0 2.3214942 0.53780943 0.30957174 0.30957174 3.1949272e-05 5.9284804e-05 +-0.030119676 0.0012853838 -0.0015995219 0.005883607 -20.332103 0 4.715918 3.7834007 0.30957174 0.30957174 0.00011463975 3.691625e-05 +-0.012273872 0.00042686376 0.0046139843 0.0024257192 -24.080106 0 4.7798843 2.425781 0.30957174 0.30957174 1.819752e-05 2.7298929e-05 +-0.0011933209 0.0010923206 0.0013872278 0.0044932826 10.243554 0 3.6352503 3.2141469 0.30957174 0.30957174 1.1025306e-05 2.1966426e-05 +-0.0071551576 0.0026117035 0.0099984998 -0.0013670798 13.735951 0 3.8080383 1.8102961 0.30957174 0.30957174 6.775519e-05 0.00010263873 +0.0007797964 4.1762765e-05 0.0066331413 -0.0049213406 -11.342576 0 2.3989865 1.3106593 0.30957174 0.30957174 8.2641385e-08 6.8380988e-05 +0.015168849 -0.0036163919 -0.015545706 0.0048334156 2.0605114 0 0.80581561 4.7875418 0.30957174 0.30957174 0.0001443941 0.00026681202 +-0.020626581 0.0026996177 -0.0078511519 0.00026275482 11.707855 0 4.2138237 5.053505 0.30957174 0.30957174 0.00011309381 6.2211549e-05 +-0.012434667 -0.0025854074 0.0046683541 -0.0013209811 9.6038233 0 6.1717063 1.6714602 0.30957174 0.30957174 7.7863914e-05 2.3702067e-05 +0.0034361663 0.00048428957 -0.0024290981 -0.0077813852 20.687445 0 2.8541524 0.069400973 0.30957174 0.30957174 3.4326435e-06 6.6008973e-05 +0.020917883 0.00054671247 0.0060966696 0.0026481694 -16.839446 0 2.178829 2.3519127 0.30957174 0.30957174 5.0756528e-05 4.4428474e-05 +-0.014105435 0.0013579749 -0.0045370967 0.0098359332 2.8896722 0 4.3667341 3.9511818 0.30957174 0.30957174 3.8640157e-05 0.00011671636 +0.0095692345 -0.001385253 1.689435e-05 -0.0064817645 0.68466562 0 1.0231126 0.37692795 0.30957174 0.30957174 2.7532526e-05 4.1673845e-05 +0.028482951 -0.0029262154 -0.0061066344 0.00032048415 4.1478359 0 1.1928199 5.0346792 0.30957174 0.30957174 0.00016706091 3.7696851e-05 +-0.0068944566 -0.00041495009 -0.0035775301 -0.008449912 -1.5144286 0 5.5881936 6.2540642 0.30957174 0.30957174 6.7865734e-06 8.3726727e-05 +0.0015986257 0.0033596995 0.0043688882 0.012922173 -6.2664881 0 3.4637058 3.1873941 0.30957174 0.30957174 0.00010310337 0.00018487513 +0.0093903958 0.00066918055 0.007404215 0.0058613577 9.8076183 0 2.5208772 2.6107623 0.30957174 0.30957174 1.3759287e-05 8.9347019e-05 +0.013095252 0.00096793668 -0.0003865677 0.004965771 -20.443123 0 2.5376915 3.5942134 0.30957174 0.30957174 2.7359765e-05 2.4610146e-05 +-0.018097522 0.00085297436 0.0027169089 -5.043951e-06 -9.7010187 0 4.6811448 1.9432551 0.30957174 0.30957174 4.258186e-05 7.4417925e-06 +-0.00089126407 -0.00041239043 -0.0063135767 0.0059281163 5.4048295 0 0.14135561 4.3368184 0.30957174 0.30957174 1.6363956e-06 7.5044595e-05 +-0.0094484552 0.0012985887 0.0027381376 -0.0060567833 -10.195648 0 4.1898596 0.80193645 0.30957174 0.30957174 2.5161594e-05 4.3946512e-05 +0.0295688 0.0033481194 0.0034380688 -0.0047797271 -2.3082346 0 2.7459839 1.0017172 0.30957174 0.30957174 0.00019809479 3.4577737e-05 +-0.0071938402 0.0011590448 -0.0002701563 -0.0015816127 -23.212166 0 4.1139939 0.20376971 0.30957174 0.30957174 1.7918505e-05 2.5548512e-06 +0.020270098 -0.0018033112 -0.0073126633 -0.0036759418 11.427292 0 1.2640417 5.5492299 0.30957174 0.30957174 7.4727896e-05 6.7314249e-05 +0.013108084 0.0025961196 0.0022355745 -0.0011296176 -6.397717 0 3.0097729 1.4804846 0.30957174 0.30957174 8.0257799e-05 6.3042525e-06 +0.0023698168 0.0011974175 -0.0020206087 -0.00077544419 -12.197719 0 3.3019573 5.4504168 0.30957174 0.30957174 1.3677615e-05 4.7125935e-06 +0.010526649 -8.6129268e-05 0.002341865 0.00012060355 -16.727804 0 1.870701 1.9961348 0.30957174 0.30957174 1.2232001e-05 5.5434663e-06 +-0.02549516 -0.0010780839 0.00065798676 0.002424879 20.659739 0 5.4543701 3.2488657 0.30957174 0.30957174 8.1942904e-05 6.2689687e-06 +-0.017553557 0.00018912499 0.0027827393 0.0076782741 18.696349 0 4.9888566 3.1655902 0.30957174 0.30957174 3.4151121e-05 6.6285946e-05 +0.0031311425 0.0029821731 0.0052735078 0.0025281534 -13.543929 0 3.4011386 2.3889773 0.30957174 0.30957174 8.2089193e-05 3.4376463e-05 +-0.016676039 0.0046188114 -0.00086977661 -0.0012186174 5.9375906 0 3.893245 6.0337532 0.30957174 0.30957174 0.00022486206 2.235699e-06 +0.0017097511 0.001060044 0.0011805215 0.00071869541 24.001766 0 3.3406492 2.4883585 0.30957174 0.30957174 1.0557052e-05 1.9173381e-06 +0.030824147 0.0027037329 -0.00086038704 -0.0058385548 6.7624593 0 2.6192439 0.22681474 0.30957174 0.30957174 0.00017089331 3.4559386e-05 +-0.0019297784 -1.2229486e-05 -0.0015322089 -0.004697676 18.710951 0 5.1443536 0.056615414 0.30957174 0.30957174 4.1017682e-07 2.4256521e-05 +-0.0092209776 0.00079208286 -0.0020829794 -0.0037514382 -8.8680438 0 4.4227128 6.147169 0.30957174 0.30957174 1.5049125e-05 1.8333666e-05 +0.010693223 -0.0027477108 -0.0071091333 -0.0055542349 15.13882 0 0.77804758 5.745977 0.30957174 0.30957174 8.1327468e-05 8.1551846e-05 +-0.0032482678 0.00019394049 -0.0049486583 -0.0036129771 -15.124172 0 4.5885547 5.7134655 0.30957174 0.30957174 1.500914e-06 3.7636904e-05 +0.0040024332 -0.0028459587 -0.011786092 0.0022910193 2.2549016 0 0.52747655 4.8962151 0.30957174 0.30957174 7.553979e-05 0.00014525067 +-0.0050710684 -0.00047185144 -0.0044742437 -0.0014342245 16.77636 0 5.7897923 5.39454 0.30957174 0.30957174 4.8511422e-06 2.2222413e-05 +0.01701157 0.0017754342 -8.7868829e-05 -0.0089361372 -7.4403968 0 2.7052333 0.36438746 0.30957174 0.30957174 6.0483022e-05 7.9216638e-05 +0.013320325 0.0012997079 -0.0013187731 0.0073584925 13.329603 0 2.671707 3.6946433 0.30957174 0.30957174 3.4865777e-05 5.5462922e-05 +0.016925059 0.0011624582 -0.0044933985 -0.0047977183 -19.474158 0 2.5041677 5.9007779 0.30957174 0.30957174 4.3756041e-05 4.3187199e-05 +0.01252266 0.00084578827 -0.0040936873 -0.004770801 18.873921 0 2.4966561 5.9443096 0.30957174 0.30957174 2.3731364e-05 3.9471389e-05 +-0.012819144 0.0030682137 0.0050798869 0.0035303951 15.780689 0 3.9459198 2.5486429 0.30957174 0.30957174 0.00010379479 3.8378519e-05 +0.0082542992 -0.00085957506 -0.0043740293 0.0033807337 4.0930086 0 1.1860597 4.4326101 0.30957174 0.30957174 1.4210125e-05 3.0625038e-05 +-0.0045317837 -0.0029001698 -0.006321193 0.00013696973 -21.551156 0 0.20441694 5.0651994 0.30957174 0.30957174 7.8873327e-05 4.0301815e-05 +-0.024887245 0.0020585991 -0.0080263036 0.0055903471 -16.118418 0 4.4409515 4.4821161 0.30957174 0.30957174 0.00010659711 9.5945982e-05 +-0.0099539511 -0.0036669441 -0.0076233601 -0.0058530641 -1.7771606 0 0.084687992 5.7375553 0.30957174 0.30957174 0.00013336588 9.2570715e-05 +-0.0081529089 -5.1713635e-05 0.00057581573 0.00037749637 19.552854 0 5.1444056 2.5216717 0.30957174 0.30957174 7.3212296e-06 4.7561783e-07 +0.0019726997 -0.0002734071 0.005857485 -0.00820903 -1.2285923 0 1.044186 0.99790059 0.30957174 0.30957174 1.1081411e-06 0.0001014331 +0.0019162358 0.00037713247 0.0016470283 0.0086444058 -17.896439 0 3.0070929 3.3261201 0.30957174 0.30957174 1.6987133e-06 7.6856345e-05 +-0.0064344813 0.0010206272 0.0013439564 0.0034295106 12.204592 0 4.1212852 3.1396399 0.30957174 0.30957174 1.4034102e-05 1.3487383e-05 +0.00043602159 -0.0017958076 -7.7090908e-05 -0.00476901 -20.852495 0 0.40094778 0.35800497 0.30957174 0.30957174 2.9397928e-05 2.2565548e-05 +0.012293625 -0.0012714263 0.0050719633 -0.00091292129 -5.1999049 0 1.1894994 1.7684199 0.30957174 0.30957174 3.1316484e-05 2.6761201e-05 +0.017397383 -0.0015850472 0.0016861411 -0.0052627893 11.560161 0 1.252364 0.68672308 0.30957174 0.30957174 5.6112253e-05 3.0339245e-05 +-0.012955623 0.0014968807 0.0027622492 -0.0043845949 1.6901121 0 4.2757233 0.94014747 0.30957174 0.30957174 3.8836808e-05 2.6761443e-05 +0.0094013772 0.0020595284 0.0025818863 0.00053158639 -19.978761 0 3.0513559 2.1465522 0.30957174 0.30957174 4.8341591e-05 7.0007768e-06 +0.0089340782 0.00018992787 0.0036694549 0.0056239711 11.296838 0 2.1363833 2.9340639 0.30957174 0.30957174 9.090752e-06 4.4947965e-05 +-0.0042627565 0.0011053335 0.0026797257 0.0025188276 -2.2196194 0 3.9163726 2.6955035 0.30957174 0.30957174 1.312426e-05 1.3532659e-05 +0.01037583 0.00093299964 -0.0042385234 -0.00286417 -8.5366625 0 2.6313875 5.6771914 0.30957174 0.30957174 1.9747961e-05 2.6248665e-05 +0.014872145 -0.0023813497 -0.007510834 0.0035785165 23.242491 0 0.97528659 4.6452052 0.30957174 0.30957174 7.5938248e-05 6.9574725e-05 +-0.025785586 8.8981052e-05 0.0050375241 -0.0011935944 23.530539 0 5.0552649 1.7142611 0.30957174 0.30957174 7.3062458e-05 2.6996661e-05 +-0.023011002 0.0012219761 0.0025469138 -0.0032397101 -2.3470811 0 4.6361306 1.0444902 0.30957174 0.30957174 7.1729953e-05 1.6950503e-05 +0.0052459359 0.0022947159 0.0024774721 -0.00089124359 -24.317765 0 3.2700105 1.6023499 0.30957174 0.30957174 5.0988483e-05 6.975795e-06 +-0.014620414 -0.00018968582 -0.00084095458 0.0078511685 11.767461 0 5.204329 3.6234613 0.30957174 0.30957174 2.3793308e-05 6.1855397e-05 +-0.0098133911 -0.00094003494 0.01039642 -0.0027619866 21.178962 0 5.8041564 1.6874353 0.30957174 0.30957174 1.8621459e-05 0.00011653353 +-0.0065405189 -0.00081270219 0.00625529 -0.0025881499 -9.1537174 0 5.9338781 1.5556499 0.30957174 0.30957174 1.0712688e-05 4.6091978e-05 +-0.0098278853 -0.0011478624 -0.00082454866 0.00081689293 24.851444 0 5.9030586 4.3100141 0.30957174 0.30957174 2.2605473e-05 1.347341e-06 +0.0026259509 0.0013770346 0.0034045554 -0.002387066 -13.855488 0 3.3095325 1.3374177 0.30957174 0.30957174 1.8030401e-05 1.7337495e-05 +-0.0024396063 0.00047727525 0.0049465625 0.0067353514 -20.361572 0 4.0272398 2.8785611 0.30957174 0.30957174 2.7283975e-06 6.9666085e-05 +0.017346787 -0.0004292625 -0.0028963252 -0.0054634289 22.875619 0 1.7233824 6.1666584 0.30957174 0.30957174 3.4711658e-05 3.8064782e-05 +-0.010005291 0.0018270511 0.0085726134 6.9368966e-05 4.9191965 0 4.0571652 1.9531229 0.30957174 0.30957174 4.1397472e-05 7.4093545e-05 +-0.016848109 0.0016331809 -0.0022046495 0.0013006173 6.5439954 0 4.3633335 4.5572435 0.30957174 0.30957174 5.5458421e-05 6.5780281e-06 +0.010486989 0.0019626083 -0.0020471726 -0.0003589527 -15.922661 0 2.9853982 5.2588897 0.30957174 0.30957174 4.7160721e-05 4.3528841e-06 +0.011150218 -0.001655241 -0.0053076396 0.00025882022 -14.468934 0 1.0110422 5.0383575 0.30957174 0.30957174 3.8606362e-05 2.8467129e-05 +-0.0030465132 -0.0014443592 0.0063652456 -0.0023369077 19.86531 0 0.14676309 1.5958571 0.30957174 0.30957174 2.0022607e-05 4.6263612e-05 +-0.012140351 0.0018411003 -0.0038962388 -0.0019482593 -6.8790692 0 4.142465 5.5471259 0.30957174 0.30957174 4.7057426e-05 1.9069449e-05 +0.0083720335 0.00085815892 0.0023443804 -0.0011446376 7.6949815 0 2.6962423 1.4940881 0.30957174 0.30957174 1.4402853e-05 6.840524e-06 +-0.012216474 0.0021237893 0.0078272527 0.0010566207 13.054091 0 4.0791241 2.0782058 0.30957174 0.30957174 5.7471033e-05 6.287273e-05 +0.010865338 0.0015449754 0.0031211727 -0.0014972221 -19.54605 0 2.8584423 1.5009796 0.30957174 0.30957174 3.4703404e-05 1.204468e-05 +-0.0071125759 -0.00051579294 -5.4578764e-05 -0.0025568463 -10.858152 0 5.6704786 0.35278346 0.30957174 0.30957174 7.9769595e-06 6.487605e-06 +0.013311499 0.00021761423 0.0077364911 -0.0051632493 22.696838 0 2.0929288 1.3603369 0.30957174 0.30957174 1.9883427e-05 8.6784786e-05 +-0.0059431226 0.0036828078 -0.0016085026 0.00038318991 10.93206 0 3.6912262 4.8546443 0.30957174 0.30957174 0.00012742854 2.7540187e-06 +-0.005173045 -0.0010634304 0.00010985101 -0.0097247848 4.021131 0 6.1670024 0.38568784 0.30957174 0.30957174 1.3239327e-05 9.3818913e-05 +0.013131171 0.0009405609 -0.0055229278 0.0025275331 12.968162 0 2.5232184 4.660561 0.30957174 0.30957174 2.6987244e-05 3.7088151e-05 +0.027502156 -0.00042470579 0.0069947979 -0.0072617744 3.3376434 0 1.8053409 1.1450312 0.30957174 0.30957174 8.4674977e-05 0.00010163301 +-0.011487109 0.00042380962 -0.0013519233 -0.009836243 -7.2589703 0 4.7624645 0.23661352 0.30957174 0.30957174 1.6121655e-05 9.7811951e-05 +0.0040557346 0.00017378348 -0.00389906 -0.00080332507 7.3569343 0 2.3172357 5.2882779 0.30957174 0.30957174 2.0808294e-06 1.5966711e-05 +0.015386043 0.0001372912 -0.00081160191 6.9333009e-05 -22.850761 0 2.0262022 5.0021546 0.30957174 0.30957174 2.6159246e-05 6.6883541e-07 +0.026973089 -0.0021653264 0.000437436 -0.0079874229 15.48986 0 1.3136869 0.42945631 0.30957174 0.30957174 0.00012257856 6.3475965e-05 +-0.0013259354 -0.0015975612 -0.0083571604 0.00021830351 -1.8635335 0 0.28343901 5.0607845 0.30957174 0.30957174 2.3441966e-05 7.0458739e-05 +0.008162438 -0.0032809413 0.0029379784 -0.0064060707 4.2496077 0 0.64090569 0.80738733 0.30957174 0.30957174 0.00010537251 4.9407998e-05 +0.017553464 0.0012875576 0.0044942505 0.0047507763 -4.2207382 0 2.5341451 2.7541811 0.30957174 0.30957174 4.8926503e-05 4.2750318e-05 +0.0244078 -0.00093240343 -0.0043102373 0.0038601209 15.134012 0 1.6102156 4.3603598 0.30957174 0.30957174 7.3318098e-05 3.350964e-05 +0.00088357374 0.0023474596 -0.003955744 -0.0033889969 13.284859 0 3.4745968 5.7910676 0.30957174 0.30957174 5.0283529e-05 2.7167901e-05 +0.0070746128 -8.4643718e-05 0.0098746793 0.007060881 8.1611374 0 1.8365366 2.5620152 0.30957174 0.30957174 5.5596192e-06 0.00014775708 +0.016975886 -0.0005379168 -0.0040583532 0.00048083073 10.310914 0 1.664085 4.9697046 0.30957174 0.30957174 3.4271451e-05 1.6833821e-05 +0.015286381 0.0026140691 0.00035948989 0.0037608882 -18.002877 0 2.9451999 3.4198239 0.30957174 0.30957174 8.7899591e-05 1.4160197e-05 +0.013921416 -0.0023785673 0.00077270608 -0.00046427257 -13.120129 0 0.94539146 1.4076371 0.30957174 0.30957174 7.2812471e-05 8.1574802e-07 +-0.010096044 0.00090285448 -0.0054274628 -0.0065670216 10.866825 0 4.4030969 5.9628203 0.30957174 0.30957174 1.8615055e-05 7.2474545e-05 +0.036670871 -0.0010423778 0.0029121168 0.0052649176 -9.2364973 0 1.6917253 3.0072136 0.30957174 0.30957174 0.00015752073 3.6044777e-05 +-0.020931067 0.00086541705 0.00023823683 0.0024292138 6.7937949 0 4.7264844 3.4173422 0.30957174 0.30957174 5.4916788e-05 5.9105839e-06 +-0.039121989 0.0012841428 -0.0015863989 0.0022857809 -8.2330067 0 4.7961439 4.1264087 0.30957174 0.30957174 0.00018303855 7.7197241e-06 +-0.011102685 -0.0025508726 0.0059830203 0.0088479847 24.955459 0 6.2117512 2.9175453 0.30957174 0.30957174 7.2806435e-05 0.00011374215 +0.0086941947 -0.00039445 -0.0017154031 0.0036775299 -4.6022163 0 1.553189 3.9554648 0.30957174 0.30957174 9.7152708e-06 1.6381466e-05 +-0.028657489 -0.0010916049 -0.0054116951 0.0012749727 5.8663612 0 5.4206794 4.8571183 0.30957174 0.30957174 0.00010100929 3.1137592e-05 +-0.009267806 0.00057070918 0.00033777126 0.0080844743 7.5868428 0 4.5754756 3.473797 0.30957174 0.30957174 1.2395996e-05 6.4945262e-05 +0.026600234 -0.00053652049 0.0012614135 0.013053033 10.41298 0 1.7633892 3.4187741 0.30957174 0.30957174 8.0297352e-05 0.00017060813 +-0.009405454 -0.0013222178 -0.014401689 0.00011756091 -0.92862561 0 5.9945081 5.0785924 0.30957174 0.30957174 2.5636713e-05 0.0002091131 +-0.0018683399 0.001906715 0.0015189872 0.0049147517 -15.162343 0 3.6230485 3.2138406 0.30957174 0.30957174 3.3500904e-05 2.6285603e-05 +-0.017019767 -0.0022052201 -2.7787084e-05 0.004283682 -0.41471172 0 5.9545886 3.5224324 0.30957174 0.30957174 7.6098234e-05 1.8202334e-05 +0.0043557308 0.0018196992 0.0053295533 0.00045895031 10.045701 0 3.2589337 2.0303077 0.30957174 0.30957174 3.2246657e-05 2.8844615e-05 +0.0018533047 0.0020107617 -0.004185443 0.0024762155 -16.885766 0 3.4150554 4.556001 0.30957174 0.30957174 3.7207747e-05 2.3742799e-05 +-0.023801326 0.00014761024 -0.0055414102 0.0075953435 -15.820598 0 5.030255 4.150067 0.30957174 0.30957174 6.2387494e-05 8.818032e-05 +0.013090622 -0.00030516161 -0.00030760351 0.0053514107 -20.766352 0 1.7358519 3.5737776 0.30957174 0.30957174 1.9660166e-05 2.8501428e-05 +0.0072862876 -0.00081375811 -0.0017132808 -0.0010553428 10.207415 0 1.1510899 5.6351556 0.30957174 0.30957174 1.1860309e-05 4.064002e-06 +-0.036897015 0.00054477551 -0.0037664906 -0.0018157094 -12.440095 0 4.9529938 5.5327219 0.30957174 0.30957174 0.00015215276 1.757224e-05 +0.024430021 -0.001205018 0.0012388445 -0.0030923979 -12.157902 0 1.522806 0.75814299 0.30957174 0.30957174 7.8745194e-05 1.1032847e-05 +-0.015512371 0.00053412656 0.0076254944 -0.0029038521 -8.9467597 0 4.7827509 1.5839353 0.30957174 0.30957174 2.9014864e-05 6.698635e-05 +-0.0030593019 -0.0015406771 0.0039197179 -0.0002292041 -24.860905 0 0.15967494 1.8871597 0.30957174 0.30957174 2.2650239e-05 1.5541544e-05 +-0.015630477 -0.0028212029 -0.0068421012 0.011162884 5.3373514e-05 0 6.1110556 4.0693917 0.30957174 0.30957174 9.932304e-05 0.00017079837 +-0.010458894 0.00017842489 -0.0056570188 0.0015505907 21.581757 0 4.9325198 4.8212223 0.30957174 0.30957174 1.2298338e-05 3.4647624e-05 +-0.01911267 0.0011602931 0.0072460775 -0.0023313994 -23.018194 0 4.5815361 1.6361696 0.30957174 0.30957174 5.2364667e-05 5.8325126e-05 +-0.0046239799 0.00097388567 0.0038448159 0.0017049654 -1.2746418 0 3.9963704 2.3594859 0.30957174 0.30957174 1.0986981e-05 1.7786516e-05 +-0.027998745 0.00043399243 -0.0090480094 0.0014709836 22.007768 0 4.9464173 4.9268049 0.30957174 0.30957174 8.7773194e-05 8.4680129e-05 +0.0013357812 0.00023491086 0.0004156573 0.00044965703 -8.3806332 0 2.9578486 2.7657182 0.30957174 0.30957174 6.9856011e-07 3.7473593e-07 +0.017756506 0.00069854739 0.0043382114 0.00089726391 -21.162324 0 2.2892051 2.1474446 0.30957174 0.30957174 3.9057062e-05 1.9772068e-05 +0.0027408305 0.00015436318 -0.0022227546 0.0025242601 21.357371 0 2.4191207 4.2418903 0.30957174 0.30957174 1.0417196e-06 1.130128e-05 +-0.022787354 -0.00079313401 0.006460073 0.0065935813 14.801842 0 5.3937229 2.7366632 0.30957174 0.30957174 6.2733548e-05 8.5196516e-05 +-0.023519505 0.0018871359 -0.00056532439 0.0038567323 0.61965493 0 4.4555184 3.6626072 0.30957174 0.30957174 9.316608e-05 1.5076309e-05 +0.013300885 0.0017559607 -0.0018597849 -0.0033573676 16.649482 0 2.8222208 6.1481726 0.30957174 0.30957174 4.750887e-05 1.466777e-05 +0.016535247 0.0014028568 0.00633976 0.0051719834 12.358523 0 2.6030577 2.625425 0.30957174 0.30957174 4.794193e-05 6.7053318e-05 +0.023183336 -1.3414449e-05 -0.0051847566 -0.005084863 5.2747921 0 1.9398257 5.8583024 0.30957174 0.30957174 5.9003161e-05 5.27476e-05 +-0.019825613 0.00055081353 0.0029457611 0.0023322628 -21.905074 0 4.838809 2.6108303 0.30957174 0.30957174 4.5912134e-05 1.4143713e-05 +0.0042067016 0.001584621 -0.0066148983 0.005490282 15.825268 0 3.232321 4.3979158 0.30957174 0.30957174 2.4816513e-05 7.4013039e-05 +-0.0074444338 0.0012884124 -0.0014232491 0.014059908 20.280373 0 4.0811451 3.6175935 0.30957174 0.30957174 2.1205421e-05 0.00019812474 +0.014911866 0.0030275619 -0.0040829665 0.003931864 -2.6089655 0 3.0202237 4.3241975 0.30957174 0.30957174 0.00010790817 3.2141061e-05 +-7.6358962e-05 0.0012613666 -0.00072764301 -0.0064374548 13.986284 0 3.5225384 0.26083558 0.30957174 0.30957174 1.4494075e-05 4.1639519e-05 +0.022642129 -0.00071603075 0.00059992586 0.0093985251 11.472116 0 1.6646173 3.4516293 0.30957174 0.30957174 6.0949312e-05 8.7980877e-05 +0.0031697173 -0.0018478167 -0.0024953457 -0.0071372924 -14.429944 0 0.56043042 0.035425984 0.30957174 0.30957174 3.2206239e-05 5.6806551e-05 +0.0054497034 0.0021288184 -0.0058939564 -0.0017001897 17.407132 0 3.2419336 5.3653739 0.30957174 0.30957174 4.4542787e-05 3.7889177e-05 +-0.00087957153 0.00091165721 0.0018027905 0.0012389614 -21.723377 0 3.6214129 2.5434276 0.30957174 0.30957174 7.6559033e-06 4.7991605e-06 +0.015126221 -0.0012703711 -6.3341184e-05 0.001188039 15.043646 0 1.292034 3.5695916 0.30957174 0.30957174 3.981836e-05 1.4040689e-06 +0.011265829 0.0025299856 0.00024544661 0.001369163 -8.8664153 0 3.0612225 3.337094 0.30957174 0.30957174 7.2240319e-05 1.9201847e-06 +0.0063072507 -0.00096044459 -0.0067189099 0.0021425772 20.181534 0 0.99892026 4.7803379 0.30957174 0.30957174 1.2770063e-05 5.0065271e-05 +0.022236975 -0.00055270726 -0.0025872291 0.00050584317 1.8377036 0 1.7224343 4.8951326 0.30957174 0.30957174 5.7065647e-05 7.0021286e-06 +0.00035841097 -0.00097616644 -0.0080722139 -0.00030150803 -4.3609526 0 0.41458438 5.1237216 0.30957174 0.30957174 8.6944352e-06 6.5781984e-05 +0.022228332 -0.0013566394 0.001667207 -0.011754589 11.533873 0 1.4376865 0.51632827 0.30957174 0.30957174 7.1006214e-05 0.00013985538 +-0.002122615 -0.002005309 0.00056986014 -0.0025899357 0.23261991 0 0.25862036 0.59258809 0.30957174 0.30957174 3.7125812e-05 6.9809165e-06 +-0.02440572 -0.00021999319 0.00068703118 -0.0046331397 17.016267 0 5.1686174 0.5226964 0.30957174 0.30957174 6.5828344e-05 2.1768272e-05 +0.0039811503 0.0010831252 -0.0075108236 0.0019383674 -7.4559939 0 3.1323748 4.8360811 0.30957174 0.30957174 1.2426674e-05 6.0599221e-05 +0.032740622 -0.00084573248 0.0041777186 -0.00031355946 8.8518676 0 1.7139938 1.8707854 0.30957174 0.30957174 0.00012419087 1.7693133e-05 +-0.016651041 0.00067700181 0.0036295238 0.0083997125 -16.201883 0 4.7319829 3.1050587 0.30957174 0.30957174 3.4611572e-05 8.3265499e-05 +-0.012081093 0.0012491644 0.006243816 -0.0006748833 -24.781233 0 4.3312045 1.8382903 0.30957174 0.30957174 3.023664e-05 3.9754822e-05 +0.0097740524 0.00046503888 0.0069925501 0.0033370627 7.7803663 0 2.3540726 2.3872161 0.30957174 0.30957174 1.2457231e-05 6.0340288e-05 +-0.00082736593 -0.0029749129 -0.0034661243 0.0054457437 -3.8854712 0 0.34377919 4.0863911 0.30957174 0.30957174 8.0694101e-05 4.1528282e-05 +0.025444326 0.0015276995 0.0027528292 -0.0031138032 6.6562154 0 2.4455835 1.1022766 0.30957174 0.30957174 9.2331195e-05 1.7257215e-05 +-0.039727154 0.0030822894 -0.00016905926 -0.0027370081 21.62329 0 4.4714379 0.31210915 0.30957174 0.30957174 0.0002597989 7.4594545e-06 +-0.049489773 0.00049604964 -0.0066763429 -0.0019285539 17.803714 0 4.9956359 5.3657411 0.30957174 0.30957174 0.00027111145 4.8626155e-05 +-0.0086015678 0.0033350386 0.010097428 -0.0059752276 5.8729685 0 3.791803 1.4143112 0.30957174 0.30957174 0.00010944095 0.00013820385 +-0.0059688266 -0.0031263288 -0.0055361742 -0.0059780542 -15.479853 0 0.16770306 5.9063968 0.30957174 0.30957174 9.2945441e-05 6.6347237e-05 +-0.016473099 0.0012659134 0.002709949 0.0089473449 5.2594129 0 4.4759424 3.2195384 0.30957174 0.30957174 4.4387526e-05 8.6811356e-05 +-0.030541131 -0.00098331281 -0.010897514 0.0023121515 23.732212 0 5.3719775 4.8792596 0.30957174 0.30957174 0.00011120356 0.00012502671 +0.015880334 -0.0021348507 -0.004600705 -0.0017626971 1.0744873 0 1.0590749 5.4498697 0.30957174 0.30957174 6.9200895e-05 2.4421008e-05 +0.016108369 0.0002330567 0.0089984245 0.0059220464 6.4764303 0 2.0761363 2.5234369 0.30957174 0.30957174 2.8979666e-05 0.00011641876 +0.0228387 -0.001012971 0.0046642511 0.00098853502 -15.456911 0 1.5611204 2.1523042 0.30957174 0.30957174 6.6607589e-05 2.2901882e-05 +-0.0023523678 -0.0015810027 0.0022466508 -0.0010320656 -5.4450762 0 0.21239323 1.5175415 0.30957174 0.30957174 2.3376985e-05 6.1451321e-06 +-0.015100828 -0.001651048 0.0032020279 -0.01308491 -13.499512 0 5.8700699 0.61617662 0.30957174 0.30957174 4.9864792e-05 0.00018016701 +0.0013642044 -0.00036325611 -0.00072683846 -0.003357861 -18.856213 0 0.76533614 0.15944528 0.30957174 0.30957174 1.4063287e-06 1.1716661e-05 +-0.0180509 -0.00089920926 -0.0042880923 0.0010174787 -15.284197 0 5.5126867 4.8555348 0.30957174 0.30957174 4.3134821e-05 1.9564521e-05 +-0.00065280837 -0.00094738965 0.0076077618 -0.0029909051 19.967972 0 0.29880111 1.5732754 0.30957174 0.30957174 8.2228775e-06 6.722303e-05 +-0.0029350808 0.00015981882 -0.0045549867 -0.0083194962 17.406011 0 4.6262332 6.1531306 0.30957174 0.30957174 1.178368e-06 8.9571398e-05 +0.0062144555 0.0029928721 -0.0057629175 0.0019524464 -17.402513 0 3.2917791 4.7624909 0.30957174 0.30957174 8.5834799e-05 3.7263172e-05 +0.012848074 0.00037921034 0.0026422958 -0.0027542336 13.645057 0 2.2077483 1.1430154 0.30957174 0.30957174 1.943115e-05 1.4563106e-05 +-0.0081893317 0.001390069 0.00044890477 -0.0049224384 -14.474225 0 4.0899664 0.46598155 0.30957174 0.30957174 2.4964184e-05 2.4237634e-05 +0.033639605 0.00058856775 -0.0017093665 0.0080372857 9.7115315 0 2.1031474 3.7271082 0.30957174 0.30957174 0.00012738177 6.7021384e-05 +0.012232686 -0.0013324751 0.0040179398 -0.004498779 -21.601166 0 1.1635829 1.1073354 0.30957174 0.30957174 3.2600482e-05 3.6350804e-05 +-0.020526173 -4.8863996e-05 0.00014654839 -0.0026615173 -24.556111 0 5.1083714 0.42975418 0.30957174 0.30957174 4.6273409e-05 7.0480481e-06 +-0.014338251 -0.0031876036 0.0058383212 -0.0023225819 -12.045433 0 6.1988175 1.569254 0.30957174 0.30957174 0.00011512726 3.9714624e-05 +0.010426164 -0.00022851404 0.0089000961 -0.0042897945 14.015648 0 1.7480342 1.4991246 0.30957174 0.30957174 1.2408977e-05 9.8110964e-05 +-0.0036955787 -0.0028064277 0.0029547571 0.0033925165 3.264942 0 0.23073749 2.7953307 0.30957174 0.30957174 7.3245043e-05 2.0217866e-05 +-0.000411532 -0.00064945683 -0.0045396946 -0.0043420066 15.754604 0 0.30485132 5.8457786 0.30957174 0.30957174 3.8608737e-06 3.9477404e-05 +0.019287123 0.0026628263 -0.00054175391 -0.0063583257 19.844159 0 2.844131 0.28861218 0.30957174 0.30957174 0.00010542763 4.0397298e-05 +0.0042021817 0.0011641837 -0.0074332494 -0.0060288533 3.0984373 0 3.1386271 5.7641726 0.30957174 0.30957174 1.4284633e-05 9.1756783e-05 +0.0083340606 -0.0020200828 -0.0021047312 -0.00067742197 -6.052448 0 0.7995602 5.3957156 0.30957174 0.30957174 4.479768e-05 4.9211949e-06 +0.012579159 0.0013295127 0.0016057687 -0.0079220118 23.114622 0 2.711537 0.57587446 0.30957174 0.30957174 3.3472362e-05 6.4850328e-05 +0.01105727 0.0028882372 -0.0023888739 0.0027043877 10.036924 0 3.1180371 4.2434531 0.30957174 0.30957174 8.9411328e-05 1.3007813e-05 +0.00033863336 0.0014865522 0.0022553177 0.0025340751 -8.235097 0 3.4908912 2.7845984 0.30957174 0.30957174 2.0142831e-05 1.1497535e-05 +-0.0029720398 0.0023413292 0.0010050488 0.0019664503 -11.586984 0 3.6543502 3.0401086 0.30957174 0.30957174 5.0905648e-05 4.8540167e-06 +0.017467188 0.0026367507 -0.00085760817 0.0061186538 10.33822 0 2.8871317 3.656269 0.30957174 0.30957174 9.6825781e-05 3.7876693e-05 +-0.0043901876 0.00038220428 -0.0036255227 0.00069991431 -18.52989 0 4.4161999 4.8974887 0.30957174 0.30957174 3.4465128e-06 1.3737484e-05 +-0.0056333914 0.0030337917 0.0051756498 0.0021471101 -21.709091 0 3.7169808 2.3354722 0.30957174 0.30957174 8.7325504e-05 3.1578521e-05 +0.00095833663 -0.00067484128 -0.0082831159 0.0058876105 11.722018 0 0.52894891 4.4725826 0.30957174 0.30957174 4.2493283e-06 0.00010355297 +-0.001917999 0.0012270252 0.0043385876 -0.0092369494 19.80463 0 3.6858335 0.81654696 0.30957174 0.30957174 1.4118832e-05 0.00010360812 +-0.020761101 0.0004800092 0.00044874401 0.00045994775 -20.058663 0 4.8791088 2.7387652 0.30957174 0.30957174 4.9415327e-05 4.1285407e-07 +-0.016700527 0.0019710576 -0.00089908358 0.0046923042 -9.5884472 0 4.2651056 3.7067127 0.30957174 0.30957174 6.600819e-05 2.2654627e-05 +-0.012032597 4.1041188e-05 0.0043915581 0.00039423736 -19.068775 0 5.0556287 2.0339081 0.30957174 0.30957174 1.5909228e-05 1.9597162e-05 +-0.013668132 -0.001950586 -0.0085555773 0.00097394557 -17.202501 0 6.0017913 4.9742485 0.30957174 0.30957174 5.5167525e-05 7.4735496e-05 +0.0027515513 0.0011394606 -0.0065215063 -0.0021014034 8.8819286 0 3.2567652 5.3960486 0.30957174 0.30957174 1.2658471e-05 4.725693e-05 +0.022817782 -0.0024745268 0.0028173076 -0.0036096953 6.3137476 0 1.1657916 1.0409688 0.30957174 0.30957174 0.00011293481 2.0926467e-05 +0.019022849 -0.0023440219 -0.01194964 -0.0053060218 -3.961257 0 1.1020607 5.501566 0.30957174 0.30957174 8.977578e-05 0.00017188415 +0.020262478 0.00041787238 0.00010505385 0.0023839569 6.8154255 0 2.1307946 3.4714959 0.30957174 0.30957174 4.6661578e-05 5.6484228e-06 +0.021006356 -0.00075597438 -0.00017433093 -0.00082748768 8.152388 0 1.6283097 0.16501789 0.30957174 0.30957174 5.364695e-05 7.0983819e-07 +0.01570957 -0.00072475391 0.0010360973 0.0094715112 20.900389 0 1.5472502 3.4060541 0.30957174 0.30957174 3.1876795e-05 9.0066393e-05 +0.0073379056 0.00014875277 0.0001719824 -0.0039421528 11.920892 0 2.1277032 0.41825409 0.30957174 0.30957174 6.1124935e-06 1.5444729e-05 +-0.015858786 0.00068593633 -0.010851157 -0.0014912669 23.012699 0 4.711361 5.2221722 0.30957174 0.30957174 3.1895073e-05 0.00012091337 +-0.0035092158 -0.00095336198 0.0044065796 -0.0037848055 21.283911 0 6.2734699 1.2394694 0.30957174 0.30957174 9.6313633e-06 3.3785159e-05 +-0.0099761402 0.0004719425 -0.0014268859 0.0010367709 -16.842443 0 4.6797995 4.462191 0.30957174 0.30957174 1.2954306e-05 3.118803e-06 +-0.027316809 0.0031849204 -0.0016580754 -0.0025049833 -16.992545 0 4.2711946 6.0690401 0.30957174 0.30957174 0.00017431943 8.995828e-06 +0.011124429 -0.001483738 -0.0020886173 -0.00066734332 0.23933184 0 1.0629453 5.3936057 0.30957174 0.30957174 3.3639321e-05 4.8396288e-06 +-0.0049776745 -5.7561215e-05 -0.0015903252 0.0067408356 12.571434 0 5.1916419 3.7494014 0.30957174 0.30957174 2.7501533e-06 4.7621203e-05 +0.030931291 -0.002264415 -0.0020046194 -0.0032626269 16.516373 0 1.3569474 6.1029035 0.30957174 0.30957174 0.00015173758 1.4609919e-05 +-0.0092227214 -0.0013851639 -0.0055402214 0.0005602456 6.192371 0 6.0263086 4.986718 0.30957174 0.30957174 2.6815446e-05 3.1255602e-05 +0.0027460137 -0.0014705699 0.019132086 -0.00085696215 14.139848 0 0.57648732 1.9006961 0.30957174 0.30957174 2.05275e-05 0.000369749 +-0.0059791811 -0.00054467231 0.00037289861 -0.0018866142 24.800702 0 5.7793486 0.57099013 0.30957174 0.30957174 6.6270541e-06 3.6707199e-06 +-0.0037627512 0.0011418069 0.0002012096 -0.00046351564 15.814592 0 3.8630084 0.78682247 0.30957174 0.30957174 1.343036e-05 2.5392486e-07 +-0.015529428 0.002579803 -0.0037590836 -0.0090681746 12.692821 0 4.0998338 6.2616312 0.30957174 0.30957174 8.710056e-05 9.5812775e-05 +0.027292605 0.00040529317 0.00022208855 -0.0017507135 23.139631 0 2.079554 0.5014999 0.30957174 0.30957174 8.3267705e-05 3.0899401e-06 +0.020176372 -0.0010487361 0.0051162247 -0.010011449 -18.670932 0 1.5028801 0.85003637 0.30957174 0.30957174 5.4707603e-05 0.0001258078 +0.02829857 0.0022668613 -0.0020559103 0.0051774278 24.768327 0 2.5754839 3.8966821 0.30957174 0.30957174 0.0001347204 3.0850233e-05 +0.016729181 0.0029002277 -0.0028963763 0.0066355542 -4.0669781 0 2.9514052 3.9304431 0.30957174 0.30957174 0.00010734469 5.2131935e-05 +-0.019606761 0.0012097127 -0.0031323155 -0.0051600728 -17.033653 0 4.5746514 6.1083055 0.30957174 0.30957174 5.5531738e-05 3.6302435e-05 +0.00019232054 -6.9403241e-05 0.01224024 0.0039274959 -9.1907592 0 0.66960456 2.2532322 0.30957174 0.30957174 4.7938479e-08 0.0001663453 +-0.0055129021 -0.00029067492 0.001337045 -0.004744149 -17.356766 0 5.534456 0.65113251 0.30957174 0.30957174 4.1060209e-06 2.4127224e-05 +0.0073431823 -0.00023809599 -0.010859817 -0.0072882412 -23.280744 0 1.6578991 5.6740178 0.30957174 0.30957174 6.4358387e-06 0.00017158597 +0.0090863392 -0.00030779549 0.0056273639 0.0035818237 -12.205946 0 1.6457907 2.5082524 0.30957174 0.30957174 9.9263647e-06 4.4651093e-05 +-0.014125061 0.00054024082 -0.0013413492 0.0016635295 6.8547967 0 4.7514351 4.1984505 0.30957174 0.30957174 2.456108e-05 4.5588385e-06 +0.0082468013 0.0025691523 0.0020868928 0.0026960594 -2.4841006 0 3.1771025 2.853241 0.30957174 0.30957174 6.759274e-05 1.1600586e-05 +0.0038389863 2.8757476e-05 -0.0065432803 -0.0050182664 23.670476 0 2.0132284 5.7370242 0.30957174 0.30957174 1.6254065e-06 6.8142903e-05 +0.00097579896 -0.00072198975 -0.00067472693 -0.001111243 13.977168 0 0.52159389 6.1081934 0.30957174 0.30957174 4.8529654e-06 1.6838437e-06 +0.022967961 -0.00068804521 -0.0051802919 0.0053153723 -14.227687 0 1.6786957 4.2924801 0.30957174 0.30957174 6.2222792e-05 5.5078912e-05 +-0.021885124 -0.00089749894 -0.0051789322 -0.0081992584 -0.060073625 0 5.4442068 6.0904578 0.30957174 0.30957174 5.9916283e-05 9.3724224e-05 +-0.0024529239 -0.00085080393 0.0035981219 -0.0039424322 -12.69214 0 0.067780591 1.1181129 0.30957174 0.30957174 7.2544903e-06 2.8469113e-05 +0.015674909 0.00016631008 0.0021853202 -0.0030881013 8.9812777 0 2.0414474 0.99398084 0.30957174 0.30957174 2.722447e-05 1.4273814e-05 +0.0020726395 0.00056788776 0.00039707597 -0.0069696469 -13.726175 0 3.1348204 0.43167384 0.30957174 0.30957174 3.409326e-06 4.8342153e-05 +0.014431054 0.0022808513 0.0065689444 -0.0075230972 -14.285925 0 2.9088244 1.0961175 0.30957174 0.30957174 7.0251194e-05 9.9642144e-05 +-0.014185429 -0.0016897521 -0.0042542625 0.0048761719 13.149525 0 5.9128775 4.2373063 0.30957174 0.30957174 4.8099688e-05 4.183108e-05 +0.0037649989 0.0045959045 0.00054017632 -0.0030462881 -9.6845742 0 3.4262041 0.5511999 0.30957174 0.30957174 0.00019396745 9.4990044e-06 +-0.029790087 -0.0020906045 0.0056606741 -0.0025224599 1.1156155 0 5.655489 1.5289086 0.30957174 0.30957174 0.00013723521 3.8615796e-05 +0.011605885 0.0017177927 0.0033129951 -0.00037717936 -9.6378663 0 2.8777354 1.8326451 0.30957174 0.30957174 4.1666638e-05 1.1206524e-05 +0.0076996286 -0.00020466465 -0.0029767978 -0.016853412 -18.707008 0 1.7075317 0.19807871 0.30957174 0.30957174 6.8896202e-06 0.00029067436 +-0.027919582 0.0015766599 0.0043495547 0.001566554 -18.877502 0 4.6115724 2.2882173 0.30957174 0.30957174 0.0001082161 2.1507095e-05 +-0.023100538 6.5032204e-05 0.0022043393 0.0070215833 4.7365334 0 5.0610503 3.209371 0.30957174 0.30957174 5.8619354e-05 5.3802699e-05 +0.0062694217 -0.00044587343 -0.0012717282 0.0051067669 10.78391 0 1.3702361 3.7618672 0.30957174 0.30957174 6.1258284e-06 2.7498673e-05 +0.0010147052 -0.0020999608 -0.0013758131 0.0044819667 19.269651 0 0.42729506 3.8160138 0.30957174 0.30957174 4.0283882e-05 2.1833888e-05 +-0.0029278794 -7.683276e-05 0.0065854952 0.0022917806 -18.552317 0 5.3213322 2.2774803 0.30957174 0.30957174 9.94836e-07 4.8932068e-05 +-0.0017791271 0.0018202266 -0.00018883031 -0.0013722578 15.72254 0 3.6227823 0.23645278 0.30957174 0.30957174 3.0528889e-05 1.9038126e-06 +0.012386947 -0.001786346 -0.0037167893 0.0035128401 9.9531685 0 1.0249434 4.3335457 0.30957174 0.30957174 4.5912105e-05 2.6167401e-05 +0.0073318188 0.0013635586 0.00022932542 0.001168841 -9.2693303 0 2.98266 3.3206152 0.30957174 0.30957174 2.2838117e-05 1.4081613e-06 +0.0017038364 0.0035084063 0.0045152202 0.0060609481 17.186619 0 3.4626308 2.8717252 0.30957174 0.30957174 0.00011244523 5.6991463e-05 +0.011688523 0.00089107896 0.0090642175 -0.004517904 0.47616402 0 2.5520926 1.4859369 0.30957174 0.30957174 2.2230948e-05 0.0001030762 +-0.0046125653 -0.0010678877 -0.0054941794 -0.0015749974 -3.1642927 0 6.2147198 5.3637258 0.30957174 0.30957174 1.2723777e-05 3.2892636e-05 +-0.013421326 -0.00084266504 0.0050179179 -0.0061799802 -11.939313 0 5.6062186 1.0602697 0.30957174 0.30957174 2.6242774e-05 6.3268097e-05 +-0.00032052973 0.0012249329 0.0062713058 0.0023540982 5.0972001 0 3.5446105 2.3015339 0.30957174 0.30957174 1.3679539e-05 4.5146849e-05 +-0.0064259989 0.0011433042 -0.0058821904 -0.0027594077 -17.309319 0 4.0687239 5.5222093 0.30957174 0.30957174 1.6440344e-05 4.2434979e-05 +0.011347709 0.00021661997 -0.0075084449 0.0081207903 12.175855 0 2.1172667 4.2661798 0.30957174 0.30957174 1.4563489e-05 0.00012225031 +-0.02127305 -0.00021689519 -0.013813863 -0.0067659665 -20.184462 0 5.1793007 5.5389407 0.30957174 0.30957174 5.0107311e-05 0.00023778651 +0.019280394 0.00053325207 -0.0015786556 -0.0015564274 -18.428714 0 2.1919048 5.8609387 0.30957174 0.30957174 4.3398118e-05 4.9153474e-06 +-0.0045922081 -0.0024281522 -0.0045521931 0.0027406842 2.554049 0 0.16959422 4.5483386 0.30957174 0.30957174 5.6023202e-05 2.8342001e-05 +-0.023901148 -0.0015640855 -0.0029596602 -0.0079586628 18.495932 0 5.6242476 0.015608014 0.30957174 0.30957174 8.4996589e-05 7.1659146e-05 +-0.011271293 -0.00071820266 0.0028613492 -0.0048103912 24.338967 0 5.6126068 0.91448122 0.30957174 0.30957174 1.8645048e-05 3.1206818e-05 +0.027634652 -6.7815472e-05 0.0090874093 -0.0036267568 -20.397222 0 1.9227459 1.5681558 0.30957174 0.30957174 8.3875729e-05 9.6301199e-05 +-0.025426961 -0.00050876193 0.0090999012 -0.011880345 -2.7071905 0 5.2669775 1.0318628 0.30957174 0.30957174 7.3332016e-05 0.00022348459 +-0.014235002 -0.0002403111 -0.0023666487 0.004686478 -21.580017 0 5.2392757 3.9868033 0.30957174 0.30957174 2.2770752e-05 2.743217e-05 +0.0020519723 0.00060943364 0.0026954098 0.0043835957 5.4752461 0 3.1618466 2.9609709 0.30957174 0.30957174 3.8455338e-06 2.6384993e-05 +0.018746679 0.00044481557 0.00025813189 -0.0061936244 -12.797397 0 2.1579665 0.41629235 0.30957174 0.30957174 4.0382192e-05 3.8117976e-05 +-0.033284619 -0.0028453344 0.00020871305 0.0036750602 -17.701335 0 5.7483159 3.4587007 0.30957174 0.30957174 0.00019536704 1.3440775e-05 +-0.0043120005 -0.0012241064 0.0073412487 -0.0046108963 -13.824648 0 0.0053141941 1.3879353 0.30957174 0.30957174 1.5690944e-05 7.5421721e-05 +-0.0024865904 -0.00075216334 -0.009567166 -0.0053437559 0.82151246 0 0.026167637 5.5926252 0.30957174 0.30957174 5.8323927e-06 0.00012060163 +-0.026831503 -0.0014598774 -0.0046199413 -0.0003250591 5.0786651 0 5.546837 5.1563674 0.30957174 0.30957174 9.8445991e-05 2.1622657e-05 +-0.010648695 -0.0022330685 -0.0095898826 -0.0025662268 -12.165878 0 6.1752256 5.34614 0.30957174 0.30957174 5.7872902e-05 9.9247804e-05 +0.015595682 0.0004615971 -0.0017237815 0.0012149578 24.153463 0 2.2084515 4.4765527 0.30957174 0.30957174 2.8641493e-05 4.4598318e-06 +0.0032631826 -0.0016396867 0.0014710733 0.0027694946 8.260138 0 0.58939076 3.02425 0.30957174 0.30957174 2.5660164e-05 9.7897786e-06 +0.007955172 0.00051383888 0.0069700734 0.0044280789 -8.1333796 0 2.4769364 2.5073992 0.30957174 0.30957174 9.3523633e-06 6.8427288e-05 +-0.011272527 -0.0023899478 0.0099107543 -0.0065087146 17.472055 0 6.1797164 1.3677222 0.30957174 0.30957174 6.5980743e-05 0.00014104456 +-0.0065010086 -0.0011055768 0.0070395836 -0.010040248 18.033761 0 6.084273 0.98961008 0.30957174 0.30957174 1.5773909e-05 0.00014995117 +-0.018618081 -0.0017256019 -0.0006180249 -0.0016422038 -23.689797 0 5.7878621 0.011671914 0.30957174 0.30957174 6.5177328e-05 3.0600954e-06 +-0.0023916322 0.00034905251 0.0011155421 -0.0042500066 -24.101351 0 4.1607802 0.63299067 0.30957174 0.30957174 1.737779e-06 1.9171083e-05 +-0.0049364953 0.0003507495 -0.013692109 0.0010221507 20.301321 0 4.512255 5.0127752 0.30957174 0.30957174 3.795837e-06 0.00019003844 +0.0081189301 0.002856358 -0.0070871418 0.0016943868 16.585691 0 3.2134355 4.8538447 0.30957174 0.30957174 8.1557581e-05 5.3484756e-05 +0.0098040797 -0.0017993214 -0.00010878873 -0.00056253574 -12.101801 0 0.91335767 0.18174938 0.30957174 0.30957174 4.0043893e-05 3.2581917e-07 +-0.015339077 -0.0011393606 -0.00048723975 0.0032604616 12.547761 0 5.6815572 3.6654254 0.30957174 0.30957174 3.7654402e-05 1.078399e-05 +-0.020812735 0.0025369845 -0.0034331206 0.0019305582 9.7840066 0 4.2490288 4.5778877 0.30957174 0.30957174 0.00010618269 1.5579315e-05 +0.038754113 -0.0018135134 0.001363876 0.0037120599 1.9995831 0 1.542145 3.1611501 0.30957174 0.30957174 0.00019483121 1.5543292e-05 +0.014529984 -0.00045937634 0.0038468723 -0.0010571577 0.58959236 0 1.6646852 1.6789746 0.30957174 0.30957174 2.5098487e-05 1.6027606e-05 +-0.012648694 -0.0022357869 -0.00018142731 -0.0065160011 20.340123 0 6.1017317 0.34623731 0.30957174 0.30957174 6.3098594e-05 4.2148142e-05 +0.013789585 0.00046947351 -0.0023471891 -0.0066461407 -15.451172 0 2.245824 0.032250641 0.30957174 0.30957174 2.2882141e-05 4.9368231e-05 +0.0030843209 -0.00038221073 -0.0051211832 0.00080784379 -13.753743 0 1.0992514 4.9314777 0.30957174 0.30957174 2.3750562e-06 2.7087645e-05 +-0.0044259279 -8.7363125e-05 0.0039494887 0.0043732161 -16.956808 0 5.2645976 2.7773231 0.30957174 0.30957174 2.2199294e-06 3.4695993e-05 +0.0015815533 -0.0014233561 0.0038366689 -0.0065110929 11.691327 0 0.49567869 0.91033667 0.30957174 0.30957174 1.8729661e-05 5.6891559e-05 +-0.023109255 0.00074962754 0.0021249195 0.0031484989 9.7661992 0 4.7993718 2.9184422 0.30957174 0.30957174 6.3743988e-05 1.438498e-05 +-0.026546317 -0.0011411533 0.00031766833 0.0035523792 13.395379 0 5.4599222 3.4259829 0.30957174 0.30957174 8.9223119e-05 1.2619095e-05 +0.011556483 -0.00085629206 0.0075129651 -0.0063185984 11.104556 0 1.3513671 1.249832 0.30957174 0.30957174 2.1340294e-05 9.650663e-05 +0.011671209 0.001469818 0.0018291337 -0.0023761765 17.737836 0 2.7989389 1.0342693 0.30957174 0.30957174 3.4633086e-05 8.9735638e-06 +-0.018045764 -0.00083076938 -0.0059289415 -0.0089702306 -1.6514537 0 5.4837787 6.0697053 0.30957174 0.30957174 4.2035924e-05 0.00011525331 +-0.032103972 -0.00061863949 -0.0023775142 -0.00020455677 -8.8348264 0 5.2604555 5.1718253 0.30957174 0.30957174 0.0001166296 5.7401577e-06 +0.014337988 0.00016110568 -0.0047729181 0.0048934772 2.2582351 0 2.0470969 4.2928782 0.30957174 0.30957174 2.2804159e-05 4.6718944e-05 +-0.014021768 0.0012445071 -0.0015587167 0.0076563169 -11.584013 0 4.4067832 3.7183269 0.30957174 0.30957174 3.5691838e-05 6.0594604e-05 +-0.0071932013 -0.00095886086 -0.0036146595 0.0015686965 8.8462094 0 5.9685625 4.6801923 0.30957174 0.30957174 1.4055387e-05 1.5613183e-05 +-0.024944217 -0.0028539611 0.0028361387 0.0014228597 14.748665 0 5.8927666 2.4068484 0.30957174 0.30957174 0.00014250151 1.0117413e-05 +-0.0087521418 0.0023043979 0.0021804785 -0.0030395165 -9.5319055 0 3.9109125 1.0004438 0.30957174 0.30957174 5.6781982e-05 1.3957202e-05 +0.027469409 0.00064838747 0.00017306057 0.0029805438 -5.7466694 0 2.1568896 3.4574229 0.30957174 0.30957174 8.6663897e-05 8.8420036e-06 +-0.012862142 -0.00078306897 -0.0042023344 -0.004313265 20.573754 0 5.5930529 5.8810551 0.30957174 0.30957174 2.3746767e-05 3.6257395e-05 +0.025096027 -0.00022953263 -0.00058078713 -0.0046527013 5.8774863 0 1.8619726 0.24911286 0.30957174 0.30957174 6.9618642e-05 2.1812653e-05 +-0.008108942 7.2281137e-05 0.0035782314 -0.0076858363 18.145002 0 5.0056682 0.81313429 0.30957174 0.30957174 7.2659722e-06 7.1502544e-05 +-0.015529194 -0.0012626703 -0.001615766 0.0028312547 -0.064907541 0 5.7241978 4.0379836 0.30957174 0.30957174 4.0996776e-05 1.0583168e-05 +-0.0051761898 0.002456773 -0.0030573504 -0.0010685224 20.644358 0 3.743186 5.4203917 0.30957174 0.30957174 5.7923019e-05 1.0556097e-05 +-0.016175947 0.0023143476 -0.0036732098 -0.0066561012 9.8789552 0 4.1703603 6.1497766 0.30957174 0.30957174 7.7516076e-05 5.7547907e-05 +0.0058819564 0.0010101713 0.0011406087 -0.00065126783 -0.5468739 0 2.9471461 1.4297753 0.30957174 0.30957174 1.3093628e-05 1.7323137e-06 +-0.023284021 0.0035027769 0.00081171231 -0.014723494 10.383781 0 4.1462887 0.42982297 0.30957174 0.30957174 0.00017128213 0.00021569265 +-0.015152836 -0.0032193054 -0.0010626904 -0.0063799754 24.99281 0 6.1805631 0.20792816 0.30957174 0.30957174 0.00011961464 4.1513475e-05 +0.022640893 0.00012951797 -0.004116691 0.0040613181 -22.39464 0 1.99716 4.3121207 0.30957174 0.30957174 5.64256e-05 3.3446228e-05 +0.0020090986 0.00114086 0.0022390894 -0.0015287053 16.820385 0 3.3249271 1.349827 0.30957174 0.30957174 1.2299527e-05 7.3724339e-06 +-0.016764561 -0.0017053164 0.007832549 -0.0064949468 9.165865 0 5.8340181 1.2567739 0.30957174 0.30957174 5.7343895e-05 0.00010369216 +0.010693708 0.00026715709 0.004306073 -0.0065808435 -14.373944 0 2.1688618 0.95744233 0.30957174 0.30957174 1.3203755e-05 6.1650739e-05 +-0.0076693694 -0.0038102397 0.00059654393 -0.0016120361 2.5899828 0 0.15683203 0.73138028 0.30957174 0.30957174 0.00013870626 2.9364135e-06 +0.022664757 7.0264346e-05 0.0017277967 -0.0010167616 -5.81207 0 1.9733296 1.4167377 0.30957174 0.30957174 5.6436453e-05 4.0350619e-06 +0.0098608156 0.00067886763 0.007325378 -0.0024592581 -15.328248 0 2.5052296 1.6236434 0.30957174 0.30957174 1.48724e-05 6.0097644e-05 +-0.0024344159 -0.00036182919 0.001258657 -0.0004725272 22.300479 0 6.021328 1.5886195 0.30957174 0.30957174 1.8431832e-06 1.8186082e-06 +-0.01224851 0.0010423076 -0.0061538471 0.0054893739 14.570429 0 4.4272681 4.3623299 0.30957174 0.30957174 2.6365875e-05 6.8068114e-05 +-0.0023241743 0.00089232823 -0.0059442488 -0.0097553063 -24.793361 0 3.7943894 6.1066162 0.30957174 0.30957174 7.8463301e-06 0.00013001863 +-0.011753524 -0.001823576 0.0027248459 0.001593172 -24.494375 0 6.0417122 2.4706472 0.30957174 0.30957174 4.5457769e-05 1.0002984e-05 +0.012931876 0.0021391438 -0.0084573261 0.007442218 4.1470246 0 2.9299883 4.3690739 0.30957174 0.30957174 6.0042309e-05 0.00012704819 +0.019784104 -0.0002241072 -0.003436099 0.0074014612 -12.625381 0 1.8422728 3.9536394 0.30957174 0.30957174 4.3425409e-05 6.6241694e-05 +0.020205316 -0.0002787924 -3.7194063e-06 -0.0087157353 10.635944 0 1.8200614 0.37387004 0.30957174 0.30957174 4.5525012e-05 7.5349821e-05 +0.011239889 0.0014467148 -0.0015040245 -0.0051874023 -10.96195 0 2.8097264 0.089921281 0.30957174 0.30957174 3.2934464e-05 2.8972088e-05 +0.0031074165 0.00051117144 -0.0017469735 0.0024354904 -15.81081 0 2.9274274 4.1419846 0.30957174 0.30957174 3.4402566e-06 8.9604463e-06 +-0.017532551 -0.00012753905 0.0001185322 0.0056811887 21.6817 0 5.1528579 3.494862 0.30957174 0.30957174 3.3892562e-05 3.202909e-05 +-0.035398082 -0.0012328915 0.001485852 -0.0035181747 -24.959071 0 5.393917 0.77683042 0.30957174 0.30957174 0.00015139968 1.4503223e-05 +-0.0021200436 -0.00073109046 -0.012921844 -0.0061841159 -12.896022 0 0.066107976 5.5298999 0.30957174 0.30957174 5.3623025e-06 0.00020626924 +0.02935586 0.0015241492 -0.0057530495 0.0060117977 -9.9985767 0 2.3868764 4.2833574 0.30957174 0.30957174 0.0001157635 6.9216857e-05 +0.011518005 -0.00014542295 -0.0055477942 0.00047188375 -10.966065 0 1.8305874 5.0025185 0.30957174 0.30957174 1.4756148e-05 3.124979e-05 +0.020227923 0.00019262648 0.0040353643 -0.0024593006 15.531006 0 2.0316268 1.4013681 0.30957174 0.30957174 4.5255332e-05 2.2416165e-05 +-0.0028802686 -0.0020103734 -0.0042397232 -0.0060112501 -6.8891059 0 0.21830032 6.0393836 0.30957174 0.30957174 3.7727174e-05 5.3964726e-05 +-0.004957661 0.0021704528 -0.0044579051 -0.001334204 0.42017404 0 3.7615756 5.3752715 0.30957174 0.30957174 4.5611191e-05 2.1800625e-05 +0.013232617 0.0005879007 0.00041557283 -1.5620905e-05 18.821863 0 2.3296591 1.9078289 0.30957174 0.30957174 2.2370638e-05 1.7435064e-07 +0.026895074 -0.0012826173 -0.00160131 0.0035805104 22.299092 0 1.5352716 3.9394745 0.30957174 0.30957174 9.4392542e-05 1.530149e-05 +0.00063150094 -0.001047672 -0.00031876199 0.004009165 -15.610213 0 0.44037378 3.5958784 0.30957174 0.30957174 1.0042382e-05 1.6045874e-05 +0.001330618 -0.0012251982 0.0033569917 0.0018901331 -14.000852 0 0.4929627 2.4544355 0.30957174 0.30957174 1.3868548e-05 1.4904974e-05 +0.022653587 -0.0012963378 0.0031379625 0.0033216721 -12.670508 0 1.4645714 2.754873 0.30957174 0.30957174 7.1644138e-05 2.0871368e-05 +0.0026847877 -0.003473858 0.0061702706 -0.0069039576 -16.508139 0 0.45893925 1.1076759 0.30957174 0.30957174 0.00011072041 8.5661817e-05 +-0.01500596 -0.0019977067 -0.0052632605 -0.0054863653 -18.844625 0 5.9679235 5.8887826 0.30957174 0.30957174 6.1073451e-05 5.7784549e-05 +-0.0019016126 -0.001136361 -0.0049448496 0.0034313605 16.039192 0 0.19262255 4.4838486 0.30957174 0.30957174 1.2160055e-05 3.6329891e-05 +0.011295335 -0.0020348403 0.0038441848 -0.0034733837 -6.1657945 0 0.92158005 1.2143647 0.30957174 0.30957174 5.172391e-05 2.6865066e-05 +0.028678927 -0.00039894122 0.013477675 -0.0089054126 -18.154016 0 1.8190514 1.3649275 0.30957174 0.30957174 9.173927e-05 0.00026179359 +-0.012033885 -0.00080033783 -0.00052984841 0.0019176656 1.5594303 0 5.63139 3.7875574 0.30957174 0.30957174 2.1732214e-05 3.9307339e-06 +-0.0073456029 -0.00084665205 0.0048757901 0.0075885642 -19.479097 0 5.8964462 2.941097 0.30957174 0.30957174 1.2453115e-05 8.1087796e-05 +0.013392993 0.0026308773 0.0049912545 0.007864609 -1.4937164 0 3.0062872 2.9467067 0.30957174 0.30957174 8.2741639e-05 8.6467651e-05 +0.0076942391 0.00217764 -0.0037948095 -0.0029884499 0.39352329 0 3.1458833 5.7498253 0.30957174 0.30957174 4.9696665e-05 2.3376588e-05 +0.01534735 -0.0027938908 -0.0015880317 -0.0020426135 12.579918 0 0.91694105 5.9927081 0.30957174 0.30957174 9.6963207e-05 6.6809357e-06 +-0.0042322472 0.0011887885 -0.004368548 0.0030819593 15.658015 0 3.8884613 4.4761084 0.30957174 0.30957174 1.4839853e-05 2.8661451e-05 +0.00414203 0.00049234684 0.0087929895 0.0022099092 -14.320932 0 2.7702261 2.1894108 0.30957174 0.30957174 4.0915416e-06 8.2791143e-05 +-0.0075110638 -0.0022364609 0.0015180071 0.0074419507 7.4421639 0 0.021080472 3.3130778 0.30957174 0.30957174 5.1756078e-05 5.7257944e-05 +0.027421408 0.0024714139 -0.0026952758 0.0013128321 -13.8074 0 2.6325133 4.636614 0.30957174 0.30957174 0.00013818405 9.0333221e-06 +-0.012634826 -9.7026765e-05 0.0032906807 -0.0083748902 -3.4286288 0 5.1565292 0.7514619 0.30957174 0.30957174 1.7610427e-05 8.0488505e-05 +-0.0047501402 -0.0011717897 -0.0069406367 0.0058330635 6.0987611 0 6.2387905 4.391778 0.30957174 0.30957174 1.4984994e-05 8.231464e-05 +-0.032209112 -0.0025393207 0.002100548 0.00019795615 2.0086258 0 5.7095063 2.038304 0.30957174 0.30957174 0.00017262423 4.4871398e-06 +0.0086289144 0.00028325437 -0.0016314669 0.0087997574 3.3628215 0 2.2356597 3.7006713 0.30957174 0.30957174 8.9046664e-06 7.9492976e-05 +-0.00086543569 0.00053830893 0.0037014884 -0.0011608926 22.739807 0 3.6905818 1.6434944 0.30957174 0.30957174 2.721904e-06 1.5149479e-05 +-0.020994272 -0.0010178586 0.0028136553 -0.0043269052 4.7060584 0 5.5025752 0.95458156 0.30957174 0.30957174 5.7822891e-05 2.6551916e-05 +0.0017691934 -0.0016485354 -0.0076169968 0.00020621656 -10.633288 0 0.49157139 5.0598414 0.30957174 0.30957174 2.5099878e-05 5.8533777e-05 +0.022500235 0.0016484687 -0.0090518082 0.0062849296 -6.8153738 0 2.5336026 4.4835777 0.30957174 0.30957174 8.0330031e-05 0.0001217841 +-0.034224328 0.00033868654 -0.0037623602 -0.00080440976 7.8322541 0 4.9967852 5.2956687 0.30957174 0.30957174 0.00012962722 1.4912589e-05 +-0.014487408 0.0036206196 0.0056104257 0.0020631895 -24.384095 0 3.9297775 2.2948672 0.30957174 0.30957174 0.00014245433 3.59558e-05 +0.0052338613 -0.0018768517 -0.0011173998 0.0056093715 22.67469 0 0.6713699 3.7140827 0.30957174 0.30957174 3.5095593e-05 3.2469386e-05 +-0.0011259644 0.00023922868 -0.0036891491 -0.0030554601 14.191959 0 3.9927964 5.7744223 0.30957174 0.30957174 6.6050775e-07 2.2981113e-05 +0.019971827 -0.0012080051 -0.00061141325 0.0062039465 2.9900896 0 1.4414976 3.6149236 0.30957174 0.30957174 5.708027e-05 3.8554609e-05 +-0.0035373123 -0.0026150785 0.00091294726 -0.0046889 10.315602 0 0.22688648 0.56812706 0.30957174 0.30957174 6.3669302e-05 2.2648276e-05 +-0.013729272 0.00091823506 0.0027836135 0.00073104593 6.7150426 0 4.5394966 2.1999341 0.30957174 0.30957174 2.8372809e-05 8.3417748e-06 +-0.030754955 -0.002438437 0.0010387918 -0.0054587777 13.624963 0 5.7121899 0.56384597 0.30957174 0.30957174 0.00015799859 3.0645194e-05 +-0.033958584 0.0017008707 0.0069478861 0.0068915934 -18.039853 0 4.6586435 2.7223682 0.30957174 0.30957174 0.0001529463 9.5776662e-05 +0.016944274 -0.00034273798 -0.0044272059 0.00076808495 5.6790296 0 1.7628817 4.9162693 0.30957174 0.30957174 3.258797e-05 2.0345112e-05 +0.0055380303 0.0006452374 0.012326552 -0.00093585347 3.6404625 0 2.7602414 1.8699306 0.30957174 0.30957174 7.1593548e-06 0.00015405124 +0.031493567 0.0014931845 -0.0077131606 -0.010270898 20.864155 0 2.3527946 6.0094596 0.30957174 0.30957174 0.00012919201 0.00016461617 +-0.018543322 0.0001730128 -0.0032784536 0.0043405043 -1.7670465 0 5.0019008 4.1666967 0.30957174 0.30957174 3.8020022e-05 2.9523516e-05 +-0.035013979 0.0019047075 0.0058905485 0.0071196473 17.106689 0 4.626619 2.8206966 0.30957174 0.30957174 0.00016763227 8.5260926e-05 +0.010958564 -0.00042462071 0.0047565898 0.0006500373 13.902749 0 1.6057795 2.0798307 0.30957174 0.30957174 1.4825578e-05 2.3228714e-05 +-0.00085354378 -0.0022363403 -0.0036277856 -0.00014625048 23.914692 0 0.33242619 5.126656 0.30957174 0.30957174 4.5637957e-05 1.3289329e-05 +-0.014926284 -0.00028587886 -0.00060431854 -0.0079941889 7.6421173 0 5.2594199 0.29823634 0.30957174 0.30957174 2.5202131e-05 6.375849e-05 +-0.0065752925 -0.00042519838 -0.00298366 0.00364706 -22.29706 0 5.6190315 4.2055555 0.30957174 0.30957174 6.3930679e-06 2.2168293e-05 +0.02133985 0.0013757171 -0.0053313634 0.0049979714 -23.506502 0 2.4760918 4.3376059 0.30957174 0.30957174 6.7231639e-05 5.3432873e-05 +0.032971975 -5.7444309e-05 0.0060715542 0.0057247786 -11.847938 0 1.9292274 2.697055 0.30957174 0.30957174 0.00011937424 6.9672368e-05 +-0.012551485 0.00062493683 -0.0016333066 0.0001841598 -21.33225 0 4.6608832 4.9753111 0.30957174 0.30957174 2.0851874e-05 2.7230775e-06 +0.021326076 0.0019236258 -0.0074570673 0.0033747374 -17.108792 0 2.632913 4.6647536 0.30957174 0.30957174 8.3634501e-05 6.735792e-05 +-0.015388231 0.0025632222 0.0090661784 -0.005353771 -7.7765067 0 4.098599 1.4152236 0.30957174 0.30957174 8.5844524e-05 0.00011129673 +0.010374997 3.6658957e-05 0.00033617659 0.0012762068 -7.5555889 0 1.9772725 3.2563185 0.30957174 0.30957174 1.1828699e-05 1.7294702e-06 +-0.0160874 0.0024337064 -0.00013683749 -0.0059850225 -0.80201285 0 4.143629 0.35125465 0.30957174 0.30957174 8.2364947e-05 3.5549732e-05 +0.026600611 -0.00033870928 -0.0021497911 -0.0068892895 3.6605452 0 1.8296217 0.069510611 0.30957174 0.30957174 7.8722442e-05 5.1737812e-05 +0.010712529 -0.0007277744 0.0011261527 -0.0061943875 21.356898 0 1.3909237 0.55557243 0.30957174 0.30957174 1.742265e-05 3.9338736e-05 +9.7161783e-05 -0.00110574 -0.0046281897 0.0060749688 -7.8212333 0 0.38394612 4.1708502 0.30957174 0.30957174 1.1138715e-05 5.8201586e-05 +-0.013478143 -0.0032218574 -0.0020633249 -7.9515336e-05 -1.4730844 0 6.2269783 5.1248965 0.30957174 0.30957174 0.00011450078 4.2982859e-06 +0.014459779 0.00039048644 -0.00095964258 0.00547296 -5.2058647 0 2.1863059 3.6908573 0.30957174 0.30957174 2.4341741e-05 3.0639514e-05 +0.01283974 0.0017434711 -0.003686464 -0.0031109037 -7.7085984 0 2.8360211 5.7836161 0.30957174 0.30957174 4.5787412e-05 2.3300269e-05 +0.0026715498 0.0023950667 0.0015030657 0.0068813866 -20.898484 0 3.39405 3.2991467 0.30957174 0.30957174 5.3038021e-05 4.924821e-05 +0.0047498981 0.0015586293 -0.010860864 8.328695e-05 11.371258 0 3.1930535 5.0790829 0.30957174 0.30957174 2.4606378e-05 0.00011892681 +0.0023367744 0.0013454531 0.00072613647 0.0072536548 18.178162 0 3.3274941 3.4153112 0.30957174 0.30957174 1.7089633e-05 5.2721639e-05 +0.027906418 0.0033448381 -0.0025039111 -0.00214937 2.0391965 0 2.7743713 5.7920327 0.30957174 0.30957174 0.00018740601 1.0903115e-05 +-0.0013580471 -0.0011304852 -0.0018293433 -0.0066886116 -15.256777 0 0.24318222 0.10525483 0.30957174 0.30957174 1.1844215e-05 4.774956e-05 +0.002416149 -0.00016437276 -0.0013495642 0.0072875171 -5.3349174 0 1.3903039 3.7004661 0.30957174 0.30957174 8.8697431e-07 5.4514652e-05 +-0.0069571707 0.0015188924 0.0022982405 0.001610688 9.8615456 0 3.9817981 2.5525725 0.30957174 0.30957174 2.6329094e-05 7.8983051e-06 +-0.00093680885 0.0011760813 -0.00133772 0.003967751 1.590269 0 3.6031141 3.8435387 0.30957174 0.30957174 1.2696132e-05 1.7419834e-05 +-0.0011400412 -0.0017670691 -0.00038294967 0.00040765028 3.7512106 0 0.30359467 4.2741108 0.30957174 0.30957174 2.8587009e-05 3.1268096e-07 +0.021293372 -0.0016085628 0.002187631 -0.008614239 -24.383124 0 1.342369 0.62494182 0.30957174 0.30957174 7.3344012e-05 7.8429842e-05 +0.015388245 0.0022081475 0.0081995193 -0.0046532485 -18.836239 0 2.8628486 1.4323928 0.30957174 0.30957174 7.0411534e-05 8.9257819e-05 +0.022858741 0.0013389589 0.00519672 0.0037982279 2.4549938 0 2.4352498 2.5723914 0.30957174 0.30957174 7.3692289e-05 4.153593e-05 +-0.0046249605 0.0013145574 0.0018465534 -0.0075704493 -22.886436 0 3.8844678 0.61542047 0.30957174 0.30957174 1.8089718e-05 6.0285842e-05 +0.013627019 0.00080787699 0.00084788952 0.00129542 10.679394 0 2.4402677 2.9326145 0.30957174 0.30957174 2.6330483e-05 2.3893211e-06 +0.019009386 0.00070638493 0.005831488 -0.0068912851 -22.62196 0 2.2714923 1.0805972 0.30957174 0.30957174 4.4214051e-05 8.1389277e-05 +-0.020333017 0.0017008151 0.0090147141 0.00156861 19.571819 0 4.4355645 2.1160112 0.30957174 0.30957174 7.1736626e-05 8.4368168e-05 +-0.043582516 -0.00029057958 0.0073030777 0.0011492223 23.719573 0 5.1473501 2.0999361 0.30957174 0.30957174 0.00020928351 5.5079751e-05 +-0.013224386 -0.0024666139 -0.0076663093 -0.0041472236 18.473469 0 6.1255254 5.5791811 0.30957174 0.30957174 7.4621409e-05 7.6311789e-05 +0.00067266269 0.0018712121 0.0051617093 0.0025743253 -18.392109 0 3.4764508 2.4044971 0.30957174 0.30957174 3.194556e-05 3.3433998e-05 +-0.0021054431 -0.00061905659 0.001325322 0.0032414786 11.713098 0 0.016970667 3.1249168 0.30957174 0.30957174 3.9776256e-06 1.2193021e-05 +0.014787897 -0.00091804775 0.0067348698 0.0012576881 -15.249942 0 1.4304164 2.1282534 0.30957174 0.30957174 3.1683731e-05 4.7297212e-05 +-0.024886527 -0.0016791783 0.00045351299 -0.011493498 15.03016 0 5.6378044 0.41405918 0.30957174 0.30957174 9.3674361e-05 0.0001312397 +0.018746253 9.847641e-05 0.001300083 0.0010779686 -2.2564588 0 1.9929128 2.633377 0.30957174 0.30957174 3.8666392e-05 2.8566146e-06 +0.025607052 0.00030461966 0.0061051326 -0.0041959597 -7.6740749 0 2.0530399 1.3467402 0.30957174 0.30957174 7.2828379e-05 5.50402e-05 +-0.0031333993 -0.00057038462 -0.0023939281 0.003349148 13.37978 0 6.1148204 4.1403202 0.30957174 0.30957174 4.0414435e-06 1.6903704e-05 +-0.029332693 0.00093662738 -0.0019862517 -0.0041665371 14.693561 0 4.8036266 6.209477 0.30957174 0.30957174 0.00010244427 2.1197017e-05 +-0.0093867445 0.0014935879 -0.0029224575 0.0052740287 8.5065701 0 4.1198183 4.0253449 0.30957174 0.30957174 2.9993798e-05 3.6200848e-05 +0.01783775 0.0010146964 -0.0099087819 0.002249223 5.3549766 0 2.423186 4.865225 0.30957174 0.30957174 4.4308521e-05 0.00010400243 +-0.036466534 0.0020429159 -0.0081641324 0.0042394661 -10.484464 0 4.6148178 4.6110501 0.30957174 0.30957174 0.00018400037 8.5024143e-05 +-0.039286099 -9.0748641e-05 -0.0025527342 0.0029097947 -17.74839 0 5.1077283 4.2400454 0.30957174 0.30957174 0.00016950457 1.4968016e-05 +0.002605347 0.0014018644 0.00032318885 0.0044903383 -20.13987 0 3.3146358 3.4434589 0.30957174 0.30957174 1.8647111e-05 2.0105404e-05 +-0.0042130908 -0.002034364 -0.00046083526 0.0040049124 17.811332 0 0.1507559 3.6313822 0.30957174 0.30957174 3.9648958e-05 1.6123732e-05 +0.02728678 -0.00073371295 0.0023796035 0.007421922 -0.79071618 0 1.7048844 3.2032611 0.30957174 0.30957174 8.6640373e-05 6.0348188e-05 +-0.0071551791 0.0046489017 -0.0010743221 -0.0018066738 -16.374244 0 3.6832712 6.1174425 0.30957174 0.30957174 0.00020249467 4.4012539e-06 +0.020989965 -0.0026192105 -2.8500766e-05 -0.00016429533 4.6604053 0 1.0958066 0.20116436 0.30957174 0.30957174 0.00011085812 2.7593611e-08 +0.0043869763 0.0013523686 -0.0020069452 0.0012872287 -11.841318 0 3.1737872 4.5200759 0.30957174 0.30957174 1.8772866e-05 5.7042228e-06 +-0.0056342604 0.00030298835 0.0095444749 0.0024882387 8.6364683 0 4.6311813 2.1981448 0.30957174 0.30957174 4.321117e-06 9.7980874e-05 +0.0089377446 -0.00048574363 -0.0012470828 0.0026365725 -10.35786 0 1.4853996 3.9608494 0.30957174 0.30957174 1.0918675e-05 8.4631988e-06 +0.011241051 0.00052048662 -0.0002729474 0.0021840918 22.429661 0 2.3442411 3.641222 0.30957174 0.30957174 1.6339344e-05 4.8067928e-06 +0.015646642 0.0016379455 0.0051873787 0.00092868749 -12.931325 0 2.706749 2.1208452 0.30957174 0.30957174 5.1314553e-05 2.798374e-05 +-0.0037509496 -0.0010005004 -0.00014836085 0.0021723634 -22.056205 0 6.2670518 3.5846358 0.30957174 0.30957174 1.0663016e-05 4.7031945e-06 +-0.0013010728 -2.0138694e-05 -0.00098993258 0.0029174219 7.882167 0 5.2267656 3.845498 0.30957174 0.30957174 1.8952391e-07 9.4304838e-06 +0.0091787967 0.0010020076 -0.00062120898 0.0045182714 -15.079567 0 2.7277017 3.6536243 0.30957174 0.30957174 1.8394736e-05 2.0638751e-05 +0.020259352 -0.0012129461 0.005385601 0.011034874 -1.5825681 0 1.4458021 3.0586406 0.30957174 0.30957174 5.8459078e-05 0.00015002497 +-0.0071001679 0.0029476914 -0.00071521909 0.0010970957 12.21381 0 3.7743987 4.0973373 0.30957174 0.30957174 8.4684443e-05 1.709595e-06 +-0.0060657486 -0.0011389116 0.0027488238 -0.0013260706 21.433612 0 6.1284195 1.4987858 0.30957174 0.30957174 1.5855009e-05 9.3618719e-06 +-0.0048040233 -0.0013208484 0.00044563564 -0.0037912709 24.326537 0 6.2776112 0.49225095 0.30957174 0.30957174 1.8426091e-05 1.4457721e-05 +0.0071177252 -0.00120085 0.0069877735 -0.0020156044 3.0624776 0 0.95114952 1.6664265 0.30957174 0.30957174 1.8697615e-05 5.3256833e-05 +0.0025185412 0.0030263734 0.00072183484 0.0042769926 3.5824953 0 3.4247896 3.3473595 0.30957174 0.30957174 8.4128516e-05 1.8670047e-05 +0.0019102519 -0.00045126493 -0.00082014571 0.0023353428 24.081788 0 0.80930925 3.8561724 0.30957174 0.30957174 2.2556169e-06 6.0878495e-06 +0.032833724 -0.00065866695 -0.00049821523 0.0032188119 -16.445604 0 1.7643506 3.6706887 0.30957174 0.30957174 0.0001222975 1.0527216e-05 +0.0057325922 -0.00019239446 0.0017352374 -0.0052755785 11.353311 0 1.6483963 0.69449016 0.30957174 0.30957174 3.9447482e-06 3.0642279e-05 +0.024211761 0.0010545912 -0.0049076339 -0.0072570044 -16.769608 0 2.3228214 6.0590966 0.30957174 0.30957174 7.4483413e-05 7.6519483e-05 +-0.021871602 -0.00057798046 -0.0044809873 0.0035206571 -18.959009 0 5.3229196 4.4246766 0.30957174 0.30957174 5.5556782e-05 3.2537731e-05 +-0.011367043 -0.00010271629 0.0023326796 0.0059791627 -2.6900636 0 5.1688194 3.1411626 0.30957174 0.30957174 1.4280357e-05 4.0947065e-05 +-0.012739857 0.00099441218 0.0036342345 -0.0014072254 6.8039924 0 4.468596 1.5783869 0.30957174 0.30957174 2.6825098e-05 1.5279598e-05 +0.034953244 0.0021257732 0.0019614487 -0.0072551365 16.56231 0 2.4510138 0.6403938 0.30957174 0.30957174 0.00017528223 5.6090033e-05 +0.016214422 -9.3444979e-05 -0.0011236811 0.0019061125 -13.098614 0 1.8926467 4.0521256 0.30957174 0.30957174 2.8940735e-05 4.876839e-06 +0.0023550259 0.00071417948 -0.0012215957 0.00074203656 -14.834172 0 3.1685745 4.5444184 0.30957174 0.30957174 5.2550982e-06 2.050627e-06 +-0.029470525 -0.001525798 0.00032370617 0.0013623854 10.687095 0 5.5273812 3.2807835 0.30957174 0.30957174 0.00011654979 1.9467258e-06 +-0.0079786171 0.00098096619 0.0032964965 -7.1179262e-05 15.55135 0 4.244751 1.9236821 0.30957174 0.30957174 1.5754125e-05 1.0960499e-05 +0.0098677479 -3.1578587e-05 0.0072456661 0.0024594303 -22.662318 0 1.9159532 2.2698651 0.30957174 0.30957174 1.0698339e-05 5.8927531e-05 +0.025289953 -0.0011033247 0.0090436594 -0.0015957087 15.593878 0 1.5668209 1.7718332 0.30957174 0.30957174 8.1300439e-05 8.4980189e-05 +-0.0039702062 -0.00010208599 -0.0068584128 0.0037460136 7.6004248 0 5.316771 4.5901819 0.30957174 0.30957174 1.8252978e-06 6.1340421e-05 +0.017155873 -0.0020103336 4.7121972e-05 0.0049632425 -19.630356 0 1.1270894 3.5063216 0.30957174 0.30957174 6.9125012e-05 2.4436829e-05 +-0.01841533 0.00093369862 0.0040474151 -0.0048442191 -20.029835 0 4.6540116 1.0743219 0.30957174 0.30957174 4.5169547e-05 3.979182e-05 +0.0052544966 -0.00089073952 0.0036705427 0.0076634111 -10.304087 0 0.94897059 3.0660395 0.30957174 0.30957174 1.0258447e-05 7.1835715e-05 +0.0088762496 -0.00028023864 -0.0017251458 0.0063908838 -16.97112 0 1.6650555 3.7815974 0.30957174 0.30957174 9.3644818e-06 4.3513531e-05 +0.013807662 0.00032523897 0.0054031821 0.0032188081 15.349896 0 2.1564627 2.4788037 0.30957174 0.30957174 2.1892747e-05 3.9709314e-05 +-0.037230381 0.0017401276 -0.0011181326 -0.0026580368 5.8969492 0 4.6841689 6.2563858 0.30957174 0.30957174 0.00017974563 8.2684436e-06 +-0.0078303997 0.0014077373 -0.0064686923 0.0056228603 3.1138752 0 4.0640873 4.3751471 0.30957174 0.30957174 2.4783268e-05 7.3545995e-05 +-0.012383044 -0.0013096739 0.0067241086 -0.00057649238 1.4417226 0 5.8534689 1.8602588 0.30957174 0.30957174 3.2457999e-05 4.5911865e-05 +-0.0014513278 -8.2819355e-05 -0.0080978191 0.0057009663 -20.875483 0 5.5660687 4.4770917 0.30957174 0.30957174 2.9371068e-07 9.8347443e-05 +0.015283191 0.0011249041 0.001540188 0.0048848772 8.1035344 0 2.5357391 3.2081257 0.30957174 0.30957174 3.7168353e-05 2.6060596e-05 +-0.023517002 -0.0012639883 -0.0024144457 -0.0029058868 4.7645576 0 5.5419899 5.9602028 0.30957174 0.30957174 7.5265843e-05 1.4252969e-05 +0.016013545 0.00030985298 -0.012113946 -0.0012950778 8.804857 0 2.1195658 5.192338 0.30957174 0.30957174 2.9025092e-05 0.0001496076 +0.025464976 -0.00019458809 -0.001404412 -0.0031681345 -5.2217578 0 1.8756003 6.237207 0.30957174 0.30957174 7.1531462e-05 1.1944369e-05 +-0.035200183 0.0008365089 -0.0030168857 0.0002017401 -8.563374 0 4.8735006 5.0204567 0.30957174 0.30957174 0.00014239376 9.2161636e-06 +0.028195612 -0.00065194831 -0.0010538769 -0.00048180835 6.1261969 0 1.7375011 5.5124337 0.30957174 0.30957174 9.1143708e-05 1.3499726e-06 +-0.0062569204 0.0020604587 0.0060720116 0.0049481697 10.572295 0 3.8376637 2.6248932 0.30957174 0.30957174 4.2971434e-05 6.1456281e-05 +-0.015583813 0.00073490064 -0.0017878647 0.012462095 22.15158 0 4.6809461 3.6595306 0.30957174 0.30957174 3.15797e-05 0.00015727057 +0.0041688218 0.00027649829 -0.0026295234 0.00068594459 -14.824679 0 2.4885854 4.8334892 0.30957174 0.30957174 2.6042464e-06 7.4374731e-06 +-0.0021428674 0.00042526166 0.0054543207 0.0086359552 6.6759463 0 4.0211587 2.948902 0.30957174 0.30957174 2.1514907e-06 0.00010396881 +-0.013502175 0.0037384788 0.0073174259 -0.001559783 -18.915426 0 3.8933602 1.736729 0.30957174 0.30957174 0.00014732799 5.6394458e-05 +0.0017613117 8.0180792e-05 0.0047130546 -0.012234233 7.1352542 0 2.3382016 0.7447454 0.30957174 0.30957174 3.9911608e-07 0.00017086015 +-0.011284586 -0.0015046755 -0.0060216637 -0.0047350254 10.963165 0 5.9687024 5.7490991 0.30957174 0.30957174 3.4603279e-05 5.8795198e-05 +0.014271095 -0.00018739514 -0.0012386135 0.003309964 -23.007814 0 1.8260461 3.8766417 0.30957174 0.30957174 2.2677531e-05 1.2413943e-05 +0.0013682441 -0.0007094407 -0.0084832454 0.0038992503 -23.334327 0 0.58293781 4.6589192 0.30957174 0.30957174 4.7903176e-06 8.7633313e-05 +0.0015108797 -0.0013693354 0.0021077665 -0.0047622646 -6.166828 0 0.49483742 0.79399418 0.30957174 0.30957174 1.7331399e-05 2.6974678e-05 +-0.013457886 0.0016048625 0.0020137634 0.0097887685 -0.77365236 0 4.2599497 3.3113933 0.30957174 0.30957174 4.334419e-05 9.9133502e-05 +0.01238455 0.00042714624 -0.004587901 -0.0080648406 7.5287166 0 2.2495155 6.1367686 0.30957174 0.30957174 1.8499317e-05 8.5736158e-05 +-0.0015010067 0.0040948092 -0.001738796 -0.004425102 -3.8416252 0 3.5561114 6.2803092 0.30957174 0.30957174 0.00015298846 2.2471251e-05 +0.001004869 -0.00020555366 0.011244888 -0.0017492616 1.2561917 0 0.86684048 1.7920012 0.30957174 0.30957174 4.9574081e-07 0.00013051346 +0.0090979762 0.0029928363 -0.0021441856 -0.0074282392 -0.31389923 0 3.1938007 0.09111485 0.30957174 0.30957174 9.0679907e-05 5.9367579e-05 +2.4477011e-05 0.0025133125 0.0027248806 0.0057879033 9.2969096 0 3.5148238 3.0727492 0.30957174 0.30957174 5.7541629e-05 4.071445e-05 +0.0071297603 -0.00079993767 -0.0084782596 -0.0078965573 9.9781627 0 1.1487967 5.8325302 0.30957174 0.30957174 1.1409439e-05 0.00013431826 +0.0030667126 -0.00070803946 -0.0034958762 -0.00084979659 -6.9671456 0 0.81813544 5.3232928 0.30957174 0.30957174 5.5991343e-06 1.3037089e-05 +-0.018885988 -0.0004448571 -0.0063961112 -0.0072715879 -20.867131 0 5.2980546 5.9320262 0.30957174 0.30957174 4.0958043e-05 9.3692172e-05 +0.012370334 -0.0039038758 -0.00060426141 -0.0022218872 -9.1805531 0 0.70906185 0.10670067 0.30957174 0.30957174 0.00015562779 5.2649727e-06 +0.0083616499 0.00071006287 0.0033464779 -0.0033315418 18.416989 0 2.6035058 1.1659942 0.30957174 0.30957174 1.2268149e-05 2.2299629e-05 +0.013636642 0.0018580239 0.0035892242 0.0008456233 8.5697831 0 2.8376926 2.174672 0.30957174 0.30957174 5.186178e-05 1.3696843e-05 +0.0013918237 -0.00017630239 0.0052534049 -0.0032306255 12.345059 0 1.0883742 1.3973668 0.30957174 0.30957174 4.9579956e-07 3.8175788e-05 +-0.012349908 -0.0016042729 0.0042060484 -0.0025708394 -11.698206 0 5.9558559 1.4000707 0.30957174 0.30957174 4.0187938e-05 2.4390829e-05 +-0.011744646 -0.0017335361 -0.007929449 -0.0054556894 -4.7894509 0 6.018006 5.6855499 0.30957174 0.30957174 4.2517298e-05 9.2912589e-05 +-0.0050587075 -0.0020389667 0.0010123699 0.0035420426 8.9804465 0 0.10839159 3.2353473 0.30957174 0.30957174 4.068044e-05 1.3477867e-05 +0.0084688584 0.00034933445 -0.00893289 -0.0003240462 -3.6991625 0 2.3045294 5.122656 0.30957174 0.30957174 8.9850364e-06 8.0551165e-05 +0.011767565 0.0016166536 0.0049018751 0.013891281 24.741365 0 2.8417237 3.1741041 0.30957174 0.30957174 3.9009416e-05 0.00021563164 +0.01162474 9.3573134e-05 0.00069313566 -0.0032328654 22.156832 0 2.0182914 0.58717598 0.30957174 0.30957174 1.491443e-05 1.0851264e-05 +-0.017193866 0.00054491304 -0.0052686644 0.006342781 -22.634409 0 4.8056341 4.213042 0.30957174 0.30957174 3.5158116e-05 6.7890678e-05 +0.01290707 0.00022604246 0.0060554094 -0.0011230733 3.4576672 0 2.1032967 1.7631643 0.30957174 0.30957174 1.8753464e-05 3.8217988e-05 +0.0074396144 -0.00021421599 -0.00019163048 -0.002458397 -13.089348 0 1.68858 0.29587665 0.30957174 0.30957174 6.4939376e-06 6.0318687e-06 +-0.010530158 0.0001801455 -0.0036582177 -2.6486871e-06 -5.4779554 0 4.9320934 5.0874074 0.30957174 0.30957174 1.2468157e-05 1.3491656e-05 +0.01153541 -0.0027869009 0.011225085 0.0040976904 -19.858421 0 0.80079379 2.2925064 0.30957174 0.30957174 8.5358406e-05 0.00014368497 +-0.0047169043 -0.00030409428 0.0075124865 0.00072342574 -8.5386853 0 5.6176979 2.0403255 0.30957174 0.30957174 3.2848232e-06 5.7416633e-05 +-0.014788817 -0.0017188646 0.0028304922 0.0040664592 -15.415511 0 5.9006204 2.9040053 0.30957174 0.30957174 5.0922841e-05 2.4479377e-05 +0.0030860445 -0.00098468247 -0.00061432708 -0.0045280409 17.530797 0 0.70566161 0.23836609 0.30957174 0.30957174 9.8779277e-06 2.0717843e-05 +0.00014645993 -0.0012125922 0.002568005 -0.004116767 -19.62696 0 0.38755863 0.93568246 0.30957174 0.30957174 1.3396599e-05 2.3459141e-05 +-0.010676766 0.0038650347 -0.0038902747 -0.0036103476 20.61015 0 3.8103267 5.8307374 0.30957174 0.30957174 0.00014859421 2.8186822e-05 +0.018207157 0.00056821378 -0.0050070732 0.0049622782 19.977662 0 2.222077 4.3098433 0.30957174 0.30957174 3.9332252e-05 4.970025e-05 +-0.025842719 0.0017895983 0.0040854616 0.0060768877 -15.405269 0 4.5239151 2.920239 0.30957174 0.30957174 0.0001024884 5.3457022e-05 +0.018484001 -0.0013454741 -0.0082203516 -0.00039339504 22.786876 0 1.359579 5.1341229 0.30957174 0.30957174 5.399693e-05 6.8278539e-05 +0.0025788244 0.0039399296 -0.00049510026 0.0015241554 17.729181 0 3.4441632 3.8323697 0.30957174 0.30957174 0.00014213532 2.5513884e-06 +-0.0015810198 -0.0014187721 0.0009391008 -0.0025292947 -1.7682753 0 0.25257422 0.73247137 0.30957174 0.30957174 1.8610797e-05 7.2347031e-06 +-0.021046567 -0.0021511418 -0.0016286117 -0.0053125874 -19.118721 0 5.8364006 0.074555928 0.30957174 0.30957174 9.0779429e-05 3.066937e-05 +-0.012851431 -0.0007422653 -0.0012089224 -0.0054504257 7.1836196 0 5.5710248 0.15430791 0.30957174 0.30957174 2.3149571e-05 3.094034e-05 +0.010452548 -0.001089566 -0.0085197998 -0.00061134474 21.347311 0 1.1855679 5.157745 0.30957174 0.30957174 2.2808002e-05 7.3549422e-05 +0.0050707534 -0.0012939826 0.0053585438 -0.0027158338 -12.215635 0 0.78055456 1.4792714 0.30957174 0.30957174 1.8075303e-05 3.6264176e-05 +-0.025672776 -0.00087491463 -0.0026212119 -0.0063063852 -7.3947615 0 5.3876988 6.2606804 0.30957174 0.30957174 7.9326082e-05 4.6375675e-05 +0.0027601923 0.00067624987 0.0066147806 0.0011123545 -10.003464 0 3.0946472 2.1103772 0.30957174 0.30957174 5.0021982e-06 4.5339334e-05 +0.017214708 -0.00064095949 0.0059024447 0.0067112173 4.0915634 0 1.6181008 2.7904977 0.30957174 0.30957174 3.6274388e-05 7.9799099e-05 +-0.0091108211 0.00035198345 0.0046407087 -0.0031069508 -6.6776177 0 4.7482982 1.3588829 0.30957174 0.30957174 1.0240848e-05 3.1286824e-05 +0.012709992 -0.0010412132 -0.0023175499 -9.4766706e-05 -5.9704595 0 1.3040012 5.1272273 0.30957174 0.30957174 2.7609507e-05 5.4237293e-06 +0.0091150315 0.00029080564 -0.00041389637 0.0015562684 -23.153471 0 2.2279307 3.7778539 0.30957174 0.30957174 9.8910508e-06 2.5750943e-06 +0.013868303 -0.0022391275 -0.0017111584 0.0011176605 16.094299 0 0.97142011 4.5118067 0.30957174 0.30957174 6.6784998e-05 4.1909966e-06 +-0.011540197 0.001615573 0.0072483357 0.00043310206 15.869831 0 4.1808929 2.0042961 0.30957174 0.30957174 3.8395845e-05 5.3152712e-05 +0.0064506613 -0.00029964431 0.0011665496 0.0050134162 -12.106465 0 1.5447972 3.2854768 0.30957174 0.30957174 5.385835e-06 2.6303041e-05 +-0.001133988 -0.001922689 0.0038975814 -0.0039752064 -13.349494 0 0.30964484 1.1538977 0.30957174 0.30957174 3.3816099e-05 3.0989466e-05 +-0.0023965421 0.00079463942 0.0063277396 0.0030559347 21.073713 0 3.8356095 2.391834 0.30957174 0.30957174 6.3826271e-06 4.9629914e-05 +0.0061861358 0.0011231216 -0.0031356845 -0.0074239705 18.184098 0 2.9720614 6.2549239 0.30957174 0.30957174 1.5691563e-05 6.4582353e-05 +-0.013395025 0.0033130127 -0.0042317962 -0.00038953619 16.448663 0 3.9336169 5.1777423 0.30957174 0.30957174 0.00011968193 1.8204594e-05 +-0.013250636 0.00071315053 -0.0028980328 0.00079231787 -14.192335 0 4.6308579 4.8218706 0.30957174 0.30957174 2.3907455e-05 9.0897491e-06 +-0.015132346 0.00096286675 0.0044037866 -0.002625451 -15.902652 0 4.5613846 1.4110545 0.30957174 0.30957174 3.3583018e-05 2.6388684e-05 +0.004991469 0.00079654258 -0.0031357703 -0.0031703778 -22.534493 0 2.9133282 5.873516 0.30957174 0.30957174 8.5147859e-06 1.9883234e-05 +0.015945187 0.0011579975 -0.0016010172 -0.004944036 -12.446491 0 2.5295527 0.058741407 0.30957174 0.30957174 4.0125984e-05 2.6829996e-05 +-0.010497805 0.0018731168 0.015866296 0.010310399 -13.270657 0 4.0674434 2.5176492 0.30957174 0.30957174 4.405871e-05 0.00035923622 +-0.011902925 -1.8475564e-05 -0.0013130379 0.0061725962 23.739064 0 5.1008278 3.7271477 0.30957174 0.30957174 1.5556273e-05 3.9530987e-05 +8.6969726e-05 0.001316022 -0.014227237 0.0066351287 3.6128438 0 3.5086384 4.6534091 0.30957174 0.30957174 1.5777487e-05 0.00024773326 +-0.0078710561 -0.0022206632 -0.0039441244 0.0031242558 20.400752 0 0.0032252853 4.420714 0.30957174 0.30957174 5.172255e-05 2.5364976e-05 +-0.0085462767 0.0017373164 -0.0043757103 -0.0023348169 23.948556 0 4.0110412 5.5734788 0.30957174 0.30957174 3.5512527e-05 2.4710213e-05 +-0.017575034 -0.0016621248 -0.0042113866 -0.0053377094 -20.505359 0 5.7978228 5.985544 0.30957174 0.30957174 5.9074219e-05 4.6141121e-05 +0.0053669835 -1.2251461e-05 -0.0036611177 -0.00058033787 -18.368521 0 1.9243052 5.2426446 0.30957174 0.30957174 3.1634401e-06 1.3847116e-05 +0.0058223018 -0.0035050892 0.0063986485 0.0073179351 -21.700686 0 0.55466901 2.7933896 0.30957174 0.30957174 0.00011563597 9.4395617e-05 +-0.0061358485 0.00037221452 -0.0033462563 0.011462912 11.720994 0 4.5818555 3.8021121 0.30957174 0.30957174 5.3950005e-06 0.00014162459 +0.0027798716 -0.00011858513 -0.0024903073 0.0064514985 0.50540561 0 1.574463 3.887012 0.30957174 0.30957174 9.7642215e-07 4.753747e-05 +-0.0064007327 0.0021901296 0.002885934 -0.00064914435 -1.3581958 0 3.8263461 1.7255769 0.30957174 0.30957174 4.8192149e-05 8.8144889e-06 +0.011063322 0.0031030012 -0.0054137244 0.0089664141 11.877907 0 3.1428269 4.0626849 0.30957174 0.30957174 0.00010114708 0.00010929383 +0.0093172646 -0.0013440706 -0.0013125537 0.0050469718 -21.558625 0 1.0247966 3.7723089 0.30957174 0.30957174 2.598622e-05 2.7002802e-05 +-0.00037145215 -0.00073069 -0.0051943677 0.0039717335 11.776066 0 0.31855207 4.4378081 0.30957174 0.30957174 4.8787147e-06 4.2848518e-05 +0.0069566103 -0.0015778194 -0.0026587654 0.0082641003 1.0324054 0 0.8250719 3.8295344 0.30957174 0.30957174 2.7990515e-05 7.4869785e-05 +-0.0021677062 0.00042273426 0.018075871 -0.0064465982 -19.571238 0 4.0285991 1.6050784 0.30957174 0.30957174 2.143721e-06 0.00037062319 +0.016485626 -0.0029901248 0.0010184352 -0.012995914 7.8925251 0 0.91856363 0.45314112 0.30957174 0.30957174 0.00011128027 0.0001685738 +0.0025622592 -0.0015082856 -0.003726175 -0.0013349332 -5.1702915 0 0.55867038 5.4281324 0.30957174 0.30957174 2.1443857e-05 1.57652e-05 +0.010081323 -0.00018976287 0.01066979 -0.010739598 -19.352562 0 1.7752803 1.1604972 0.30957174 0.30957174 1.1485001e-05 0.00022917881 +-0.018411212 0.0011426445 -0.0019885344 0.011310303 19.722824 0 4.5721374 3.6913203 0.30957174 0.30957174 4.9104941e-05 0.00013087509 +-0.028600285 -0.00010540008 0.0029407046 -0.001675557 11.885374 0 5.1202473 1.4306785 0.30957174 0.30957174 8.9896178e-05 1.1503028e-05 +0.0051122228 -0.0020941868 0.005147899 -0.0022803159 0.12052382 0 0.63613031 1.5311103 0.30957174 0.30957174 4.2819253e-05 3.1874689e-05 +0.031723623 -0.00051266035 -0.01042609 -0.0044201196 -19.590873 0 1.7989369 5.4847592 0.30957174 0.30957174 0.00011287241 0.00012896895 +0.03156169 -0.00071885492 0.00054380077 -0.0063258282 15.611413 0 1.7405222 0.46075018 0.30957174 0.30957174 0.00011406057 3.9990667e-05 +-0.0060296969 -3.2528248e-05 0.0015811844 -2.1573355e-05 1.3884741 0 5.1357919 1.931564 0.30957174 0.30957174 4.0008276e-06 2.5209865e-06 +-0.012607289 -0.00020017198 0.0017225054 0.0014865457 -23.041777 0 5.2303271 2.6530841 0.30957174 0.30957174 1.7813368e-05 5.1831613e-06 +-0.024776662 0.005355356 -0.0031288905 0.00046388242 -8.9469527 0 3.985829 4.9406768 0.30957174 0.30957174 0.00032864568 1.0083208e-05 +-0.015909354 0.0029909323 -0.0065347131 -0.0013561243 5.0898636 0 4.0444089 5.2897017 0.30957174 0.30957174 0.00010927492 4.487478e-05 +-0.0066314944 0.0021964072 0.00029489759 0.0089781333 -9.507375 0 3.8359419 3.4827911 0.30957174 0.30957174 4.8773129e-05 8.0042774e-05 +0.0027586513 0.00083778712 -0.011238666 0.0022938714 17.248822 0 3.169035 4.8869343 0.30957174 0.30957174 7.2291757e-06 0.00013255655 +-0.0012323767 -0.00059646084 -0.0050347759 -0.0065696525 23.592115 0 0.1512584 5.9996667 0.30957174 0.30957174 3.4075264e-06 6.8366953e-05 +0.013597312 -0.0013385145 -0.0051431999 -0.0022479933 -21.85574 0 1.2140945 5.4957765 0.30957174 0.30957174 3.6616881e-05 3.1680752e-05 +0.0052694802 0.0021613999 -0.0027561373 -0.0079002521 19.984508 0 3.2543861 0.036102078 0.30957174 0.30957174 4.5604039e-05 6.9567528e-05 +0.0011717153 0.0015006851 -0.0067115739 0.0054472392 -13.321326 0 3.4303895 4.4088729 0.30957174 0.30957174 2.0665539e-05 7.484491e-05 +-0.0094230938 0.0010079608 0.005066192 -0.0038287068 9.6454454 0 4.3142546 1.301835 0.30957174 0.30957174 1.9002605e-05 4.0415992e-05 +-0.018826026 0.00024358969 -0.0039453005 -0.0031492127 20.475953 0 4.9693645 5.7563883 0.30957174 0.30957174 3.9447595e-05 2.5529631e-05 +0.010602861 -0.0011207423 -0.0016072265 0.0049677814 13.915117 0 1.1786081 3.8311803 0.30957174 0.30957174 2.3783156e-05 2.7083536e-05 +-0.013003673 0.0023645467 0.0029277976 0.00015694181 10.40832 0 4.059037 1.9982172 0.30957174 0.30957174 6.9494063e-05 8.6663075e-06 +0.011388007 -0.00029646772 0.0027402944 0.0086289498 8.9480728 0 1.7122506 3.2060461 0.30957174 0.30957174 1.5037268e-05 8.1427138e-05 +-0.0079288251 0.0014298171 -0.0039501044 0.011008111 8.9685179 0 4.0627222 3.8630065 0.30957174 0.30957174 2.5524268e-05 0.0001359292 +0.0083753594 0.0015082098 0.011314123 -0.0078121573 -10.266843 0 2.9684362 1.3445801 0.30957174 0.30957174 2.8421559e-05 0.00018958922 +0.023057312 -0.0017202113 -0.0015832262 0.0026879051 24.758518 0 1.3481845 4.0517561 0.30957174 0.30957174 8.5317604e-05 9.6934535e-06 +0.0027387518 0.0019919403 -0.011363489 -0.0068256997 -24.815348 0 3.3660894 5.624024 0.30957174 0.30957174 3.6967834e-05 0.00017639496 +0.022413022 0.00031637823 0.006515279 -0.0033569447 11.942175 0 2.0729812 1.4726277 0.30957174 0.30957174 5.6057573e-05 5.3972852e-05 +-0.010919355 0.0041450719 -0.0029158519 0.00048008833 -22.792045 0 3.7973987 4.9248021 0.30957174 0.30957174 0.00016960282 8.8001214e-06 +0.0019157398 0.00030133437 -0.00029068488 -0.002124664 4.7528218 0 2.9065713 0.2372353 0.30957174 0.30957174 1.2300413e-06 4.5628824e-06 +-0.0029754198 0.0017937076 0.0035380987 3.0875996e-05 15.541296 0 3.6960184 1.9537525 0.30957174 0.30957174 3.0280259e-05 1.2621133e-05 +0.0049700346 3.3315262e-06 0.00065196263 0.00058966758 -4.9032446 0 1.9512027 2.6763275 0.30957174 0.30957174 2.7117295e-06 7.7341656e-07 +-0.027621888 -0.0021190714 -0.002999143 0.0077369712 -11.617054 0 5.6966397 3.8884413 0.30957174 0.30957174 0.00012466174 6.8444879e-05 +-0.0032906488 -0.003388785 0.0063790987 0.00048318096 -15.456779 0 0.26810335 2.0200876 0.30957174 0.30957174 0.00010579955 4.1256196e-05 +-0.014972869 0.0017851426 0.0013015844 0.0072318273 24.338238 0 4.2600565 3.3363986 0.30957174 0.30957174 5.3639718e-05 5.3584372e-05 +0.021192248 0.0004801602 -0.0085387371 0.0015761126 -19.255885 0 2.1486329 4.9056037 0.30957174 0.30957174 5.1402297e-05 7.5968422e-05 +-0.016043318 0.0017796499 -0.00021175173 0.0019498575 -5.0989056 0 4.2960769 3.6249424 0.30957174 0.30957174 5.7106084e-05 3.8164066e-06 +-0.010469049 -3.9146715e-05 -0.0067861311 0.00024870934 -13.091355 0 5.1207386 5.0503519 0.30957174 0.30957174 1.2045628e-05 4.6488333e-05 +0.0021066517 -0.0034411423 0.00033671237 0.0016330024 21.24799 0 0.44140435 3.3109387 0.30957174 0.30957174 0.00010835551 2.7594336e-06 +0.0046369716 0.0018873329 0.00033572843 0.0017971098 -13.510377 0 3.2524513 3.3297349 0.30957174 0.30957174 3.4808202e-05 3.3171218e-06 +0.022672096 -0.00059776664 0.0057423182 -0.00036935229 -7.2428173 0 1.7093857 1.8813819 0.30957174 0.30957174 5.9683012e-05 3.3378335e-05 +0.004742904 0.001301794 0.0090909634 0.0047641087 -8.5354985 0 3.1354235 2.4244674 0.30957174 0.30957174 1.7906814e-05 0.00010583253 +-0.0001543887 -0.0018017436 0.0082433409 -0.0017444636 -18.90555 0 0.36489392 1.7381908 0.30957174 0.30957174 2.9574203e-05 7.1525151e-05 +0.0046610291 -0.00057149597 -0.0015329016 -0.0039215882 5.1192834 0 1.1045256 6.2820979 0.30957174 0.30957174 5.3601183e-06 1.7623445e-05 +0.020126593 -0.00096124555 -0.0019593248 -0.0024471149 13.823437 0 1.534733 5.9783733 0.30957174 0.30957174 5.2885438e-05 9.8101979e-06 +0.007736798 -0.00097157903 0.010287236 0.0078897908 7.5189796 0 1.0926583 2.5954411 0.30957174 0.30957174 1.5169976e-05 0.00016843537 +0.0034075217 -0.003768227 0.0034225316 -0.0056636527 -6.8471585 0 0.47324494 0.9214743 0.30957174 0.30957174 0.00013062355 4.3626802e-05 +-0.014671165 0.0017783963 0.0059380331 -0.0018660666 -20.502457 0 4.2518059 1.6429265 0.30957174 0.30957174 5.2438906e-05 3.9001719e-05 +0.00098328443 -0.00034825182 0.00041831976 0.0043084535 -4.5163095 0 0.67486388 3.4183195 0.30957174 0.30957174 1.2109168e-06 1.8589093e-05 +0.020593657 0.0026041674 -0.0048333577 -0.0042477082 9.2585316 0 2.8009772 5.8036617 0.30957174 0.30957174 0.00010833323 4.1448915e-05 +0.0044112432 0.00025861092 -0.0015138049 -0.0044462624 -14.866502 0 2.4356046 0.043658353 0.30957174 0.30957174 2.7453894e-06 2.1919684e-05 +0.0049247567 -0.00061752221 -0.00065687865 -0.0035217312 -16.315056 0 1.093399 0.18842878 0.30957174 0.30957174 6.1361588e-06 1.2737312e-05 +-0.009578274 -0.0006690243 9.6005015e-05 0.0097842376 -1.6223199 0 5.6533537 3.506001 0.30957174 0.30957174 1.4148605e-05 9.4966527e-05 +-0.011096875 0.0019758842 0.0020624531 -0.0034560268 -23.596959 0 4.0683745 0.91592093 0.30957174 0.30957174 4.9082092e-05 1.6135931e-05 +0.011855505 0.00050239775 0.00032205242 0.0043131694 8.6433887 0 2.3134985 3.4407587 0.30957174 0.30957174 1.7728723e-05 1.8557568e-05 +-0.0035506018 0.00046528071 -0.00048465941 0.0010098783 -7.8622786 0 4.2132138 3.9665217 0.30957174 0.30957174 3.3559875e-06 1.2484173e-06 +0.005861193 0.00066509006 -0.0082616559 -0.0047490996 17.516224 0 2.7470509 5.6048998 0.30957174 0.30957174 7.8007185e-06 9.1182936e-05 +-0.00093337825 -0.0012471209 0.0034813919 -0.0043041902 -18.8596 0 0.29232439 1.05838 0.30957174 0.30957174 1.4263546e-05 3.0595143e-05 +0.016920362 0.0012282895 0.00057087233 -0.0019860605 6.1155417 0 2.5293547 0.65635722 0.30957174 0.30957174 4.5172277e-05 4.2410941e-06 +-0.020546669 0.00078818057 0.0041086576 -5.8597125e-05 14.70257 0 4.7505132 1.930951 0.30957174 0.30957174 5.2003078e-05 1.7022084e-05 +0.005545677 0.0021370973 -0.0010749673 0.00049689998 11.722064 0 3.2383771 4.6567819 0.30957174 0.30957174 4.4980348e-05 1.4098877e-06 +-0.012114996 -0.002074438 0.010063366 0.0024125755 5.5384817 0 6.0873837 2.1785603 0.30957174 0.30957174 5.531263e-05 0.00010787033 +-0.011114422 0.00070594123 -0.0071780895 -0.00030095409 5.5318385 0 4.5621618 5.1282531 0.30957174 0.30957174 1.8100478e-05 5.2034831e-05 +0.022684891 0.0021969554 0.0025187084 0.0005920706 -22.781087 0 2.667997 2.1741721 0.30957174 0.30957174 0.00010045915 6.7433191e-06 +-0.0033289174 -0.00041731901 -0.002356611 -0.00578976 -19.035524 0 5.9382697 6.2680897 0.30957174 0.30957174 2.8029597e-06 3.8849159e-05 +-0.0016325315 -0.0027857292 0.0035610556 -0.0073850166 -19.605704 0 0.31005577 0.82679115 0.30957174 0.30957174 7.098395e-05 6.688197e-05 +0.010443281 0.0010076535 -0.0017709921 -0.011365734 9.0432052 0 2.6661579 0.21848488 0.30957174 0.30957174 2.1221859e-05 0.00013129735 +0.010012037 0.0034501865 -0.00052345212 0.0068447809 7.4848134 0 3.2074968 3.5928387 0.30957174 0.30957174 0.00011944022 4.674843e-05 +0.013649525 0.0013257316 -0.00082379162 0.002065795 -24.091118 0 2.6694291 3.8981462 0.30957174 0.30957174 3.6462816e-05 4.9171673e-06 +0.015659358 -3.0982025e-05 0.009204063 -6.8389999e-06 3.5283707 0 1.9270757 1.9443596 0.30957174 0.30957174 2.6927765e-05 8.5405398e-05 +0.018877434 0.0016914758 0.0025441209 0.0071720496 -20.846373 0 2.6296546 3.1724469 0.30957174 0.30957174 6.5182607e-05 5.7547686e-05 +-0.014508612 -0.0027752549 0.0071811844 0.00016436519 -0.82402158 0 6.1364803 1.9677959 0.30957174 0.30957174 9.3268821e-05 5.201659e-05 +0.0096894874 -0.0024337048 -0.00013632711 -0.00029249799 18.996434 0 0.78634403 6.2182245 0.30957174 0.30957174 6.4260642e-05 1.0359987e-07 +-0.015451029 0.00036056533 0.0045637427 -0.0012712292 -16.36408 0 4.8772307 1.6755246 0.30957174 0.30957174 2.7391821e-05 2.2600487e-05 +0.00050046958 0.0010596535 -0.0083548602 0.0061938216 -11.542594 0 3.4640921 4.4526308 0.30957174 0.30957174 1.02561e-05 0.00010842594 +0.013221382 -0.00024748216 -0.0018000464 -0.0025318588 -1.4615141 0 1.7762086 6.0356036 0.30957174 0.30957174 1.9747488e-05 9.6250565e-06 +-0.030057076 0.0027311983 0.0093466448 8.2116314e-05 -2.7503719 0 4.3952597 1.953811 0.30957174 0.30957174 0.00016712648 8.8078596e-05 +0.00085899976 -0.001272629 -0.0063675467 -0.011379566 9.6196103 0 0.44826244 6.1438655 0.30957174 0.30957174 1.4834409e-05 0.00016932362 +-0.010763329 0.0014313443 0.00025640644 0.00027266919 -5.5176665 0 4.2059867 2.7571705 0.30957174 0.30957174 3.1380386e-05 1.4002751e-07 +0.018400016 -0.00047897291 -0.0099792952 0.013308006 -3.93669 0 1.7122697 4.163213 0.30957174 0.30957174 3.9255992e-05 0.00027606914 +-0.030180684 -0.0011532213 -0.0016296692 -0.0046647492 18.016537 0 5.4216477 0.035661301 0.30957174 0.30957174 0.00011210771 2.4261409e-05 +-0.013465225 -0.002067858 0.00015344428 -0.0063185935 8.8937316 0 6.0368742 0.39877791 0.30957174 0.30957174 5.8855947e-05 3.9625535e-05 +-0.026874842 -8.0892055e-05 -0.00093153797 -0.00069366315 -21.952573 0 5.1141012 5.7228685 0.30957174 0.30957174 7.9346824e-05 1.3521147e-06 +-0.0096566869 -0.00067629236 -0.0027108527 0.0011125157 -1.4903892 0 5.6545555 4.7000988 0.30957174 0.30957174 1.4403249e-05 8.6363108e-06 +0.0001747055 0.0018214933 -0.0053960004 -0.0048740855 -19.52563 0 3.5053642 5.8172754 0.30957174 0.30957174 3.0226787e-05 5.291879e-05 +0.013679163 0.0010955953 -0.0045450598 0.0047694625 -19.678278 0 2.5754073 4.2812595 0.30957174 0.30957174 3.1475665e-05 4.3389802e-05 +-0.014830629 0.0029185423 0.0017366165 8.7757708e-05 -3.3618261 0 4.0247307 1.9951798 0.30957174 0.30957174 0.00010173785 3.0480605e-06 +-0.0076557146 -7.5240802e-05 0.010295225 0.00055042198 8.227224 0 5.1759787 1.9980785 0.30957174 0.30957174 6.4855957e-06 0.0001071562 +0.0042059163 -0.0019688183 -0.0026063373 0.0042757499 -4.9716488 0 0.60465036 4.066929 0.30957174 0.30957174 3.7252106e-05 2.498258e-05 +0.011183851 0.0013669188 0.0063019485 -0.0017122731 0.68303435 0 2.7840882 1.681843 0.30957174 0.30957174 3.0751314e-05 4.2946471e-05 +-0.016987015 0.0008051465 7.9062659e-05 -0.0010346019 17.472527 0 4.6791034 0.45118977 0.30957174 0.30957174 3.7582358e-05 1.0680479e-06 +0.0043929811 -0.001347521 0.00010528997 0.0057155249 -24.057345 0 0.71797615 3.4973231 0.30957174 0.30957174 1.865943e-05 3.2414258e-05 +-0.0082018589 0.00054971053 3.1705217e-05 -0.0075534612 -14.249503 0 4.5385596 0.3785319 0.30957174 0.30957174 1.0137439e-05 5.6594452e-05 +0.0074151701 0.0012507853 0.0037613316 0.0039385167 -23.248718 0 2.9389533 2.7494464 0.30957174 0.30957174 2.0287351e-05 2.964943e-05 +-0.029466992 -0.00055511791 -0.00024787201 -0.0088839964 -7.0644569 0 5.256642 0.34617928 0.30957174 0.30957174 9.812687e-05 7.8349153e-05 +-0.0064959259 -0.00072558013 0.0010542613 0.0087184166 22.223437 0 5.8807596 3.3945823 0.30957174 0.30957174 9.4280476e-06 7.6516703e-05 +0.012755437 -4.2128957e-05 0.0010744476 -0.0047865241 23.86078 0 1.915019 0.59685488 0.30957174 0.30957174 1.7877013e-05 2.3889407e-05 +0.0020469657 0.00023494436 0.00020917808 0.0064817461 6.0109222 0 2.752757 3.4833695 0.30957174 0.30957174 9.6280025e-07 4.1717433e-05 +-0.030722086 -0.00039924752 -0.0032904606 0.00090212615 9.2237425 0 5.2045214 4.8211634 0.30957174 0.30957174 0.00010506466 1.1722642e-05 +0.023014322 -0.0004316054 -0.0016534144 0.00048957277 14.093844 0 1.7758948 4.8010187 0.30957174 0.30957174 5.9841301e-05 2.9938079e-06 +0.014104119 0.0027288473 -0.0071668665 0.0070195553 -24.402832 0 2.9998001 4.3157328 0.30957174 0.30957174 8.9671472e-05 0.00010065842 +-0.001890466 -0.00099570068 0.0075170936 0.0062214959 -9.5048507 0 0.16881629 2.6324846 0.30957174 0.30957174 9.4235446e-06 9.5361358e-05 +0.00017786964 -0.00090298488 0.0046619091 0.011857113 12.266157 0 0.39592073 3.1385119 0.30957174 0.30957174 7.4310921e-06 0.0001613649 +-0.0045207068 0.0026672221 -0.0008626431 -0.0067169658 -18.116368 0 3.6998517 0.24554216 0.30957174 0.30957174 6.7048265e-05 4.5503034e-05 +-0.0015601167 0.0017936869 -0.004630289 0.001832484 5.4981323 0 3.6110864 4.712613 0.30957174 0.30957174 2.9574908e-05 2.4945192e-05 +-0.012935902 0.0022929354 0.0063592936 -0.0049327128 -18.740223 0 4.0703985 1.2892959 0.30957174 0.30957174 6.6262844e-05 6.490519e-05 +-0.0038972256 -0.0037377334 0.007667729 0.0037820474 -18.944216 0 0.26033497 2.4001104 0.30957174 0.30957174 0.00012893126 7.3461568e-05 +0.02977161 0.0015119586 -0.0035982236 -0.0051162728 -20.675905 0 2.3783972 6.0407295 0.30957174 0.30957174 0.00011812491 3.9017346e-05 +-0.0074683932 -0.0006930155 -0.0069181548 0.0068784161 7.442097 0 5.7884411 4.3082306 0.30957174 0.30957174 1.0497985e-05 9.5181061e-05 +0.011229673 0.0013366372 -0.0010557439 -0.0028205967 19.495463 0 2.7709015 0.013471569 0.30957174 0.30957174 3.0118294e-05 9.0151176e-06 +-0.012831356 0.00061825268 0.010225523 -0.0037215642 -24.242497 0 4.6730903 1.598651 0.30957174 0.30957174 2.1556026e-05 0.00011915172 +0.0054799568 0.00061737987 0.0034351641 -0.00066585129 15.099378 0 2.7434615 1.7551479 0.30957174 0.30957174 6.768706e-06 1.2336319e-05 +0.014473623 -0.0028212727 -0.0063519164 -0.0002943866 9.9539991 0 0.8872025 5.1326283 0.30957174 0.30957174 9.5503527e-05 4.0761703e-05 +0.0088208967 -0.0040904653 -0.00088296512 -0.0029336547 -1.3175969 0 0.60675006 0.079698413 0.30957174 0.30957174 0.00016095879 9.3227231e-06 +-0.014038476 -0.00068201579 -0.0020041694 -0.0082674443 6.4074006 0 5.5033312 0.13460554 0.30957174 0.30957174 2.5871906e-05 7.1847399e-05 +-0.020032935 -0.0011237973 -0.0069319191 -0.0028800473 -8.9744453 0 5.5591085 5.4775972 0.30957174 0.30957174 5.5559954e-05 5.667081e-05 +0.018192272 0.0012528695 0.0031371571 -0.0028882611 2.6654073 0 2.5053816 1.2050268 0.30957174 0.30957174 5.0630482e-05 1.8196582e-05 +-0.008881003 0.002438668 -0.0014186975 0.0015179607 12.635718 0 3.8962093 4.2715537 0.30957174 0.30957174 6.2832744e-05 4.314683e-06 +0.0078454599 0.0024086251 0.00016930876 0.00020095807 6.1274235 0 3.1724906 2.8117613 0.30957174 0.30957174 5.9604732e-05 6.8956738e-08 +0.024535653 0.00085473453 0.00064201397 -0.0030318056 18.070181 0 2.2523831 0.58462871 0.30957174 0.30957174 7.2740609e-05 9.5330631e-06 +-0.0096800389 -0.0013185691 0.0037815519 -0.0013669402 -13.918795 0 5.9791525 1.6008225 0.30957174 0.30957174 2.6124235e-05 1.6270123e-05 +0.0080963994 0.00037477713 0.0043209485 0.002101848 -24.84901 0 2.3441409 2.3946455 0.30957174 0.30957174 8.4755507e-06 2.3204838e-05 +0.0027637646 -0.00250276 -0.0059293265 0.0017422976 -1.5420951 0 0.4949369 4.8030781 0.30957174 0.30957174 5.7897903e-05 3.845456e-05 +0.033983486 0.000999937 -0.0074485542 -0.0047550781 -14.542599 0 2.2069771 5.6511831 0.30957174 0.30957174 0.00013588719 7.8361168e-05 +0.0061131205 0.00096053729 -0.0026074888 -0.0078947125 -22.599439 0 2.9060731 0.052871948 0.30957174 0.30957174 1.2506994e-05 6.8676943e-05 +0.033263155 -0.00052627095 -0.0037180043 -0.0025658909 18.12899 0 1.8019588 5.6869677 0.30957174 0.30957174 0.00012398433 2.0466803e-05 +-0.020751727 0.00013522897 0.0020425782 -0.00012759627 -10.139799 0 5.0273974 1.8832126 0.30957174 0.30957174 4.7440307e-05 4.2222852e-06 +0.019704938 0.00012683697 0.0014850207 -0.0028942497 -19.961541 0 2.0036649 0.85167307 0.30957174 0.30957174 4.2771263e-05 1.0532212e-05 +0.0015151296 -0.0017213838 0.0059662074 0.0078321086 5.4293457 0 0.47062489 2.8609884 0.30957174 0.30957174 2.7244567e-05 9.6731721e-05 +0.02078293 0.00097627553 0.0014880885 0.0052435064 22.879339 0 2.349431 3.2372276 0.30957174 0.30957174 5.609827e-05 2.9504502e-05 +0.00049831972 0.00019457784 0.00025134091 0.016761168 -9.8323986 0 3.2418254 3.5007764 0.30957174 0.30957174 3.7214599e-07 0.00027872883 +-0.00031007087 -0.0038788013 -0.000324193 0.0092054071 14.316603 0 0.36552494 3.5513828 0.30957174 0.30957174 0.00013706203 8.4160286e-05 +-0.0015707735 0.0012379839 -0.0057171705 0.0058623287 8.544998 0 3.6542893 4.2928144 0.30957174 0.30957174 1.4231925e-05 6.7041499e-05 +0.0059326087 0.00093702381 -0.0030566154 -0.00078472603 -3.4227225 0 2.9085072 5.3360438 0.30957174 0.30957174 1.1861851e-05 1.0029875e-05 +-0.010027026 -0.00046001101 -0.0015594422 -0.008426517 5.3207621 0 5.4825409 0.18984869 0.30957174 0.30957174 1.2964754e-05 7.2883726e-05 +-0.0048508391 0.003603588 -0.00012105842 0.0051980711 -19.003183 0 3.6626035 3.5393676 0.30957174 0.30957174 0.00012087609 2.6816238e-05 +-0.0068168188 0.0015068118 -0.0024802121 0.0028607857 20.304473 0 3.9768419 4.2341768 0.30957174 0.30957174 2.5783902e-05 1.4319517e-05 +0.0031618592 0.00032781605 -0.00074081326 -0.0033703201 13.626721 0 2.701931 0.15622738 0.30957174 0.30957174 2.0764037e-06 1.1820488e-05 +-0.019298343 -0.0022100216 -0.0023249926 -0.0010823873 7.7749753 0 5.8932248 5.5192962 0.30957174 0.30957174 8.5375789e-05 6.6117449e-06 +-0.0017658436 -0.0030919313 0.0037105776 -0.0058415131 -2.3517969 0 0.3116871 0.94388752 0.30957174 0.30957174 8.7428304e-05 4.7727982e-05 +-0.0068129564 -0.0017245983 -0.0013011255 -0.00066000371 2.7078467 0 6.2482947 5.5528572 0.30957174 0.30957174 3.2188918e-05 2.1388106e-06 +0.0074359528 4.9367074e-05 0.00439398 0.0047141415 -21.269361 0 2.0054999 2.761581 0.30957174 0.30957174 6.0921432e-06 4.1507884e-05 +0.0038989886 0.0021228719 -0.0041399677 0.0039809642 5.7833054 0 3.3169375 4.3249236 0.30957174 0.30957174 4.2721022e-05 3.2998979e-05 +-0.016416178 -0.0013364356 0.0028210115 -0.0011807293 14.722133 0 5.7247871 1.5515866 0.30957174 0.30957174 4.5853796e-05 9.4058276e-06 +0.015727667 -0.00021325875 -0.0019926645 -0.0025404978 -15.166397 0 1.8222008 5.988408 0.30957174 0.30957174 2.756867e-05 1.0405022e-05 +0.013695724 -0.00086358136 -0.0014286905 -0.0046646608 0.76765425 0 1.4237208 0.074811364 0.30957174 0.30957174 2.7384709e-05 2.3640915e-05 +0.0045961142 0.0022611992 -0.0053431342 0.004579232 -24.407164 0 3.2963565 4.3821364 0.30957174 0.30957174 4.8895402e-05 4.958162e-05 +-0.01113503 0.0018621212 0.0047671909 -0.0043317444 -1.9726698 0 4.0967818 1.211558 0.30957174 0.30957174 4.5197852e-05 4.1523653e-05 +0.0030249619 9.761092e-06 0.0020537215 0.0030047713 -3.7004649 0 1.9744827 2.9125481 0.30957174 0.30957174 1.0053708e-06 1.3207801e-05 +0.0038742984 -0.0039569284 -0.00021525829 -0.00063804442 -4.2723663 0 0.48137379 0.046452284 0.30957174 0.30957174 0.00014427586 4.5052277e-07 +0.0017783308 -0.0010592078 -0.0031064877 0.0036615546 -5.7898457 0 0.55656225 4.223469 0.30957174 0.30957174 1.0567168e-05 2.3027508e-05 +0.011079048 0.00051856662 0.0047192857 -0.00078415779 -13.290145 0 2.3481305 1.7817484 0.30957174 0.30957174 1.5924225e-05 2.3063143e-05 +0.0029099963 -0.00037849096 0.0020771214 0.0064537022 -23.208947 0 1.0753073 3.2021375 0.30957174 0.30957174 2.2345677e-06 4.5663097e-05 +0.016539009 -0.00061393202 -0.0077888226 -0.0021174437 -4.2482495 0 1.6190243 5.3500828 0.30957174 0.30957174 3.3461708e-05 6.5607606e-05 +-0.01220846 0.00040695624 0.00038872971 0.0077486989 -16.165659 0 4.7918858 3.4653599 0.30957174 0.30957174 1.787051e-05 5.9709182e-05 +-0.0087447856 0.0010076487 -0.0038857657 -0.003468825 10.887099 0 4.2770674 5.8114254 0.30957174 0.30957174 1.7644046e-05 2.7157712e-05 +-0.014735648 -0.001313507 -0.01339024 0.0028721507 -3.2705512 0 5.7686998 4.8770537 0.30957174 0.30957174 3.9553316e-05 0.00018894267 +-0.0039089176 0.0016215425 0.0052004133 -0.00089860571 12.505805 0 3.7745931 1.7753482 0.30957174 0.30957174 2.5629549e-05 2.806572e-05 +-0.024106516 -0.0031834454 0.0032972013 0.012869736 -22.661557 0 5.9639591 3.2631305 0.30957174 0.30957174 0.00015611144 0.000175251 +0.026305453 -0.00063918133 0.0045032579 -0.005819479 -1.5148791 0 1.7272651 1.0368092 0.30957174 0.30957174 7.9684801e-05 5.4037141e-05 +0.013210845 0.0042997266 -0.0044999779 -0.0057788114 -15.039573 0 3.1905873 5.9919267 0.30957174 0.30957174 0.00018756994 5.3539509e-05 +-0.029303143 -0.00031198659 0.0075177832 -0.00014489575 -6.8566823 0 5.1833732 1.925981 0.30957174 0.30957174 9.5149342e-05 5.6998604e-05 +-0.0086145113 -0.0016152959 -0.0044491874 0.0033575488 12.693721 0 6.1278332 4.4441224 0.30957174 0.30957174 3.1914539e-05 3.1138616e-05 +-0.0080488095 0.0018448703 -0.0027684558 -0.0040682748 15.012498 0 3.9625475 6.0561862 0.30957174 0.30957174 3.8115907e-05 2.4143858e-05 +-0.00510894 -0.0018140404 0.003972621 0.0018671263 21.498511 0 0.074453414 2.381339 0.30957174 0.30957174 3.2841933e-05 1.9368338e-05 +-0.0040493003 0.0018202971 -0.0015116323 0.00035263266 -24.413975 0 3.7554072 4.8592981 0.30957174 0.30957174 3.1983747e-05 2.4270036e-06 +0.010775911 0.00091808612 -0.0010286928 -0.0011332195 -0.87659524 0 2.605094 5.916357 0.30957174 0.30957174 2.0425463e-05 2.340638e-06 +-0.0091456504 0.0018375332 0.0096518643 0.00028137443 7.9486321 0 4.0159487 1.9740052 0.30957174 0.30957174 3.9940135e-05 9.3996423e-05 +0.0082249834 -0.00064636021 -0.00720049 -0.003841879 -19.659401 0 1.3238053 5.5734572 0.30957174 0.30957174 1.1232182e-05 6.6910388e-05 +0.020355543 0.0010496006 -0.0068310828 -0.0049377491 4.5535968 0 2.3842202 5.7087276 0.30957174 0.30957174 5.5521342e-05 7.1228306e-05 +0.0087246546 0.0021978771 -0.0047476342 0.0004045837 20.885308 0 3.1049364 5.0023608 0.30957174 0.30957174 5.2360515e-05 2.2886136e-05 +-0.0083055857 0.0023149294 -0.00081209113 0.0052523295 6.1190404 0 3.8910966 3.6705244 0.30957174 0.30957174 5.6388941e-05 2.8028769e-05 +0.030655973 -0.00020808503 -0.00065666124 0.0011242832 -16.652791 0 1.8833431 4.0480604 0.30957174 0.30957174 0.00010356161 1.6885111e-06 +-0.0046841832 -0.0012791707 0.0020565631 -0.0064672621 -12.262366 0 6.2752637 0.68453666 0.30957174 0.30957174 1.731415e-05 4.5751213e-05 +0.014646053 0.0019815772 0.0018545751 0.0013760848 15.072064 0 2.8342551 2.5795741 0.30957174 0.30957174 5.9317238e-05 5.3457844e-06 +0.018290566 0.0022711678 0.00034125116 0.0045906262 -4.7021318 0 2.791946 3.4410903 0.30957174 0.30957174 8.3713339e-05 2.102085e-05 +-0.022867942 -0.00087831002 0.0020483036 0.00074894513 -16.841314 0 5.4232502 2.2930272 0.30957174 0.30957174 6.4434321e-05 4.786132e-06 +0.008006346 0.0041133255 0.0014357358 -0.0068312255 -13.14043 0 3.3053841 0.58309792 0.30957174 0.30957174 0.00016116249 4.8366451e-05 +0.002308123 0.0017523067 -0.0020621263 -0.0023530853 0.29306015 0 3.3722909 5.9338651 0.30957174 0.30957174 2.8555888e-05 9.7792679e-06 +0.010180525 0.0018714043 -0.0033341825 0.0046969284 -3.9483234 0 2.9775408 4.1370459 0.30957174 0.30957174 4.3280068e-05 3.3090147e-05 +-0.020601691 0.00052073742 -0.0038081158 0.0071911042 11.819317 0 4.860381 4.0062727 0.30957174 0.30957174 4.9062782e-05 6.5913805e-05 +-0.016343065 0.00054548394 0.00045790422 0.0035230051 -14.975193 0 4.7915261 3.3856003 0.30957174 0.30957174 3.2031492e-05 1.2522592e-05 +-0.016947771 -0.0017831353 -0.00091810769 -0.003434862 -12.971744 0 5.8508644 0.11108259 0.30957174 0.30957174 6.0494823e-05 1.2552671e-05 +0.0078751497 0.0010160864 -0.00064441053 0.0060502963 -6.5739689 0 2.8109209 3.6228602 0.30957174 0.30957174 1.6212956e-05 3.6728744e-05 +-0.017932278 -0.00019150878 0.0010158865 0.0037112307 7.0113953 0 5.1836682 3.2466303 0.30957174 0.30957174 3.5634708e-05 1.4702303e-05 +0.026110029 0.0013425371 -0.0015327452 8.5490194e-05 15.531467 0 2.383138 5.0314207 0.30957174 0.30957174 9.1257462e-05 2.3757082e-06 +0.021152889 6.405605e-05 -0.0051634102 0.0044742336 8.1783716 0 1.972675 4.3766941 0.30957174 0.30957174 4.9156513e-05 4.6735035e-05 +-0.017419832 -0.00030470559 0.0048956889 0.0067364912 7.5743931 0 5.244701 2.8835782 0.30957174 0.30957174 3.4157652e-05 6.9176525e-05 +-4.0502484e-05 -0.0012411402 -0.0097575397 -0.00071412615 -18.252122 0 0.3707179 5.1591575 0.30957174 0.30957174 1.4032528e-05 9.6491561e-05 +-0.0075561136 0.0020974894 -0.01169105 0.0021965235 -8.2282676 0 3.8924853 4.9024413 0.30957174 0.30957174 4.6344057e-05 0.00014258055 +-0.00097197003 -0.0004962232 0.0016461792 -0.0056481732 8.3789897 0 0.16250107 0.66008625 0.30957174 0.30957174 2.346779e-06 3.4375903e-05 +-0.007286453 -0.0012108266 -0.00039664841 0.0019181727 6.3278703 0 6.0736874 3.7214195 0.30957174 0.30957174 1.9183591e-05 3.8082481e-06 +-0.0070801171 0.00054540496 0.0071885247 -0.0012401308 -19.172831 0 4.4748061 1.7756177 0.30957174 0.30957174 8.2126426e-06 5.3621618e-05 +0.0067899383 0.00034486173 -0.0065596744 -1.8457551e-05 15.173307 0 2.3784337 5.0894803 0.30957174 0.30957174 6.1444521e-06 4.3380431e-05 +0.013436045 0.00057321812 0.0036393374 -0.0012018837 -17.821725 0 2.3157636 1.6285351 0.30957174 0.30957174 2.2810896e-05 1.4785589e-05 +0.01120813 0.00024490072 -0.0066506409 0.0044034925 -4.0034182 0 2.1415712 4.5055753 0.30957174 0.30957174 1.4336773e-05 6.3825542e-05 +-0.011287149 -0.0020027917 -0.00096690199 -0.0033126898 20.668496 0 6.1034503 0.088120075 0.30957174 0.30957174 5.052486e-05 1.1827701e-05 +0.014353696 0.0022513757 -0.0025593182 -0.0073165398 -16.355648 0 2.9052437 0.035266187 0.30957174 0.30957174 6.8789828e-05 5.9702408e-05 +-0.029265708 -0.00053097448 -0.0039802712 0.01135453 -5.1051321 0 5.2504821 3.8555956 0.30957174 0.30957174 9.6590225e-05 0.00014385457 +0.0099800173 -0.00092073861 0.0023144036 0.0029492923 2.6955912 0 1.2461936 2.8465847 0.30957174 0.30957174 1.8656432e-05 1.4028121e-05 +0.012279602 0.00020209984 -0.0011673708 -0.0039819339 6.2283779 0 2.0939119 0.086924937 0.30957174 0.30957174 1.692519e-05 1.7101453e-05 +-0.010908118 0.00098874379 0.00090248285 -0.0011618487 23.700323 0 4.3964725 1.0386489 0.30957174 0.30957174 2.1967496e-05 2.160092e-06 +-0.015070598 -0.00088021168 0.0012530596 -0.0030379866 3.8578093 0 5.5756401 0.768375 0.30957174 0.30957174 3.1990569e-05 1.0737693e-05 +0.0052871865 -0.00016435433 0.0040601601 0.0009692364 -13.091519 0 1.669152 2.1776028 0.30957174 0.30957174 3.3148091e-06 1.7551104e-05 +-0.013180987 0.0012800748 0.002895644 0.0066393478 4.8965602 0 4.3624146 3.1016466 0.30957174 0.30957174 3.3999027e-05 5.2177611e-05 +0.013009965 -0.00098554667 0.00071790404 -0.0018383726 -2.600623 0 1.3410699 0.74935863 0.30957174 0.30957174 2.7428724e-05 3.8718743e-06 +0.0039309082 -0.0016820711 -0.003694317 -0.001393085 24.68762 0 0.62542735 5.4446176 0.30957174 0.30957174 2.7470014e-05 1.5684227e-05 +-0.0082678796 0.0020296017 0.0044501249 -0.0001756805 10.675629 0 3.9364098 1.9059581 0.30957174 0.30957174 4.502822e-05 1.9995661e-05 +0.018765749 0.0025563889 0.0027174987 -0.0076748162 14.40552 0 2.8375994 0.71716766 0.30957174 0.30957174 9.8189242e-05 6.5871521e-05 +0.031129586 0.0024181731 0.0019615775 0.0019902246 -19.419857 0 2.5609212 2.7336846 0.30957174 0.30957174 0.00015964716 7.8081184e-06 +0.0075555992 -0.00047906426 -0.0052274961 -0.001269069 -6.3979619 0 1.4213242 5.3229953 0.30957174 0.30957174 8.3574733e-06 2.914699e-05 +0.0011733726 0.00011949805 -0.010286796 8.5166225e-05 7.7317292 0 2.6930133 5.0784772 0.30957174 0.30957174 2.8122125e-07 0.00010668798 +0.026026636 0.0038670261 0.0039735791 0.001798558 4.3083739 0 2.8795705 2.3670931 0.30957174 0.30957174 0.000210582 1.9126697e-05 +0.013675669 -0.00040712291 -0.004801979 0.00033463287 11.724684 0 1.6802806 5.017676 0.30957174 0.30957174 2.2040795e-05 2.3358048e-05 +-0.0051075906 -0.0030841995 -0.0052282466 0.0057223749 -17.685636 0 0.19446798 4.2602427 0.30957174 0.30957174 8.9514806e-05 6.0038186e-05 +0.017876059 0.00031294498 0.0034769492 -0.0081793085 1.3153606 0 2.1032371 0.7791791 0.30957174 0.30957174 3.5971745e-05 7.8547858e-05 +-0.016639975 0.0023264433 0.0010526767 0.012822974 -15.629672 0 4.1815343 3.4333189 0.30957174 0.30957174 7.969905e-05 0.00016421627 +0.0049677581 -0.00018767736 -0.0090848687 -0.0087235966 14.158822 0 1.6136483 5.8477483 0.30957174 0.30957174 3.0300025e-06 0.00015869344 +0.015945226 -0.00040063924 0.00574355 0.0056031748 21.790341 0 1.7200904 2.7140663 0.30957174 0.30957174 2.937299e-05 6.4398989e-05 +-0.016178311 0.0014947485 0.0053438353 0.0021863004 -21.845532 0 4.3870718 2.330608 0.30957174 0.30957174 4.9085619e-05 3.3530623e-05 +0.00055975805 -0.00092639082 0.0016099122 -0.00030516941 -18.534874 0 0.44053438 1.7592427 0.30957174 0.30957174 7.8520631e-06 2.7053206e-06 +0.010313193 -0.0027853186 -0.0065287535 -0.00076705874 -17.226344 0 0.76037264 5.2027052 0.30957174 0.30957174 8.2346639e-05 4.355571e-05 +-0.014860774 0.0017182151 0.0025818373 -0.0008391525 -6.6050694 0 4.2753701 1.6332241 0.30957174 0.30957174 5.1136714e-05 7.4187058e-06 +0.0056116318 -0.00164147 0.0064691771 0.00012676001 24.038778 0 0.73332559 1.9645302 0.30957174 0.30957174 2.8001443e-05 4.2207345e-05 +0.018133829 0.0030673271 -0.0014574365 0.003008823 17.321073 0 2.9402251 3.970166 0.30957174 0.30957174 0.00012180413 1.1121251e-05 +-0.00038878607 0.0019997566 -0.00013902407 -0.0074087705 13.835241 0 3.5372322 0.35538476 0.30957174 0.30957174 3.6445232e-05 5.4465534e-05 +-0.01736112 0.0029681705 -0.0043803707 0.0015995967 -16.581612 0 4.0866919 4.7391688 0.30957174 0.30957174 0.00011334166 2.1882081e-05 +0.010148456 -0.0023803269 0.0038257499 -0.0086160014 -5.7613752 0 0.81204725 0.79519663 0.30957174 0.30957174 6.2919389e-05 8.8390896e-05 +0.032011814 0.0010075697 -0.00058335004 -0.0092789855 -14.125836 0 2.2243231 0.31100458 0.30957174 0.30957174 0.00012174247 8.5746453e-05 +-0.014662201 -0.0024504637 0.00049134621 -0.005821574 1.3024343 0 6.0763141 0.45918474 0.30957174 0.30957174 7.8299609e-05 3.3860077e-05 +0.016236454 -0.00048773855 0.0049895657 -0.0025378281 -23.03642 0 1.6779923 1.477844 0.30957174 0.30957174 3.1106698e-05 3.1487205e-05 +0.013355995 0.00093966971 -0.0086175074 0.00019196849 -20.367594 0 2.5150452 5.0645964 0.30957174 0.30957174 2.7625697e-05 7.490335e-05 +-0.005051982 0.0019617609 0.0061394009 -0.0050260619 -21.96687 0 3.7914043 1.2630589 0.30957174 0.30957174 3.7859276e-05 6.305654e-05 +-0.011338519 8.8629098e-05 0.0065907345 0.0071271685 24.585346 0 5.0156045 2.7655313 0.30957174 0.30957174 1.4184707e-05 9.4177673e-05 +0.010624493 0.0020304671 0.0002907469 0.0043763452 -15.936482 0 2.9945006 3.4490152 0.30957174 0.30957174 4.9947719e-05 1.9082756e-05 +0.0073874562 -0.001514844 -0.000721463 0.0032831008 -9.2852229 0 0.86582687 3.7339134 0.30957174 0.30957174 2.6894789e-05 1.1216347e-05 +-0.00071379995 0.00024767949 -0.0010473122 0.0075557749 1.9713452 0 3.8223013 3.6547346 0.30957174 0.30957174 6.1474842e-07 5.7733918e-05 +-0.0068484759 -0.0022885866 0.0087875058 0.00069288067 -1.7765085 0 0.056904267 2.0231485 0.30957174 0.30957174 5.2860252e-05 7.8325943e-05 +0.032258825 -0.002586966 -0.00073994241 -0.0035211884 -18.923177 0 1.3141811 0.16553402 0.30957174 0.30957174 0.00017520096 1.2850491e-05 +-0.0085047747 0.00057679178 0.0013448287 -0.006663036 4.3409794 0 4.5332873 0.57503929 0.30957174 0.30957174 1.0970888e-05 4.5860376e-05 +-0.0017733666 0.00032478743 -0.0046746282 -0.0016553371 -11.348704 0 4.055865 5.4244751 0.30957174 0.30957174 1.3061496e-06 2.4748267e-05 +0.017527842 -0.0035210607 0.0032901865 0.0022935353 -8.0103273 0 0.87442923 2.5500593 0.30957174 0.30957174 0.00014666312 1.6131343e-05 +-0.0010318261 0.0002912897 0.0038810076 0.0080252558 -1.0502227 0 3.8867587 3.0622617 0.30957174 0.30957174 8.8980352e-07 7.9068966e-05 +-0.013200859 -0.0011929557 0.0024026017 -0.00059820355 -11.479757 0 5.7754235 1.7029733 0.30957174 0.30957174 3.2093981e-05 6.1745051e-06 +0.01798209 0.0011822288 -0.00026430279 -0.010762865 -21.56561 0 2.4847025 0.34954822 0.30957174 0.30957174 4.8228859e-05 0.00011497302 +-0.019975923 0.0011585065 -0.0037820977 -0.0032420771 -9.1974368 0 4.6006591 5.7913489 0.30957174 0.30957174 5.6031173e-05 2.4846941e-05 +-0.032329825 -1.6826921e-05 -0.00067488656 0.001967956 10.629479 0 5.0914304 3.8487617 0.30957174 0.30957174 0.00011474342 4.3007201e-06 +-0.0079583721 -0.0014396883 0.00073675272 0.0027671097 17.723378 0 6.1120591 3.2536506 0.30957174 0.30957174 2.5833828e-05 8.142213e-06 +-0.0087737054 -0.00017297966 0.00099171155 -0.00011701446 -17.546286 0 5.2643924 1.8285883 0.30957174 0.30957174 8.7229737e-06 1.0050907e-06 +-0.01195305 0.0016324435 0.0036694811 -0.0050527446 8.4813707 0 4.1929511 1.0062826 0.30957174 0.30957174 3.9959753e-05 3.8898649e-05 +0.016377923 0.00026003543 -0.0027382655 -0.0046300482 6.9093265 0 2.0887319 6.1198406 0.30957174 0.30957174 3.0062142e-05 2.8823228e-05 +0.019749478 -0.0015322487 0.0026781523 -0.00027754812 -14.22085 0 1.3298586 1.8426602 0.30957174 0.30957174 6.4204495e-05 7.3073786e-06 +-0.019081614 0.0018948513 -0.0082028461 -0.00023508981 2.5683466 0 4.3513476 5.1151094 0.30957174 0.30957174 7.2677544e-05 6.7890011e-05 +-0.01525286 0.00058601813 0.010251415 -0.0045009285 17.809001 0 4.7500285 1.5343625 0.30957174 0.30957174 2.8667905e-05 0.00012604275 +-0.010328768 0.00048155465 -0.0019338109 -0.010367737 8.6472696 0 4.6850698 0.18842832 0.30957174 0.30957174 1.3823805e-05 0.00011039092 +0.0010003703 -0.0017348318 8.5616152e-05 0.0047230758 0.31355932 0 0.43751753 3.49762 0.30957174 0.30957174 2.7525815e-05 2.213446e-05 +0.0020227003 0.0018853849 0.0073100117 -0.0016760965 -16.611032 0 3.3986607 1.7214668 0.30957174 0.30957174 3.2830016e-05 5.6658456e-05 +0.0075973246 0.00088068586 -0.0019990735 0.0013150118 -7.8877484 0 2.7577082 4.5085644 0.30957174 0.30957174 1.3401558e-05 5.7441453e-06 +-0.018598239 0.0026825012 -0.0044767486 0.0017176057 -13.481307 0 4.166462 4.723044 0.30957174 0.30957174 0.00010352063 2.3130965e-05 +-0.027469391 -0.0030970497 -0.00020568391 0.0053759135 -16.956274 0 5.8854268 3.554446 0.30957174 0.30957174 0.00017020871 2.8709412e-05 +0.00019889308 0.00077142574 -0.00096539151 -0.0049064347 -7.6350061 0 3.4875972 0.17847805 0.30957174 0.30957174 5.4253115e-06 2.4818028e-05 +0.0028976872 -0.00047581676 0.0045952104 -0.00096481282 8.416167 0 0.96359411 1.7397688 0.30957174 0.30957174 2.9841299e-06 2.2211429e-05 +0.025607381 -0.00038861056 0.0010236974 0.0031801284 -2.4646959 0 1.8077259 3.2020875 0.30957174 0.30957174 7.3360623e-05 1.1087942e-05 +0.011134902 -0.00047928662 -0.0091415577 0.0015808619 -9.6583925 0 1.5714185 4.9168095 0.30957174 0.30957174 1.5703381e-05 8.6728223e-05 +-0.0011816872 0.0022595289 -0.0020367288 0.005202607 18.336307 0 3.5732411 3.8917992 0.30957174 0.30957174 4.6660947e-05 3.1030338e-05 +-0.019876906 0.00076389064 0.0029189893 -0.001667039 -15.683389 0 4.7499405 1.4296862 0.30957174 0.30957174 4.8687532e-05 1.1346504e-05 +0.0024773094 0.001183156 0.0051230636 0.0052541342 8.5913675 0 3.2899645 2.7390663 0.30957174 0.30957174 1.3425542e-05 5.3842438e-05 +-0.022597213 0.0017025608 -0.0063315989 0.0036540419 9.7630956 0 4.4851931 4.5667768 0.30957174 0.30957174 8.2461344e-05 5.3660002e-05 +0.0057376779 0.0019020921 -0.008720756 -0.00198413 10.983115 0 3.1961147 5.3086493 0.30957174 0.30957174 3.6571272e-05 8.0576482e-05 +-0.01938172 -0.0018401996 -0.0040366159 -0.0095037035 19.239761 0 5.7997649 6.2529045 0.30957174 0.30957174 7.2085242e-05 0.00010601716 +0.0014007197 0.0014311223 -0.001395103 0.0048437812 17.877527 0 3.4088586 3.7984891 0.30957174 0.30957174 1.8872399e-05 2.5234682e-05 +-0.013815433 -0.00099671721 -0.0060718529 -9.4701257e-05 -17.124644 0 5.6681078 5.1021587 0.30957174 0.30957174 3.0002383e-05 3.7176829e-05 +-0.02944318 -0.00056079652 0.0018608009 -0.0059373517 -7.3466159 0 5.2584829 0.68033482 0.30957174 0.30957174 9.8030603e-05 3.8457907e-05 +-0.0087708547 -0.00076915391 -0.000307771 -0.00041909069 10.666201 0 5.7607227 6.0201797 0.30957174 0.30957174 1.3833999e-05 2.6971197e-07 +-0.00095764312 0.002162019 -0.0034807572 0.0018297454 22.845896 0 3.5644792 4.6060497 0.30957174 0.30957174 4.2680871e-05 1.5535332e-05 +-0.011725449 0.0023828666 0.0012547573 0.0036162036 14.843058 0 4.011168 3.179387 0.30957174 0.30957174 6.6816341e-05 1.455844e-05 +-0.018132988 0.0017880755 -0.0026035034 0.0015877099 -9.981299 0 4.3548328 4.542671 0.30957174 0.30957174 6.5219878e-05 9.3339241e-06 +0.007040559 0.0016504483 -0.0064730613 -0.0056212678 10.536644 0 3.0779321 5.7977574 0.30957174 0.30957174 3.0255344e-05 7.3585236e-05 +0.0090787329 -0.0014898546 -0.0051894423 0.006480814 3.798454 0 0.96388094 4.1950491 0.30957174 0.30957174 2.9267974e-05 6.8811176e-05 +-0.0012036271 0.00068129111 -0.00042523183 -0.0062186121 7.570634 0 3.7074562 0.30547124 0.30957174 0.30957174 4.3872221e-06 3.8540743e-05 +-0.0020904881 -0.0016693274 -0.0015485178 -0.0077333107 -22.292671 0 0.23768357 0.1751051 0.30957174 0.30957174 2.5864422e-05 6.1737981e-05 +-0.0084480443 -0.0020221201 -0.0030193443 -0.0061031508 21.523599 0 6.2274798 6.194837 0.30957174 0.30957174 4.5082689e-05 4.6138019e-05 +-0.013502149 0.003092325 -0.0015265226 -0.002538153 18.303869 0 3.9628633 6.1124223 0.30957174 0.30957174 0.00010712141 8.739397e-06 +-0.017611955 0.0012011758 -0.00049363817 0.0055205855 24.575821 0 4.5307691 3.6057966 0.30957174 0.30957174 4.7193954e-05 3.0476097e-05 +-0.011077512 -0.00078398221 0.00064773362 -0.0059765172 5.1303002 0 5.6593243 0.48313182 0.30957174 0.30957174 1.9069753e-05 3.5852919e-05 +-0.018991915 -0.0018397049 -0.00014007862 -0.0010193795 -1.5226103 0 5.809698 0.23664071 0.30957174 0.30957174 7.0426587e-05 1.0505142e-06 +-0.003737201 0.00096408025 0.0014305075 0.0010144227 -22.84968 0 3.9182244 2.5581014 0.30957174 0.30957174 9.9999361e-06 3.0837657e-06 +-0.0110015 0.00059667542 0.0037372277 0.0050863106 -22.473381 0 4.6278093 2.8783371 0.30957174 0.30957174 1.6529773e-05 3.9742096e-05 +0.031505547 0.00041119254 -0.0013619876 -0.0098596035 -18.753708 0 2.0634316 0.23592601 0.30957174 0.30957174 0.0001105048 9.8295871e-05 +-0.0072905346 0.00091316507 0.0008381239 0.002919158 -11.537348 0 4.235537 3.2341411 0.30957174 0.30957174 1.3430895e-05 9.1607575e-06 +0.0095032737 0.00098548654 -0.0025883129 -0.00079945512 -20.515852 0 2.7020342 5.3839831 0.30957174 0.30957174 1.8761082e-05 7.387936e-06 +-0.0088872457 0.0018115582 0.00046854613 0.0013353495 16.085527 0 4.0099031 3.1758908 0.30957174 0.30957174 3.8565164e-05 1.9900651e-06 +0.063191685 0.00075646939 -0.0017093506 5.33133e-05 21.751499 0 2.053716 5.0557621 0.30957174 0.30957174 0.00044357309 2.9485172e-06 +-0.020494956 -0.0011574115 0.0010580142 0.0074051369 5.0131763 0 5.5618171 3.3728365 0.30957174 0.30957174 5.8314018e-05 5.5521175e-05 +-0.011688761 -0.0011280307 -0.0026249571 0.002529553 -12.120374 0 5.8078399 4.3238538 0.30957174 0.30957174 2.6589774e-05 1.3293468e-05 +-0.016944959 0.00073506265 -0.0063292931 0.0080306406 23.103922 0 4.7103626 4.1873127 0.30957174 0.30957174 3.6442401e-05 0.00010435623 +-0.018513699 -0.00082546847 0.00046546819 0.0067795171 -12.331035 0 5.4724937 3.4467854 0.30957174 0.30957174 4.383395e-05 4.5808638e-05 +0.013967964 -0.0024833141 -0.0047360462 0.0008710277 24.714346 0 0.92746327 4.9062461 0.30957174 0.30957174 7.7594081e-05 2.3365534e-05 +-0.010930156 -0.0029094542 -0.0004147401 0.0023625643 -11.037302 0 6.2663294 3.6910568 0.30957174 0.30957174 9.0225049e-05 5.7099887e-06 +0.011463079 -0.002541879 0.0048040968 -0.0038220702 -5.3721196 0 0.83398799 1.277005 0.30957174 0.30957174 7.3281976e-05 3.7757584e-05 +-0.016892657 0.00059789423 -0.0080695398 0.0022209776 -16.373693 0 4.7747973 4.8201794 0.30957174 0.30957174 3.4582564e-05 7.0541152e-05 +0.039018538 0.0013931998 0.0034836103 0.00500507 -5.954089 0 2.2595639 2.9040336 0.30957174 0.30957174 0.00018481093 3.7082636e-05 +0.016640455 -0.0010725234 -0.0053820336 -0.00015024134 -7.5742876 0 1.4141981 5.1143718 0.30957174 0.30957174 4.0876344e-05 2.9224802e-05 +-0.0022480469 -0.0023035361 0.0021975749 -0.0028330487 -7.4599433 0 0.26757473 1.0379787 0.30957174 0.30957174 4.889167e-05 1.282997e-05 +0.0064965424 -0.00079268726 -0.00073641122 -0.010523526 23.239656 0 1.1069428 0.30386891 0.30957174 0.30957174 1.035705e-05 0.00011039586 +0.018758267 -0.0014180979 -0.0030911727 -0.0011169732 6.826455 0 1.3420249 5.4308464 0.30957174 0.30957174 5.6946488e-05 1.0870783e-05 +0.0024748976 -0.0027612915 0.0012618947 -0.0044643251 -17.33977 0 0.47237581 0.65190808 0.30957174 0.30957174 7.012894e-05 2.1374405e-05 +0.016843515 0.001529859 -0.00051382225 0.0027375176 -24.923304 0 2.6363138 3.7029082 0.30957174 0.30957174 5.246438e-05 7.6995728e-06 +0.0013535363 -0.00018874492 -0.005224361 0.012364001 -22.899937 0 1.0412108 3.9186024 0.30957174 0.30957174 5.2563643e-07 0.00017914888 +-0.0059087176 0.00048963306 0.001306395 0.00083028925 23.56362 0 4.4400853 2.5075829 0.30957174 0.30957174 6.0165249e-06 2.4043863e-06 +0.015264459 0.00045236826 -0.0018350228 0.0022575146 16.297763 0 2.2087711 4.2023978 0.30957174 0.30957174 2.7442561e-05 8.449922e-06 +0.0057209346 0.00097887211 0.011063092 0.0015046699 -10.204697 0 2.945458 2.0791953 0.30957174 0.30957174 1.2321421e-05 0.00012563545 +-0.015115786 -0.00094522464 0.0040608648 -0.0029733824 -3.2519434 0 5.6044786 1.3169475 0.30957174 0.30957174 3.3221383e-05 2.5394567e-05 +0.025087769 0.00037345518 -0.0011800502 0.0047513029 16.165972 0 2.0798762 3.7612368 0.30957174 0.30957174 7.0363691e-05 2.3796212e-05 +0.0094499315 0.0015925146 0.0010777171 0.0046949225 18.888822 0 2.9385249 3.2884756 0.30957174 0.30957174 3.2905533e-05 2.3035008e-05 +-0.01582266 0.0013641023 0.00073038067 0.0016854366 -3.741795 0 4.4209533 3.1040025 0.30957174 0.30957174 4.4433893e-05 3.3555315e-06 +0.024707627 0.00080654431 0.004978017 -0.0068112034 -12.952054 0 2.2341317 1.0093094 0.30957174 0.30957174 7.294099e-05 7.1000027e-05 +0.00036739133 -0.0015323128 -0.001830389 2.1991108e-05 14.80124 0 0.40061461 5.0747725 0.30957174 0.30957174 2.1403473e-05 3.3781148e-06 +0.0055433815 -0.00045494979 0.0010264037 0.00064329301 9.5870432 0 1.3031243 2.5013027 0.30957174 0.30957174 5.2587984e-06 1.4725721e-06 +-0.0091994223 -0.0017243999 0.0098552666 -0.0027118729 -13.076811 0 6.1276886 1.678642 0.30957174 0.30957174 3.637759e-05 0.00010521282 +-0.020799672 0.00046298835 0.0020229402 0.0032480121 12.271223 0 4.8866323 2.95521 0.30957174 0.30957174 4.9445091e-05 1.4589927e-05 +-0.011442109 -0.00011449497 -0.0026369127 -0.0036995405 15.999021 0 5.1775906 6.0343997 0.30957174 0.30957174 1.4491624e-05 2.0585922e-05 +-0.0066997484 0.0013703871 -0.0043417023 -0.0088166889 11.379171 0 4.0084629 6.1966775 0.30957174 0.30957174 2.2034572e-05 9.6109499e-05 +-0.0030777406 0.00018403816 0.0047141393 0.0058422788 -6.1717189 0 4.5879173 2.8329873 0.30957174 0.30957174 1.3483962e-06 5.62605e-05 +0.013187365 -0.002326822 -0.002993645 0.0021294668 -2.6892695 0 0.930859 4.4722299 0.30957174 0.30957174 6.8410025e-05 1.3532928e-05 +0.0087261956 -0.0027032924 0.0033917939 -0.0044052539 14.465774 0 0.71485294 1.0343717 0.30957174 0.30957174 7.4928545e-05 3.0847391e-05 +-0.012846884 0.0017417508 0.007957276 0.0023116445 -22.133949 0 4.1965194 2.2256541 0.30957174 0.30957174 4.5752941e-05 6.913489e-05 +-0.0050749311 0.0011824957 0.0028545202 -0.0014156318 -21.841812 0 3.95618 1.4879368 0.30957174 0.30957174 1.5564904e-05 1.0202518e-05 +-0.012965525 -0.0018316476 0.00153201 -0.0060044475 0.20109122 0 5.9968842 0.626068 0.30957174 0.30957174 4.9015392e-05 3.8128054e-05 +-0.014228489 -0.0012090766 0.00070780749 -0.0017387391 -15.460589 0 5.7454219 0.76373933 0.30957174 0.30957174 3.5541032e-05 3.5038437e-06 +-0.019471876 -0.0032374926 0.0060205072 -0.0026812155 -0.67442523 0 6.0739364 1.5291278 0.30957174 0.30957174 0.00013710102 4.3672768e-05 diff --git a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py index c5a5c236..49cf6a18 100644 --- a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py +++ b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py @@ -17,12 +17,12 @@ from orbit.core import orbit_mpi from orbit.core.bunch import Bunch -from orbit.core.bunch import BunchTuneAnalysis4D +from orbit.core.bunch import BunchTuneAnalysis from orbit.core.bunch import BunchTwissAnalysis from orbit.bunch_generators import TwissContainer from orbit.bunch_generators import GaussDist2D from orbit.bunch_generators import WaterBagDist2D -from orbit.diagnostics import TeapotTuneAnalysis4DNode +from orbit.diagnostics import TeapotTuneAnalysisNode from orbit.lattice import AccLattice from orbit.lattice import AccNode from orbit.teapot import TEAPOT_Lattice @@ -81,7 +81,7 @@ def build_norm_matrix_from_twiss_2d(alpha: float, beta: float) -> np.ndarray: # Add tune diagnostic node # ------------------------------------------------------------------------------------ -tune_node = TeapotTuneAnalysis4DNode() +tune_node = TeapotTuneAnalysisNode() tune_node.setNormMatrix(norm_matrix) lattice.getNodes()[0].addChildNode(tune_node, 0) From 12cc93ab2d28e3d010a86d48534dc621d9f514ac Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Mon, 15 Sep 2025 14:20:56 -0400 Subject: [PATCH 27/40] Add setActive function to TeapotTuneAnalysisNode --- py/orbit/diagnostics/TeapotDiagnosticsNode.py | 7 +++++++ 1 file changed, 7 insertions(+) diff --git a/py/orbit/diagnostics/TeapotDiagnosticsNode.py b/py/orbit/diagnostics/TeapotDiagnosticsNode.py index eeedb01b..18b961b9 100644 --- a/py/orbit/diagnostics/TeapotDiagnosticsNode.py +++ b/py/orbit/diagnostics/TeapotDiagnosticsNode.py @@ -203,13 +203,20 @@ def __init__(self, name: str = "tuneanalysis no name") -> None: self.lattlength = 0.0 self.setLength(0.0) self.position = 0.0 + self.active = True def track(self, paramsDict: dict) -> None: """Implementation of the AccNodeBunchTracker class track(probe) method.""" + if not self.active: + return + length = self.getLength(self.getActivePartIndex()) bunch = paramsDict["bunch"] self.bunchtune.analyzeBunch(bunch) + def setActive(self, active: bool) -> None: + self.active = active + def setPosition(self, position: float) -> None: self.position = position From fb2035d7ff9b0cfc68286fedb97ba003cea4b7c3 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 19 Sep 2025 09:47:49 -0400 Subject: [PATCH 28/40] Check tunes against transfer matrix --- examples/Diagnostics/Tunes/test_tune.py | 17 ++++++++++++++++- .../Diagnostics/Tunes/test_tune_4d_uncoupled.py | 17 ++++++++++++++++- 2 files changed, 32 insertions(+), 2 deletions(-) diff --git a/examples/Diagnostics/Tunes/test_tune.py b/examples/Diagnostics/Tunes/test_tune.py index 52d33c7b..461b995b 100644 --- a/examples/Diagnostics/Tunes/test_tune.py +++ b/examples/Diagnostics/Tunes/test_tune.py @@ -153,4 +153,19 @@ "action_y", ] ) -print(particles.iloc[:, 6:]) \ No newline at end of file +print(particles.iloc[:, 6:]) + +# Check against tune from transfer matrix +tune_x_true = lattice_params["fractional tune x"] +tune_y_true = lattice_params["fractional tune y"] +tune_x_pred = np.mean(phase_data["tune_x"]) +tune_y_pred = np.mean(phase_data["tune_y"]) + +tune_x_err = tune_x_pred - tune_x_true +tune_y_err = tune_y_pred - tune_y_true + +print("tune_x_err", tune_x_err) +print("tune_y_err", tune_y_err) + +assert np.abs(tune_x_err) < 1.00e-08 +assert np.abs(tune_y_err) < 1.00e-08 \ No newline at end of file diff --git a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py index 49cf6a18..3184fd8f 100644 --- a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py +++ b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py @@ -156,4 +156,19 @@ def build_norm_matrix_from_twiss_2d(alpha: float, beta: float) -> np.ndarray: "action_2", ] ) -print(particles.iloc[:, 6:]) \ No newline at end of file +print(particles.iloc[:, 6:]) + +# Check against tune from transfer matrix +tune_x_true = lattice_params["fractional tune x"] +tune_y_true = lattice_params["fractional tune y"] +tune_x_pred = np.mean(phase_data["tune_x"]) +tune_y_pred = np.mean(phase_data["tune_y"]) + +tune_x_err = tune_x_pred - tune_x_true +tune_y_err = tune_y_pred - tune_y_true + +print("tune_x_err", tune_x_err) +print("tune_y_err", tune_y_err) + +assert np.abs(tune_x_err) < 1.00e-08 +assert np.abs(tune_y_err) < 1.00e-08 \ No newline at end of file From 3dddd80193420612d83650c99bf8c9a098e6f554 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 19 Sep 2025 11:22:52 -0400 Subject: [PATCH 29/40] Add option to start FODO lattice at quad or drift center --- examples/Diagnostics/Tunes/utils.py | 53 +++++++++++++++++++++++++++++ 1 file changed, 53 insertions(+) diff --git a/examples/Diagnostics/Tunes/utils.py b/examples/Diagnostics/Tunes/utils.py index e59a0e7e..66c6aee7 100644 --- a/examples/Diagnostics/Tunes/utils.py +++ b/examples/Diagnostics/Tunes/utils.py @@ -12,6 +12,20 @@ def make_lattice( + length: float = 5.0, + fill_fraction: float = 0.5, + kq: float = 0.65, + start: str = "drift", +) -> AccLattice: + if start == "drift": + return make_lattice_drift_start(length=length, fill_fraction=fill_fraction, kq=kq) + elif start == "quad": + return make_lattice_quad_start(length=length, fill_fraction=fill_fraction, kq=kq) + else: + raise ValueError + + +def make_lattice_quad_start( length: float = 5.0, fill_fraction: float = 0.5, kq: float = 0.65 ) -> AccLattice: drift_nodes = [ @@ -48,3 +62,42 @@ def make_lattice( pass return lattice + + +def make_lattice_drift_start( + length: float = 5.0, fill_fraction: float = 0.5, kq: float = 0.65 +) -> AccLattice: + + drift_nodes = [ + DriftTEAPOT("drift1"), + DriftTEAPOT("drift2"), + DriftTEAPOT("drift3"), + ] + quad_nodes = [ + QuadTEAPOT("qf"), + QuadTEAPOT("qd"), + ] + for node in [quad_nodes[0], drift_nodes[1], quad_nodes[1]]: + node.setLength(length * fill_fraction * 0.50) + for node in [drift_nodes[0], drift_nodes[2]]: + node.setLength(length * fill_fraction * 0.25) + + quad_nodes[0].setParam("kq", +kq) + quad_nodes[1].setParam("kq", -kq) + + lattice = TEAPOT_Lattice() + lattice.addNode(drift_nodes[0]) + lattice.addNode(quad_nodes[0]) + lattice.addNode(drift_nodes[1]) + lattice.addNode(quad_nodes[1]) + lattice.addNode(drift_nodes[2]) + lattice.initialize() + + for node in lattice.getNodes(): + try: + node.setUsageFringeFieldIN(False) + node.setUsageFringeFieldOUT(False) + except: + pass + + return lattice From 6ea69a453ef51bbfc5bd7fe868dbc8f63750705e Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 19 Sep 2025 11:46:30 -0400 Subject: [PATCH 30/40] Fix fill fraction argument in make_lattice --- examples/Diagnostics/Tunes/utils.py | 50 +++++++++++++++++++++-------- 1 file changed, 36 insertions(+), 14 deletions(-) diff --git a/examples/Diagnostics/Tunes/utils.py b/examples/Diagnostics/Tunes/utils.py index 66c6aee7..5aaf2160 100644 --- a/examples/Diagnostics/Tunes/utils.py +++ b/examples/Diagnostics/Tunes/utils.py @@ -13,21 +13,33 @@ def make_lattice( length: float = 5.0, - fill_fraction: float = 0.5, + fill_frac: float = 0.5, kq: float = 0.65, start: str = "drift", + sol: float = 0.0, ) -> AccLattice: + """Create FODO lattice. + + Args: + length: Length of lattice [m]. + fill_frac: Fraction of lattice occupied by quadrupoles. + + """ if start == "drift": - return make_lattice_drift_start(length=length, fill_fraction=fill_fraction, kq=kq) + return make_lattice_drift_start(length=length, fill_frac=fill_frac, kq=kq) elif start == "quad": - return make_lattice_quad_start(length=length, fill_fraction=fill_fraction, kq=kq) + return make_lattice_quad_start(length=length, fill_frac=fill_frac, kq=kq) else: raise ValueError def make_lattice_quad_start( - length: float = 5.0, fill_fraction: float = 0.5, kq: float = 0.65 + length: float = 5.0, fill_frac: float = 0.5, kq: float = 0.65 ) -> AccLattice: + + length_quad = length * fill_frac / 2.0 + length_drift = length * (1.0 - fill_frac) / 2.0 + drift_nodes = [ DriftTEAPOT("drift1"), DriftTEAPOT("drift2"), @@ -37,11 +49,14 @@ def make_lattice_quad_start( QuadTEAPOT("qd"), QuadTEAPOT("qf2"), ] - for node in [drift_nodes[0], quad_nodes[1], drift_nodes[1]]: - node.setLength(length * fill_fraction * 0.50) - for node in [quad_nodes[0], quad_nodes[2]]: - node.setLength(length * fill_fraction * 0.25) - + + drift_nodes[0].setLength(length_drift) + drift_nodes[1].setLength(length_drift) + + quad_nodes[0].setLength(length_quad * 0.5) + quad_nodes[1].setLength(length_quad) + quad_nodes[2].setLength(length_quad * 0.5) + quad_nodes[0].setParam("kq", +kq) quad_nodes[1].setParam("kq", -kq) quad_nodes[2].setParam("kq", +kq) @@ -65,9 +80,12 @@ def make_lattice_quad_start( def make_lattice_drift_start( - length: float = 5.0, fill_fraction: float = 0.5, kq: float = 0.65 + length: float = 5.0, fill_frac: float = 0.5, kq: float = 0.65 ) -> AccLattice: + length_quad = length * fill_frac / 2.0 + length_drift = length * (1.0 - fill_frac) / 2.0 + drift_nodes = [ DriftTEAPOT("drift1"), DriftTEAPOT("drift2"), @@ -77,11 +95,15 @@ def make_lattice_drift_start( QuadTEAPOT("qf"), QuadTEAPOT("qd"), ] - for node in [quad_nodes[0], drift_nodes[1], quad_nodes[1]]: - node.setLength(length * fill_fraction * 0.50) - for node in [drift_nodes[0], drift_nodes[2]]: - node.setLength(length * fill_fraction * 0.25) + + drift_nodes[0].setLength(length_drift * 0.5) + drift_nodes[1].setLength(length_drift) + drift_nodes[2].setLength(length_drift * 0.5) + + quad_nodes[0].setLength(length_quad) + quad_nodes[1].setLength(length_quad) + quad_nodes[0].setParam("kq", +kq) quad_nodes[1].setParam("kq", -kq) From 9965cb6d15ea6e0652290046314532ce01b3e66c Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 19 Sep 2025 11:56:24 -0400 Subject: [PATCH 31/40] Improve make_lattice helper function --- examples/Diagnostics/Tunes/utils.py | 150 ++++++++++++---------------- 1 file changed, 62 insertions(+), 88 deletions(-) diff --git a/examples/Diagnostics/Tunes/utils.py b/examples/Diagnostics/Tunes/utils.py index 5aaf2160..400eeb88 100644 --- a/examples/Diagnostics/Tunes/utils.py +++ b/examples/Diagnostics/Tunes/utils.py @@ -16,110 +16,84 @@ def make_lattice( fill_frac: float = 0.5, kq: float = 0.65, start: str = "drift", - sol: float = 0.0, ) -> AccLattice: """Create FODO lattice. Args: length: Length of lattice [m]. fill_frac: Fraction of lattice occupied by quadrupoles. - + kq: Quad coefficient [1/m]. + start: Whether to start in drift or quad center. {"drift", "quad"} """ - if start == "drift": - return make_lattice_drift_start(length=length, fill_frac=fill_frac, kq=kq) - elif start == "quad": - return make_lattice_quad_start(length=length, fill_frac=fill_frac, kq=kq) - else: - raise ValueError - - -def make_lattice_quad_start( - length: float = 5.0, fill_frac: float = 0.5, kq: float = 0.65 -) -> AccLattice: - length_quad = length * fill_frac / 2.0 length_drift = length * (1.0 - fill_frac) / 2.0 - drift_nodes = [ - DriftTEAPOT("drift1"), - DriftTEAPOT("drift2"), - ] - quad_nodes = [ - QuadTEAPOT("qf1"), - QuadTEAPOT("qd"), - QuadTEAPOT("qf2"), - ] - - drift_nodes[0].setLength(length_drift) - drift_nodes[1].setLength(length_drift) - - quad_nodes[0].setLength(length_quad * 0.5) - quad_nodes[1].setLength(length_quad) - quad_nodes[2].setLength(length_quad * 0.5) - - quad_nodes[0].setParam("kq", +kq) - quad_nodes[1].setParam("kq", -kq) - quad_nodes[2].setParam("kq", +kq) - - lattice = TEAPOT_Lattice() - lattice.addNode(quad_nodes[0]) - lattice.addNode(drift_nodes[0]) - lattice.addNode(quad_nodes[1]) - lattice.addNode(drift_nodes[1]) - lattice.addNode(quad_nodes[2]) - lattice.initialize() - - for node in lattice.getNodes(): - try: - node.setUsageFringeFieldIN(False) - node.setUsageFringeFieldOUT(False) - except: - pass + if start == "quad": + drift_nodes = [ + DriftTEAPOT("drift1"), + DriftTEAPOT("drift2"), + ] + quad_nodes = [ + QuadTEAPOT("qf1"), + QuadTEAPOT("qd"), + QuadTEAPOT("qf2"), + ] - return lattice - + drift_nodes[0].setLength(length_drift) + drift_nodes[1].setLength(length_drift) + + quad_nodes[0].setLength(length_quad * 0.5) + quad_nodes[1].setLength(length_quad) + quad_nodes[2].setLength(length_quad * 0.5) + + quad_nodes[0].setParam("kq", +kq) + quad_nodes[1].setParam("kq", -kq) + quad_nodes[2].setParam("kq", +kq) -def make_lattice_drift_start( - length: float = 5.0, fill_frac: float = 0.5, kq: float = 0.65 -) -> AccLattice: + lattice = TEAPOT_Lattice() + lattice.addNode(quad_nodes[0]) + lattice.addNode(drift_nodes[0]) + lattice.addNode(quad_nodes[1]) + lattice.addNode(drift_nodes[1]) + lattice.addNode(quad_nodes[2]) + lattice.initialize() - length_quad = length * fill_frac / 2.0 - length_drift = length * (1.0 - fill_frac) / 2.0 + elif start == "drift": - drift_nodes = [ - DriftTEAPOT("drift1"), - DriftTEAPOT("drift2"), - DriftTEAPOT("drift3"), - ] - quad_nodes = [ - QuadTEAPOT("qf"), - QuadTEAPOT("qd"), - ] + drift_nodes = [ + DriftTEAPOT("drift1"), + DriftTEAPOT("drift2"), + ] + quad_nodes = [ + QuadTEAPOT("qf1"), + QuadTEAPOT("qd"), + QuadTEAPOT("qf2"), + ] + + drift_nodes[0].setLength(length_drift) + drift_nodes[1].setLength(length_drift) + + quad_nodes[0].setLength(length_quad * 0.5) + quad_nodes[1].setLength(length_quad) + quad_nodes[2].setLength(length_quad * 0.5) + + quad_nodes[0].setParam("kq", +kq) + quad_nodes[1].setParam("kq", -kq) + quad_nodes[2].setParam("kq", +kq) - - drift_nodes[0].setLength(length_drift * 0.5) - drift_nodes[1].setLength(length_drift) - drift_nodes[2].setLength(length_drift * 0.5) + lattice = TEAPOT_Lattice() + lattice.addNode(quad_nodes[0]) + lattice.addNode(drift_nodes[0]) + lattice.addNode(quad_nodes[1]) + lattice.addNode(drift_nodes[1]) + lattice.addNode(quad_nodes[2]) + lattice.initialize() - quad_nodes[0].setLength(length_quad) - quad_nodes[1].setLength(length_quad) + else: + raise ValueError - quad_nodes[0].setParam("kq", +kq) - quad_nodes[1].setParam("kq", -kq) - - lattice = TEAPOT_Lattice() - lattice.addNode(drift_nodes[0]) - lattice.addNode(quad_nodes[0]) - lattice.addNode(drift_nodes[1]) - lattice.addNode(quad_nodes[1]) - lattice.addNode(drift_nodes[2]) - lattice.initialize() - for node in lattice.getNodes(): - try: - node.setUsageFringeFieldIN(False) - node.setUsageFringeFieldOUT(False) - except: - pass - + node.setUsageFringeFieldIN(False) + node.setUsageFringeFieldOUT(False) + return lattice From 957fcfa51a69547e786b3fcf0b528f134610d755 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 19 Sep 2025 11:56:49 -0400 Subject: [PATCH 32/40] Remove unused imports --- examples/Diagnostics/Tunes/test_tune.py | 5 ----- examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py | 5 ----- 2 files changed, 10 deletions(-) diff --git a/examples/Diagnostics/Tunes/test_tune.py b/examples/Diagnostics/Tunes/test_tune.py index 461b995b..35c65be3 100644 --- a/examples/Diagnostics/Tunes/test_tune.py +++ b/examples/Diagnostics/Tunes/test_tune.py @@ -14,20 +14,15 @@ import pandas as pd import matplotlib.pyplot as plt -from orbit.core import orbit_mpi from orbit.core.bunch import Bunch -from orbit.core.bunch import BunchTuneAnalysis from orbit.core.bunch import BunchTwissAnalysis from orbit.bunch_generators import TwissContainer from orbit.bunch_generators import GaussDist2D -from orbit.bunch_generators import WaterBagDist2D from orbit.diagnostics import TeapotTuneAnalysisNode from orbit.lattice import AccLattice from orbit.lattice import AccNode from orbit.teapot import TEAPOT_Lattice from orbit.teapot import TEAPOT_MATRIX_Lattice -from orbit.teapot import DriftTEAPOT -from orbit.teapot import QuadTEAPOT from orbit.utils.consts import mass_proton from utils import make_lattice diff --git a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py index 3184fd8f..f1cb14cd 100644 --- a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py +++ b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py @@ -15,20 +15,15 @@ import pandas as pd import matplotlib.pyplot as plt -from orbit.core import orbit_mpi from orbit.core.bunch import Bunch -from orbit.core.bunch import BunchTuneAnalysis from orbit.core.bunch import BunchTwissAnalysis from orbit.bunch_generators import TwissContainer from orbit.bunch_generators import GaussDist2D -from orbit.bunch_generators import WaterBagDist2D from orbit.diagnostics import TeapotTuneAnalysisNode from orbit.lattice import AccLattice from orbit.lattice import AccNode from orbit.teapot import TEAPOT_Lattice from orbit.teapot import TEAPOT_MATRIX_Lattice -from orbit.teapot import DriftTEAPOT -from orbit.teapot import QuadTEAPOT from orbit.utils.consts import mass_proton from utils import make_lattice From 9bd58752ad07e6cdafb44e88faf0b14678c02fab Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 19 Sep 2025 11:57:07 -0400 Subject: [PATCH 33/40] Add test using 4 x 4 normalization matrix from eigenvectors --- examples/Diagnostics/Tunes/test_tune_4d.py | 190 +++++++++++++++++++++ 1 file changed, 190 insertions(+) create mode 100644 examples/Diagnostics/Tunes/test_tune_4d.py diff --git a/examples/Diagnostics/Tunes/test_tune_4d.py b/examples/Diagnostics/Tunes/test_tune_4d.py new file mode 100644 index 00000000..6f48f608 --- /dev/null +++ b/examples/Diagnostics/Tunes/test_tune_4d.py @@ -0,0 +1,190 @@ +"""Test one-turn tune estimation in uncoupled lattice using 4D normalization. + +See comments on `test_tune.py`. This example is the same, but the tunes are +estimated using the `BunchTuneAnalysis4D` class. Since there is no coupling +in the lattice, the (eigen)tunes {nu1, nu2} should be the same as horizontal +and vertical tunes {nux, nuy}. +""" +import math +import os +import pathlib +import random +from pprint import pprint + +import numpy as np +import pandas as pd +import matplotlib.pyplot as plt + +from orbit.core.bunch import Bunch +from orbit.core.bunch import BunchTwissAnalysis +from orbit.diagnostics import TeapotTuneAnalysisNode +from orbit.lattice import AccLattice +from orbit.lattice import AccNode +from orbit.teapot import TEAPOT_Lattice +from orbit.teapot import TEAPOT_MATRIX_Lattice +from orbit.teapot import SolenoidTEAPOT +from orbit.utils.consts import mass_proton + +from utils import make_lattice + + +# Setup +# ------------------------------------------------------------------------------------ + +path = pathlib.Path(__file__) +output_dir = os.path.join("outputs", path.stem) +os.makedirs(output_dir, exist_ok=True) + + +# Initialize lattice and bunch +# ------------------------------------------------------------------------------------ + +lattice = make_lattice() + +bunch = Bunch() +bunch.mass(mass_proton) +bunch.getSyncParticle().kinEnergy(1.000) + + +# Analyze transfer matrix +# ------------------------------------------------------------------------------------ + + +def calc_eigtune(eigval: float) -> float: + return np.arccos(np.real(eigval)) / (2.0 * np.pi) + + +def unit_symplectic_matrix(ndim: int) -> np.ndarray: + U = np.zeros((ndim, ndim)) + for i in range(0, ndim, 2): + U[i: i + 2, i: i + 2] = [[0.0, 1.0], [-1.0, 0.0]] + return U + + +def normalize_eigvec(v: np.ndarray) -> np.ndarray: + U = unit_symplectic_matrix(len(v)) + + def _norm(v): + return np.linalg.multi_dot([np.conj(v), U, v]) + + if _norm(v) > 0.0: + v = np.conj(v) + + v *= np.sqrt(2.0 / np.abs(_norm(v))) + assert np.isclose(np.imag(_norm(v)), -2.0) + assert np.isclose(np.real(_norm(v)), +0.0) + return v + + +def calc_norm_matrix_from_eigvecs(v1: np.ndarray, v2: np.ndarray) -> np.ndarray: + V = np.zeros((4, 4)) + V[:, 0] = +np.real(v1) + V[:, 1] = -np.imag(v1) + V[:, 2] = +np.real(v2) + V[:, 3] = -np.imag(v2) + return np.linalg.inv(V) + + +# Estimate transfer matrix +matrix_lattice = TEAPOT_MATRIX_Lattice(lattice, bunch) + +M = np.zeros((4, 4)) +for i in range(4): + for j in range(4): + M[i, j] = matrix_lattice.getOneTurnMatrix().get(i, j) + +# Calculate eigenvalues and eigenvectors +eigvals, eigvecs = np.linalg.eig(M) +eigvals = eigvals[[0, 2]] +eigvecs = eigvecs[:, [0, 2]] + +v1 = normalize_eigvec(eigvecs[:, 0]) +v2 = normalize_eigvec(eigvecs[:, 1]) + +# Calculate tunes from transfer matrix +tune_1_true = calc_eigtune(eigvals[0]) +tune_2_true = calc_eigtune(eigvals[1]) + +# Calculate normalization matrix from transfer matrix +V_inv = calc_norm_matrix_from_eigvecs(v1, v2) +V = np.linalg.inv(V_inv) + +# Print normalization matrix +print("Normalization matrix V^{-1}:") +print(V_inv) + + +# Add tune diagnostic node +# ------------------------------------------------------------------------------------ + +tune_node = TeapotTuneAnalysisNode() +tune_node.setNormMatrix(V_inv) +lattice.getNodes()[0].addChildNode(tune_node, 0) + + +# Generate phase space distribution +# ------------------------------------------------------------------------------------ + +rng = np.random.default_rng() + +n = 1000 +eps_1 = 25.0e-06 # mode 1 rms emittance +eps_2 = 25.0e-06 # mode 2 rms emittance + +# Generate particles in normalized phase space +particles = np.zeros((n, 6)) +particles[:, (0, 1)] = rng.normal(size=(n, 2), scale=np.sqrt(eps_1)) +particles[:, (2, 3)] = rng.normal(size=(n, 2), scale=np.sqrt(eps_2)) +particles[:, 4] = rng.uniform(-25.0, 25.0, size=n) +particles[:, 5] = 0.0 + +# Unnormalize transverse coordinates (match to lattice) +particles[:, :4] = np.matmul(particles[:, :4], V.T) + +# Add particles to bunch +for index in range(n): + bunch.addParticle(*particles[index]) + + +# Tracking +# ------------------------------------------------------------------------------------ + +n_turns = 10 +for turn in range(n_turns): + lattice.trackBunch(bunch) + + twiss_calc = BunchTwissAnalysis() + twiss_calc.analyzeBunch(bunch) + xrms = math.sqrt(twiss_calc.getCorrelation(0, 0)) * 1000.0 + yrms = math.sqrt(twiss_calc.getCorrelation(2, 2)) * 1000.0 + print("turn={} xrms={:0.3f} yrms={:0.3f}".format(turn + 1, xrms, yrms)) + + +# Analysis +# ------------------------------------------------------------------------------------ + +# Collect phase data from bunch +phase_data = {} +for i in range(bunch.getSize()): + data = tune_node.getData(bunch, i) + for key in data: + if key in phase_data: + phase_data[key].append(data[key]) + else: + phase_data[key] = [] + +phase_data = pd.DataFrame(phase_data) +print(phase_data) + +# Check against tune from transfer matrix +tune_1_pred = np.mean(phase_data["tune_x"]) +tune_2_pred = np.mean(phase_data["tune_y"]) + +tune_1_err = tune_1_pred - tune_1_true +tune_2_err = tune_2_pred - tune_2_true + +print("tune_1_err", tune_1_err) +print("tune_2_err", tune_2_err) + +assert np.abs(tune_1_err) < 1.00e-08 +assert np.abs(tune_2_err) < 1.00e-08 \ No newline at end of file From 37f22ba2812bf531816555f5bdec14273a7adff6 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 19 Sep 2025 12:07:28 -0400 Subject: [PATCH 34/40] Add 4D coupled tune analysis example --- examples/Diagnostics/Tunes/test_tune.py | 12 ++++--- examples/Diagnostics/Tunes/test_tune_4d.py | 31 +++++++++++-------- .../Tunes/test_tune_4d_uncoupled.py | 31 ++++++++++--------- 3 files changed, 43 insertions(+), 31 deletions(-) diff --git a/examples/Diagnostics/Tunes/test_tune.py b/examples/Diagnostics/Tunes/test_tune.py index 35c65be3..1fdfc764 100644 --- a/examples/Diagnostics/Tunes/test_tune.py +++ b/examples/Diagnostics/Tunes/test_tune.py @@ -153,12 +153,16 @@ # Check against tune from transfer matrix tune_x_true = lattice_params["fractional tune x"] tune_y_true = lattice_params["fractional tune y"] -tune_x_pred = np.mean(phase_data["tune_x"]) -tune_y_pred = np.mean(phase_data["tune_y"]) +tune_x_calc = np.mean(phase_data["tune_x"]) +tune_y_calc = np.mean(phase_data["tune_y"]) -tune_x_err = tune_x_pred - tune_x_true -tune_y_err = tune_y_pred - tune_y_true +tune_x_err = tune_x_calc - tune_x_true +tune_y_err = tune_y_calc - tune_y_true +print("tune_x_true", tune_x_true) +print("tune_x_calc", tune_x_calc) +print("tune_y_true", tune_y_true) +print("tune_y_calc", tune_y_calc) print("tune_x_err", tune_x_err) print("tune_y_err", tune_y_err) diff --git a/examples/Diagnostics/Tunes/test_tune_4d.py b/examples/Diagnostics/Tunes/test_tune_4d.py index 6f48f608..36e260c6 100644 --- a/examples/Diagnostics/Tunes/test_tune_4d.py +++ b/examples/Diagnostics/Tunes/test_tune_4d.py @@ -1,10 +1,4 @@ -"""Test one-turn tune estimation in uncoupled lattice using 4D normalization. - -See comments on `test_tune.py`. This example is the same, but the tunes are -estimated using the `BunchTuneAnalysis4D` class. Since there is no coupling -in the lattice, the (eigen)tunes {nu1, nu2} should be the same as horizontal -and vertical tunes {nux, nuy}. -""" +"""Test one-turn tune estimation in coupled lattice.""" import math import os import pathlib @@ -41,6 +35,14 @@ lattice = make_lattice() +sol_node = SolenoidTEAPOT() +sol_node.setLength(0.5) +sol_node.setParam("B", 0.25) +sol_node.setUsageFringeFieldIN(False) +sol_node.setUsageFringeFieldOUT(False) +lattice.addNode(sol_node) +lattice.initialize() + bunch = Bunch() bunch.mass(mass_proton) bunch.getSyncParticle().kinEnergy(1.000) @@ -176,13 +178,16 @@ def calc_norm_matrix_from_eigvecs(v1: np.ndarray, v2: np.ndarray) -> np.ndarray: phase_data = pd.DataFrame(phase_data) print(phase_data) -# Check against tune from transfer matrix -tune_1_pred = np.mean(phase_data["tune_x"]) -tune_2_pred = np.mean(phase_data["tune_y"]) - -tune_1_err = tune_1_pred - tune_1_true -tune_2_err = tune_2_pred - tune_2_true +# Check average tune vs. transfer matrix +tune_1_calc = np.mean(phase_data["tune_x"]) +tune_2_calc = np.mean(phase_data["tune_y"]) +tune_1_err = tune_1_calc - tune_1_true +tune_2_err = tune_2_calc - tune_2_true +print("tune_1_true", tune_1_true) +print("tune_1_calc", tune_1_calc) +print("tune_2_true", tune_2_true) +print("tune_2_calc", tune_2_calc) print("tune_1_err", tune_1_err) print("tune_2_err", tune_2_err) diff --git a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py index f1cb14cd..35ebe8f3 100644 --- a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py +++ b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py @@ -153,17 +153,20 @@ def build_norm_matrix_from_twiss_2d(alpha: float, beta: float) -> np.ndarray: ) print(particles.iloc[:, 6:]) -# Check against tune from transfer matrix -tune_x_true = lattice_params["fractional tune x"] -tune_y_true = lattice_params["fractional tune y"] -tune_x_pred = np.mean(phase_data["tune_x"]) -tune_y_pred = np.mean(phase_data["tune_y"]) - -tune_x_err = tune_x_pred - tune_x_true -tune_y_err = tune_y_pred - tune_y_true - -print("tune_x_err", tune_x_err) -print("tune_y_err", tune_y_err) - -assert np.abs(tune_x_err) < 1.00e-08 -assert np.abs(tune_y_err) < 1.00e-08 \ No newline at end of file +# Check average tune vs. transfer matrix +tune_1_true = lattice_params["fractional tune x"] +tune_2_true = lattice_params["fractional tune y"] +tune_1_calc = np.mean(phase_data["tune_x"]) +tune_2_calc = np.mean(phase_data["tune_y"]) +tune_1_err = tune_1_calc - tune_1_true +tune_2_err = tune_2_calc - tune_2_true + +print("tune_1_true", tune_1_true) +print("tune_1_calc", tune_1_calc) +print("tune_2_true", tune_2_true) +print("tune_2_calc", tune_2_calc) +print("tune_1_err", tune_1_err) +print("tune_2_err", tune_2_err) + +assert np.abs(tune_1_err) < 1.00e-08 +assert np.abs(tune_2_err) < 1.00e-08 \ No newline at end of file From d1c98589324b34a6ac5d453e04464be1b4ab1114 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 19 Sep 2025 13:57:15 -0400 Subject: [PATCH 35/40] tune_node.getData(bunch) returns data for all particles --- examples/Diagnostics/Tunes/test_tune.py | 14 +- py/orbit/diagnostics/TeapotDiagnosticsNode.py | 145 +++++++++++++++--- 2 files changed, 130 insertions(+), 29 deletions(-) diff --git a/examples/Diagnostics/Tunes/test_tune.py b/examples/Diagnostics/Tunes/test_tune.py index 1fdfc764..c76a5ded 100644 --- a/examples/Diagnostics/Tunes/test_tune.py +++ b/examples/Diagnostics/Tunes/test_tune.py @@ -117,15 +117,7 @@ # ------------------------------------------------------------------------------------ # Collect phase data from bunch -phase_data = {} -for i in range(bunch.getSize()): - data = tune_node.getData(bunch, i) - for key in data: - if key in phase_data: - phase_data[key].append(data[key]) - else: - phase_data[key] = [] - +phase_data = tune_node.getData(bunch) phase_data = pd.DataFrame(phase_data) print(phase_data) @@ -153,8 +145,8 @@ # Check against tune from transfer matrix tune_x_true = lattice_params["fractional tune x"] tune_y_true = lattice_params["fractional tune y"] -tune_x_calc = np.mean(phase_data["tune_x"]) -tune_y_calc = np.mean(phase_data["tune_y"]) +tune_x_calc = np.mean(phase_data["tune_1"]) +tune_y_calc = np.mean(phase_data["tune_2"]) tune_x_err = tune_x_calc - tune_x_true tune_y_err = tune_y_calc - tune_y_true diff --git a/py/orbit/diagnostics/TeapotDiagnosticsNode.py b/py/orbit/diagnostics/TeapotDiagnosticsNode.py index 18b961b9..cea9e45a 100644 --- a/py/orbit/diagnostics/TeapotDiagnosticsNode.py +++ b/py/orbit/diagnostics/TeapotDiagnosticsNode.py @@ -180,20 +180,69 @@ def resetFile(self, file): class TeapotTuneAnalysisNode(DriftTEAPOT): - """Tune analysis node. + """One-turn tune analysis node. + + This node uses the Average Phase Advance (APA) method to estimate the + tunes and actions of each particle. See Eq. (6) of [1]. We use only + a single turn rather than the average of multiple turns. + + The phase advance is computed by normalizing the particle coordinates. + In the normalized frame, the turn-by-turn coordinates should jump along + a circle of area J, where J is an invariant. (In an uncoupled lattice, + J is the Courant-Snyder (CS) invariant.). The phase is the angle below + the x axis. The (fractional) phase advance is the change in phase on + subsequent turns, modulo 2 pi. The tune is the phase advance divided + by 2 pi. + + The normalization is performed using a 6 x 6 matrix V^{-1}. In + uncoupled systems, the user can call `assignTwiss` to set the matrix + using Courant-Snyder parameters in each plane [2], as well as the + horizontal dispersion and dispersion-prime. Note that the last column + of V^{-1} multiplies by the fractional momentum offset (delta_p / p), + not the energy offset (delta_E). + + .. math:: + + \begin{bmatrix} + u_1 \\ u_1' \\ u_2 \\ u_2' \\ u_3 \\ u_3' + \end{bmatrix} + = + \begin{bmatrix} + \frac{1}{\sqrt{\beta_x}} & 0 & 0 & 0 & 0 & 0\\ + \frac{\alpha_x}{\sqrt{\beta_x}} & \sqrt{\beta_x} & 0 & 0 & 0 & 0 \\ + 0 & 0 & \frac{1}{\sqrt{\beta_y}} & 0 & 0 & 0 \\ + 0 & 0 & \frac{\alpha_y}{\sqrt{\beta_y}} & \sqrt{\beta_y} & 0 & 0 \\ + 0 & 0 & 0 & 0 & 1 & 0 \\ + 0 & 0 & 0 & 0 & 0 & 1 \\ + \end{bmatrix} + \begin{bmatrix} + 1 & 0 & 0 & 0 & 0 & -\eta_x \\ + 0 & 1 & 0 & 0 & 0 & -\eta_x' \\ + 0 & 0 & 1 & 0 & 0 & 0 \\ + 0 & 0 & 0 & 1 & 0 & 0 \\ + 0 & 0 & 0 & 0 & 1 & 0 \\ + 0 & 0 & 0 & 0 & 0 & 1 \\ + \end{bmatrix} + \begin{bmatrix} + x \\ x' \\ y \\ y' \\ z \\ \delta p + \end{bmatrix} - The tunes are estimated from the particle phase space coordinates on - neighboring turns. The coordinates are "normalized" in each 2D phase - plane (x-x', y-y') using provided twiss parameters (alpha, beta) as - well as the dispersion in the x plane. In the normalized frame, the - turn-by-turn coordinates advance in phase around a circle. The fractional - tune is defined by the change in angle for a single turn. - - The calculation will be incorrect if the normalization matrix does not - map the turn-by-turn coordinates to a circle. In a linear lattice - without space charge, the normalization will be correct if the provided - twiss parameters are the same as the periodic lattice twiss parameters - at the location of the node. + Otherwise, the user can set the matrix directly. + + The phase phi_k is defined by + + .. math:: + \tan(\phi_k) = u_k' / u_k + + The action J_k is defined as: + + .. math:: + J_k = u_k^2 + u_k'^2 + + References + ---------- + [1] https://cds.cern.ch/record/292773/files/p147.pdf + [2] S. Y. Lee, Accelerator Physics """ def __init__(self, name: str = "tuneanalysis no name") -> None: """Constructor.""" @@ -205,6 +254,8 @@ def __init__(self, name: str = "tuneanalysis no name") -> None: self.position = 0.0 self.active = True + self.keys = ["phase_1", "phase_1", "tune_1", "tune_2", "action_1", "action_2"] + def track(self, paramsDict: dict) -> None: """Implementation of the AccNodeBunchTracker class track(probe) method.""" if not self.active: @@ -224,6 +275,11 @@ def setLatticeLength(self, lattlength): self.lattlength = lattlength def setNormMatrix(self, norm_matrix: list[list[float]]) -> None: + """Set the normalization matrix. + + Args; + norm_matrix: Normalization matrix of shape (4, 4) or (6, 6). + """ ndim = len(norm_matrix) norm_matrix_list = list(norm_matrix) for i in range(ndim): @@ -232,6 +288,7 @@ def setNormMatrix(self, norm_matrix: list[list[float]]) -> None: self.bunchtune.setNormMatrixElement(i, j, value) def getNormMatrix(self) -> list[list[float]]: + """Return normalization matrix of shape (6, 6).""" norm_matrix = [ [0.0, 0.0, 0.0, 0.0, 0.0, 0.0], [0.0, 0.0, 0.0, 0.0, 0.0, 0.0], @@ -263,13 +320,65 @@ def assignTwiss( """ self.bunchtune.assignTwiss(betax, alphax, etax, etapx, betay, alphay) - def getData(self, bunch: Bunch, index: int) -> dict[str, float]: - """Return phase advances, tunes, and actions for a single particle.""" - keys = ["phase_x", "phase_y", "tune_x", "tune_y", "action_x", "action_y"] + def getData(self, bunch: Bunch, index: int = None) -> dict[str, float] | dict[str, list[float]]: + """Return phase advances, tunes, and actions. + + Args: + bunch: A Bunch object. + index: Particle index. If None, return data for all particles. + + Returns: + data: Dictionary with keys ["phase_1", "phase_1", "tune_1", "tune_2", + "action_1", "action_2"]. (If the lattice is uncoupled, 1->x and + 2->y.) If `index` is None, each value of `data` is a list of floats; + otherwise it is a float. + """ data = {} - for j, key in enumerate(keys): - data[key] = bunch.partAttrValue("ParticlePhaseAttributes", index, j) + if index is None: + for j, key in enumerate(self.keys): + data[key] = [] + for index in range(bunch.getSize()): + value = bunch.partAttrValue("ParticlePhaseAttributes", index, j) + data[key].append(value) + else: + index = int(index) + bunch_size = bunch.getSize() + if (index < bunch_size): + raise ValueError("particle index < 0") + if (index > bunch_size - 1): + raise ValueError("particle index > bunch.getSize() - 1") + for j, key in enumerate(self.keys): + data[key] = bunch.partAttrValue("ParticlePhaseAttributes", index, j) return data + + def getTunes(self, bunch: Bunch, index: int = None) -> dict[str, float] | dict[str, list[float]]: + """Return fractional tunes (nu_1, nu_2). + + Args: + bunch: A Bunch object. + index: Particle index in bunch (not ID). + + Returns: + tune_1: Fractional tune (mode 1). + tune_2: Fractional tune (mode 2). + """ + data = self.getData(bunch, index) + return (data["tune_1"], data["tune_2"]) + + + def getActions(self, bunch: Bunch, index: int) -> dict[str, float] | dict[str, list[float]]: + """Return actions (J_1, J_2). + + Args: + bunch: A Bunch object. + index: Particle index in bunch (not ID). + + Returns: + J_1: Action (mode 1). + J_2: Action tune (mode 2). + """ + data = self.getData(bunch, index) + return (data["action_1"], data["action_2"]) class TeapotBPMSignalNode(DriftTEAPOT): From efd235ee291763181986c1eafbc9b3be298b85d8 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 19 Sep 2025 13:57:46 -0400 Subject: [PATCH 36/40] Accidentally committed output files --- .../Tunes/outputs/test_tune/bunch.dat | 1015 ----------------- .../outputs/test_tune_4d_uncoupled/bunch.dat | 1015 ----------------- 2 files changed, 2030 deletions(-) delete mode 100644 examples/Diagnostics/Tunes/outputs/test_tune/bunch.dat delete mode 100644 examples/Diagnostics/Tunes/outputs/test_tune_4d_uncoupled/bunch.dat diff --git a/examples/Diagnostics/Tunes/outputs/test_tune/bunch.dat b/examples/Diagnostics/Tunes/outputs/test_tune/bunch.dat deleted file mode 100644 index 43574170..00000000 --- a/examples/Diagnostics/Tunes/outputs/test_tune/bunch.dat +++ /dev/null @@ -1,1015 +0,0 @@ -% PARTICLE_ATTRIBUTES_CONTROLLERS_NAMES ParticlePhaseAttributes -% PARTICLE_ATTRIBUTES_CONTROLLER_DICT ParticlePhaseAttributes size 6 xAction 0 xLastPhase 0 xLastTune 0 yAction 0 yLastPhase 0 yLastTune 0 -% BUNCH_ATTRIBUTE_DOUBLE charge 1 -% BUNCH_ATTRIBUTE_DOUBLE classical_radius 1.5347e-18 -% BUNCH_ATTRIBUTE_DOUBLE macro_size 0 -% BUNCH_ATTRIBUTE_DOUBLE mass 0.938272 -% SYNC_PART_COORDS 0 0 0 x, y, z positions in [m] -% SYNC_PART_MOMENTUM 0 0 1.6960377525279 px, py, pz momentum component in GeV/c -% SYNC_PART_X_AXIS 1 0 0 nxx, nxy, pxz - x-axis ort coordinates -% info only: energy of the synchronous particle [GeV] = 1 -% info only: momentum of the synchronous particle [GeV/c] = 1.6960377525279 -% info only: beta=v/c of the synchronous particle = 0.8750256554045 -% info only: gamma=1/sqrt(1-(v/c)**2) of the synchronous particle = 2.0657889919897 -% SYNC_PART_TIME 1.9060246584653e-07 time in [sec] -% x[m] px[rad] y[m] py[rad] z[m] (pz or dE [GeV]) PhaseVars --0.00053353841 0.0019264679 -0.0023728768 0.00451823 11.15473 0 3.5462865 4.0028295 0.30957174 0.30957174 3.3838685e-05 2.5925778e-05 -0.016052551 -0.0010796933 0.00071740327 -0.0069386597 -24.326636 0 1.3953941 0.47816024 0.30957174 0.30957174 3.8906961e-05 4.8274568e-05 -0.0057484801 -0.00052091008 0.0031216119 0.012490659 2.3378761 0 1.2550202 3.269077 0.30957174 0.30957174 6.0993882e-06 0.00016457893 -0.034876448 0.002308461 -0.0078291127 -0.0071192182 -1.5907307 0 2.48768 5.8205937 0.30957174 0.30957174 0.00018207287 0.00011206812 -0.015217737 0.00053102817 -0.0056642814 0.0027910962 7.1093982 0 2.2528706 4.6320664 0.30957174 0.30957174 2.7990865e-05 4.0072853e-05 -0.0081969177 -0.001455795 -0.00058586893 -0.001069189 -5.3175185 0 0.92792542 6.1527838 0.30957174 0.30957174 2.6681716e-05 1.479962e-06 --0.024247489 0.0010330531 0.00048850158 0.0024520119 13.606911 0 4.7164827 3.3176813 0.30957174 0.30957174 7.4263882e-05 6.2043265e-06 --0.017532851 0.0031443202 0.000279889 -0.0016720985 8.3584392 0 4.0651771 0.54147759 0.30957174 0.30957174 0.00012380767 2.8522825e-06 -0.010784952 0.00039402385 0.0016238349 0.0014538236 -12.172981 0 2.2663737 2.6712776 0.30957174 0.30957174 1.4183005e-05 4.7548475e-06 -0.0003566723 0.0010079991 0.0058046167 0.0068512881 8.420607 0 3.4770687 2.8090023 0.30957174 0.30957174 9.2696591e-06 8.0528835e-05 -0.0075209373 0.00042703336 0.001980975 0.0011078983 -6.3889453 0 2.4224281 2.4515771 0.30957174 0.30957174 7.8706437e-06 5.1737655e-06 --0.019452037 -0.00079725203 0.0056721518 -0.0050012194 -11.840858 0 5.4440149 1.2265016 0.30957174 0.30957174 4.7327629e-05 5.7245526e-05 -0.0072460155 -9.5140441e-05 0.0031884742 0.0076521209 11.755332 0 1.8260557 3.118201 0.30957174 0.30957174 5.846268e-06 6.8330728e-05 -0.010278729 0.00079522052 0.0025233186 -0.0085538356 6.0483318 0 2.5590053 0.66336761 0.30957174 0.30957174 1.7358736e-05 7.8995516e-05 --0.0062316991 0.0033190819 0.00078603477 0.0062888006 -16.379802 0 3.7191569 3.3905451 0.30957174 0.30957174 0.00010461476 3.9852112e-05 --0.0055201673 -0.0012137694 -0.010743058 0.0086168562 -22.211306 0 6.1944296 4.4146367 0.30957174 0.30957174 1.6765414e-05 0.00019000395 --0.034150227 0.0014493494 0.0060647611 0.012038448 6.3948873 0 4.7177828 3.0459538 0.30957174 0.30957174 0.00014716139 0.00018083355 --0.01050912 -0.0020513583 -0.0030589314 0.0039432379 23.167352 0 6.1451811 4.1796016 0.30957174 0.30957174 5.045685e-05 2.4856735e-05 --0.0032521047 -0.0010126354 0.00069193794 -0.0018116763 -18.765538 0 0.035354091 0.74184905 0.30957174 0.30957174 1.0502055e-05 3.7383129e-06 --0.042058981 -0.0025930601 -0.006301898 0.0094856585 14.207953 0 5.5984099 4.1060453 0.30957174 0.30957174 0.00025544197 0.00012928783 -0.017881527 0.0035595634 -0.0039339754 0.0060882378 19.654341 0 3.0119244 4.0932709 0.30957174 0.30957174 0.00015052137 5.2369245e-05 --0.018620719 6.1256081e-06 -0.0089035385 -0.0020794093 5.0062168 0 5.0836926 5.3143339 0.30957174 0.30957174 3.8063447e-05 8.4208194e-05 --0.00053305458 0.00038824715 0.0013209288 -0.0028068977 -16.316282 0 3.6654883 0.81728932 0.30957174 0.30957174 1.4043024e-06 9.5740453e-06 --0.025653842 0.0014490835 0.0063914034 -0.0082622705 -9.4785053 0 4.6114676 1.0366463 0.30957174 0.30957174 9.1374654e-05 0.00010889617 --0.0074732153 -0.00022149989 0.0052286851 0.0072247735 14.417174 0 5.3503958 2.8855659 0.30957174 0.30957174 6.5778557e-06 7.9337302e-05 --0.0034289135 0.0032201249 0.016929839 -0.0017384006 -16.357773 0 3.6322596 1.8435943 0.30957174 0.30957174 9.5747686e-05 0.00029195351 -0.0081034561 0.0020823725 0.0094974866 -0.00097251006 -13.097487 0 3.112167 1.8438751 0.30957174 0.30957174 4.6709381e-05 9.187569e-05 -0.0025752754 -0.0005025236 0.0055772413 -0.0049253524 3.9405681 0 0.88674486 1.2257144 0.30957174 0.30957174 3.0284364e-06 5.5422128e-05 -0.013726602 9.5934836e-05 0.0020512199 -0.0027096942 24.297572 0 2.008676 1.0261732 0.30957174 0.30957174 2.0767975e-05 1.1524874e-05 -0.0090718825 0.0034082343 0.0028952082 -0.0025429574 17.501914 0 3.2316079 1.2284052 0.30957174 0.30957174 0.00011484962 1.4864905e-05 --0.0060525809 0.0012085305 0.0018080293 -0.0035300648 -1.1081685 0 4.0185725 0.85094642 0.30957174 0.30957174 1.7326204e-05 1.5656215e-05 -0.011481774 -0.0010704618 0.0016957418 0.00077138283 -8.7957317 0 1.2410207 2.3689611 0.30957174 0.30957174 2.4910357e-05 3.489201e-06 --0.014155327 0.00051465396 0.0038867853 0.0021721475 3.3410243 0 4.7668642 2.4512625 0.30957174 0.30957174 2.4409167e-05 1.9910324e-05 -0.012327073 0.00019066255 -0.0021562054 -0.0074436985 -24.033575 0 2.0850698 0.090171462 0.30957174 0.30957174 1.7012498e-05 5.9647742e-05 --0.021500397 0.00093678155 0.0087012843 0.0019150258 15.442127 0 4.7088586 2.1600304 0.30957174 0.30957174 5.874031e-05 7.996721e-05 -0.002532024 -0.00039608111 0.0060940308 0.0086347253 -11.812598 0 0.98621341 2.8974827 0.30957174 0.30957174 2.1328775e-06 0.00011139556 --0.024570009 -0.00091047446 -0.0088232898 0.00063090088 -6.0226922 0 5.4122391 5.015882 0.30957174 0.30957174 7.3822107e-05 7.8879881e-05 -0.0077839722 0.0020329936 -0.0037047195 -0.0056210682 17.245703 0 3.1179958 6.0710191 0.30957174 0.30957174 4.430104e-05 4.5177753e-05 --0.039532631 -0.0037819478 -0.0040340341 -0.0020427185 -19.737015 0 5.8035119 5.5521566 0.30957174 0.30957174 0.00030185525 2.0545047e-05 --0.012250269 -0.0031563696 -0.0064933408 -4.8515008e-05 3.4761564 0 6.2547188 5.0941002 0.30957174 0.30957174 0.00010722784 4.2509517e-05 --0.020164211 0.0021931873 -0.0062594778 0.0024129232 12.186319 0 4.3059156 4.7214762 0.30957174 0.30957174 8.8451567e-05 4.5275579e-05 --0.01349985 0.0010020856 0.0011732701 -0.00042396521 -2.758671 0 4.492127 1.6009301 0.30957174 0.30957174 2.9153827e-05 1.5660772e-06 -0.011940338 0.00053211711 -0.0010333154 -0.0011100165 23.970535 0 2.3307271 5.9038079 0.30957174 0.30957174 1.8230397e-05 2.2986185e-06 --0.032855231 -0.001469868 0.0093885049 -0.0047953388 23.05332 0 5.4736724 1.4761535 0.30957174 0.30957174 0.00013818148 0.00011167189 --0.0013040119 0.0051016911 0.0010505987 0.0014445138 -24.717018 0 3.543945 2.8832104 0.30957174 0.30957174 0.00023727871 3.1825032e-06 -0.014830385 0.0026351526 0.00035342521 0.0024234967 -22.66568 0 2.9624775 3.3699171 0.30957174 0.30957174 8.7400166e-05 5.9517727e-06 -0.0034470659 5.9730203e-06 0.0036363755 -0.00045466396 21.748992 0 1.9608799 1.8217055 0.30957174 0.30957174 1.3047241e-06 1.3536068e-05 -0.019246763 0.0014560245 -0.005223744 0.008943192 6.1055766 0 2.5484883 4.0480842 0.30957174 0.30957174 5.9977505e-05 0.00010684391 --0.017737434 0.00060866917 0.0025982602 -0.0089421492 17.355453 0 4.7837197 0.65926001 0.30957174 0.30957174 3.7912486e-05 8.6121459e-05 --0.025070359 0.00040220168 -0.0077550797 0.003783942 -20.686628 0 4.9415755 4.6359352 0.30957174 0.30957174 7.0470943e-05 7.4833961e-05 -0.0048789378 0.0012205469 0.002201843 0.00063487491 -2.21842 0 3.1023787 2.2236664 0.30957174 0.30957174 1.6183691e-05 5.2874404e-06 -0.017755061 0.00073764861 -0.01148556 0.0027709073 24.856687 0 2.3068942 4.8518056 0.30957174 0.30957174 3.9562984e-05 0.0001406093 --0.022584526 0.00085652986 -0.0051845834 -0.002541648 0.078798876 0 4.7540488 5.539291 0.30957174 0.30957174 6.2675979e-05 3.3506764e-05 --0.010688179 0.00079807623 -0.0012181202 0.0065446038 6.0878902 0 4.4893837 3.7013792 0.30957174 0.30957174 1.8342609e-05 4.3981418e-05 --0.02580881 0.001855245 0.0029526251 -0.0011293873 4.6273898 0 4.5069331 1.5824653 0.30957174 0.30957174 0.00010447575 1.0054264e-05 -0.007575453 0.00012723218 0.0035400182 0.0030661372 -15.522012 0 2.0969143 2.6548687 0.30957174 0.30957174 6.4472888e-06 2.1959065e-05 --0.017921493 -0.00067362811 0.0063925889 -0.002916143 4.4194926 0 5.4165781 1.5201764 0.30957174 0.30957174 3.9391771e-05 4.9633446e-05 --0.030011928 0.0020666237 0.0017256701 -0.0032989193 4.1502842 0 4.5264575 0.85960012 0.30957174 0.30957174 0.00013778342 1.3797084e-05 -0.0097984851 0.00039475159 -0.0025353846 -0.0067886982 10.986153 0 2.2968259 0.014201291 0.30957174 0.30957174 1.1959227e-05 5.2194351e-05 --0.011910322 -0.00028612888 0.0039115556 0.0061832445 23.27158 0 5.3021329 2.9481686 0.30957174 0.30957174 1.6318282e-05 5.3348362e-05 -0.00011200603 0.001223494 0.0055091531 0.0097552586 -20.599626 0 3.5058436 2.9983224 0.30957174 0.30957174 1.3637546e-05 0.00012499376 -0.011861211 -0.001669654 0.0056383016 0.0018702748 -24.329526 0 1.0366364 2.2629662 0.30957174 0.30957174 4.0838958e-05 3.5519237e-05 --0.00025165206 0.0015168639 -0.0074260134 -0.0019811617 4.27204 0 3.5341032 5.3453888 0.30957174 0.30957174 2.09665e-05 5.9488475e-05 --9.2620418e-05 0.00093640594 -0.0045775248 0.0084964115 4.8454163 0 3.5267506 4.0134631 0.30957174 0.30957174 7.9885541e-06 9.2729842e-05 --0.017291748 -0.00055083974 0.0014660424 0.0058238455 2.517491 0 5.3691173 3.2673569 0.30957174 0.30957174 3.558783e-05 3.5809727e-05 -0.024778709 0.00055545175 -0.0058949647 0.0034867791 -9.8725207 0 2.1465276 4.5561053 0.30957174 0.30957174 7.0211851e-05 4.7093211e-05 -0.018412706 0.0023554111 0.0014198901 0.0023001953 -5.4371557 0 2.8066875 2.9592209 0.30957174 0.30957174 8.7755918e-05 7.2806395e-06 --0.0096285346 0.00018019627 -0.0018623084 0.0044533971 -13.437039 0 4.9178323 3.9148683 0.30957174 0.30957174 1.0473068e-05 2.3168845e-05 --0.013045998 -0.0015939206 0.0013111444 0.008366873 -4.7859612 0 5.9254954 3.3592039 0.30957174 0.30957174 4.1826959e-05 7.117163e-05 -0.015843296 -0.00043945153 -0.0030287924 0.0011219075 -19.716298 0 1.6976063 4.7345814 0.30957174 0.30957174 2.9314309e-05 1.0496863e-05 -0.016683572 0.0034769006 -0.0043881102 0.002893346 -19.033772 0 3.0310716 4.507487 0.30957174 0.30957174 0.00014067728 2.7716239e-05 --0.0057797249 -0.0031979156 4.2988144e-06 0.0038832625 16.815099 0 0.17843932 3.5147769 0.30957174 0.30957174 9.6825662e-05 1.4957814e-05 --0.0036245307 0.00017998388 0.012787009 -0.0016758171 23.970639 0 4.6618863 1.815825 0.30957174 0.30957174 1.7372557e-06 0.00016762613 -0.0050174107 5.9520054e-06 -0.006939218 0.0063852453 -14.049776 0 1.9559024 4.3468867 0.30957174 0.30957174 2.7638938e-06 8.8986963e-05 --0.0059335386 0.00091534602 -0.0028729372 -0.0016871345 -5.3518582 0 4.134366 5.6141434 0.30957174 0.30957174 1.1497273e-05 1.1144458e-05 -0.0032547718 0.00032294699 -0.0019193693 -0.0081045785 -22.497035 0 2.6800381 0.139932 0.30957174 0.30957174 2.1129872e-06 6.8867089e-05 --0.0069659561 0.0015677065 0.0003797071 -0.0030101433 22.937586 0 3.9697199 0.50079211 0.30957174 0.30957174 2.7715026e-05 9.1330499e-06 -0.0010103707 0.0013983442 0.0047560963 0.0078404434 4.2881819 0 3.4367395 2.96702 0.30957174 0.30957174 1.7924237e-05 8.3780343e-05 -0.0093463348 0.0036194963 -0.00067273527 0.0049577378 12.773654 0 3.2396709 3.6518492 0.30957174 0.30957174 0.00012892915 2.4836682e-05 --0.026844455 -0.0014573022 -0.0026873934 -0.0019823057 2.8763654 0 5.5459431 5.7183536 0.30957174 0.30957174 9.8453875e-05 1.1178718e-05 -0.030001979 -0.00026757303 -0.0059830503 -0.0012701727 22.108311 0 1.8640325 5.2942355 0.30957174 0.30957174 9.9464517e-05 3.7688993e-05 -0.0018700843 0.00039448603 -0.0055873088 -0.0017307113 -11.346039 0 3.0360554 5.3847868 0.30957174 0.30957174 1.8015079e-06 3.4443643e-05 -0.0083069012 -0.0049188312 0.00044603555 0.00079939891 -9.6299122 0 0.55760999 3.0034943 0.30957174 0.30957174 0.00022797558 8.3444092e-07 -0.0038480694 0.00051736965 -0.0044438786 0.010740474 -9.8749499 0 2.8311749 3.9110732 0.30957174 0.30957174 4.0638573e-06 0.00013433405 --0.023044413 0.00024938103 0.012376125 0.004384834 -12.852363 0 4.9884273 2.2830475 0.30957174 0.30957174 5.8863043e-05 0.00017348837 --0.00079032486 0.0012289209 0.0050277246 0.0011894131 -5.175434 0 3.5863741 2.1755844 0.30957174 0.30957174 1.3825974e-05 2.688734e-05 --0.02254966 -0.00092388901 0.00066446611 -0.0027804578 5.1760466 0 5.4439011 0.61072 0.30957174 0.30957174 6.3595693e-05 8.1135485e-06 --0.0046542327 0.00086494783 0.00029507117 -0.0025069185 20.52348 0 4.0494487 0.4924102 0.30957174 0.30957174 9.1930175e-06 6.3216003e-06 --0.012297452 -0.0019422238 0.0037917588 -0.0025666568 24.790961 0 6.0500775 1.3538031 0.30957174 0.30957174 5.0963976e-05 2.1029096e-05 --0.020842412 -0.0002957909 -0.007225005 0.0005113734 7.6935541 0 5.2152544 5.0165983 0.30957174 0.30957174 4.8484802e-05 5.2885614e-05 --0.01435085 0.00020623474 -0.001761774 -0.0084872326 -5.6194912 0 4.9565195 0.16800594 0.30957174 0.30957174 2.2995677e-05 7.4579816e-05 -0.0062101673 0.00024212181 0.00054279172 -0.0026672972 1.4245089 0 2.2863574 0.57665016 0.30957174 0.30957174 4.7676978e-06 7.353972e-06 --0.0069300752 -0.0024261229 -0.00175283 -0.0069638985 -22.406556 0 0.070439592 0.12579135 0.30957174 0.30957174 5.8890593e-05 5.1201209e-05 -0.01702617 -0.0028091119 0.0044491484 0.0051568249 4.6466664 0 0.96140045 2.8000145 0.30957174 0.30957174 0.00010370639 4.6334102e-05 -0.032107619 0.0002519548 0.00012860135 -0.0010755339 19.317101 0 2.0164583 0.49426591 0.30957174 0.30957174 0.00011374729 1.1640929e-06 -0.017556731 -0.0010108109 -0.0015134477 0.00071419474 -8.1331979 0 1.4620706 4.6488993 0.30957174 0.30957174 4.3144933e-05 2.8151456e-06 --0.0011644835 -0.0026539341 0.0028976435 -0.0013886753 -14.325605 0 0.32616992 1.5013481 0.30957174 0.30957174 6.4309537e-05 1.0377609e-05 -0.0043829004 -0.00079012544 0.004245688 0.0099652999 8.8442768 0 0.92126982 3.1101998 0.30957174 0.30957174 7.7957634e-06 0.00011667703 --0.022316139 0.00089956413 0.0036709376 0.0026714588 -8.4756332 0 4.7347751 2.5703354 0.30957174 0.30957174 6.2041495e-05 2.0664621e-05 -0.0014940622 0.0012897784 -0.0013405744 -0.0039349018 13.268098 0 3.3894076 0.043458764 0.30957174 0.30957174 1.5398753e-05 1.7170044e-05 -0.019059554 -0.00091859731 0.0075210403 -0.0027485739 -13.171137 0 1.5313968 1.5973329 0.30957174 0.30957174 4.7565e-05 6.4520734e-05 -0.021719709 -0.0022391844 -0.0081687977 -0.0047603155 -13.595201 0 1.1910799 5.610799 0.30957174 0.30957174 9.7460764e-05 8.9750591e-05 -0.030389392 0.00037437279 -0.010867836 -0.010701686 5.3049056 0 2.0568492 5.860326 0.30957174 0.30957174 0.00010265744 0.00023267271 --0.015290156 -0.00027917384 -0.00042327693 0.00070107125 18.015667 0 5.2515032 4.0626697 0.30957174 0.30957174 2.6374607e-05 6.6815056e-07 --0.008769378 -0.002476316 -0.0093736641 0.005484056 9.4246321 0 0.0035267776 4.560867 0.30957174 0.30957174 6.430205e-05 0.00011841353 --0.024397502 -0.0015970312 -0.0046455937 -8.7369544e-05 -11.045231 0 5.6243755 5.105342 0.30957174 0.30957174 8.8576996e-05 2.1765041e-05 --0.018213993 0.001864371 -0.0059249065 0.00058631339 21.256583 0 4.3362436 4.9888454 0.30957174 0.30957174 6.808156e-05 3.5731665e-05 -0.018176071 0.0011091646 0.0010046989 0.0054461752 9.8340793 0 2.4524465 3.3320121 0.30957174 0.30957174 4.7473752e-05 3.043864e-05 -0.00098735386 -4.2634663e-05 -0.00046576571 0.010736455 15.698277 0 1.5703365 3.5596004 0.30957174 0.30957174 1.2357629e-07 0.00011455811 --0.002313395 0.00027777079 -0.0037280589 -0.0035980221 -8.6127002 0 4.2565364 5.8502833 0.30957174 0.30957174 1.2903528e-06 2.6852806e-05 -0.018028353 -0.00044226219 -0.0071286098 -0.00058844329 20.139005 0 1.7252422 5.1683863 0.30957174 0.30957174 3.746164e-05 5.1574794e-05 -0.0052252035 -3.0221664e-05 -0.0032096932 -0.0010501052 -0.67656149 0 1.8924582 5.4004882 0.30957174 0.30957174 3.005534e-06 1.1479916e-05 -0.0034999705 0.00050188683 0.008694828 -0.0016913093 -10.299796 0 2.8625179 1.7544927 0.30957174 0.30957174 3.6393099e-06 7.9053706e-05 -0.0066054735 -0.0032501001 -0.006388028 -0.0015721421 -14.859358 0 0.59381482 5.3261239 0.30957174 0.30957174 0.00010101354 4.3591196e-05 --0.0076974788 -0.0017081811 0.0071980321 0.0031023594 14.750532 0 6.1981016 2.3490964 0.30957174 0.30957174 3.308451e-05 6.1780833e-05 --0.023610648 0.0010111809 -0.0021263686 0.00088062501 -11.635494 0 4.7147201 4.6969105 0.30957174 0.30957174 7.0510799e-05 5.327531e-06 -0.021884063 0.00039664195 0.001762663 0.0024824503 -4.0074568 0 2.1087251 2.8946164 0.30957174 0.30957174 5.4006674e-05 9.2450379e-06 --0.0012069346 0.0017674205 0.00094813194 0.0072393656 18.074955 0 3.5907174 3.3846157 0.30957174 0.30957174 2.8615556e-05 5.2890929e-05 -0.0070210005 -0.00078421366 -0.0020598641 0.0061443131 -24.167038 0 1.1510365 3.8418197 0.30957174 0.30957174 1.1013582e-05 4.172495e-05 --0.0043843351 -0.0021542589 -0.002513327 -0.0090682794 20.402298 0 0.15449258 0.10183394 0.30957174 0.30957174 4.4385259e-05 8.7937067e-05 --0.01072185 -0.0017034247 0.00020886885 -0.0071592648 12.284438 0 6.0528469 0.40370424 0.30957174 0.30957174 3.9052024e-05 5.0884613e-05 --0.010296355 0.0034462408 0.010996902 0.0015180177 -22.750384 0 3.832819 2.0811747 0.30957174 0.30957174 0.0001198262 0.0001242034 --0.0067169004 0.00098276826 -0.004995511 0.0051793191 -16.000109 0 4.1595796 4.2872853 0.30957174 0.30957174 1.3750922e-05 5.1766999e-05 --0.0091450554 0.002228721 0.0053068567 0.0058013673 24.637335 0 3.939117 2.7709382 0.30957174 0.30957174 5.4428946e-05 6.1776031e-05 --0.0058371441 0.0030931251 0.0065487079 0.0027890697 -3.5734463 0 3.7201673 2.3448075 0.30957174 0.30957174 9.0893611e-05 5.095118e-05 -0.012762642 -0.00087179077 -0.0092797752 0.0019854866 -23.523367 0 1.388482 4.8775637 0.30957174 0.30957174 2.4804329e-05 9.0726493e-05 --0.004922704 0.00075727451 0.0021117211 0.0010398602 21.402748 0 4.1356957 2.3994546 0.30957174 0.30957174 7.8841334e-06 5.5682839e-06 -0.012712858 0.0020049177 0.0030244234 0.0001844958 9.1321166 0 2.907804 2.0055316 0.30957174 0.30957174 5.4358717e-05 9.2554657e-06 -0.0062904866 0.0020176083 0.00039741218 0.011813338 12.809136 0 3.1861282 3.4819907 0.30957174 0.30957174 4.1425834e-05 0.00013858575 -0.0020425273 -0.00087027967 -0.0060213672 -0.0048561099 18.607247 0 0.62646044 5.7614049 0.30957174 0.30957174 7.3573015e-06 5.9943545e-05 -0.0020643758 -1.4844984e-05 0.0048261552 0.0013984789 -1.6297393 0 1.8796843 2.2249797 0.30957174 0.30957174 4.698383e-07 2.5421573e-05 --0.0078535376 -0.0021695122 0.0020485517 0.002177001 -4.7224841 0 6.2792331 2.7568308 0.30957174 0.30957174 4.9646693e-05 8.9317853e-06 --0.00046985757 -0.00012687753 -0.0046498128 0.0074306619 -18.316821 0 6.2713624 4.078696 0.30957174 0.30957174 1.7087696e-07 7.6565284e-05 -0.00056127242 -0.0015536649 -0.0032040277 0.0038204322 19.281295 0 0.41393721 4.2177642 0.30957174 0.30957174 2.2023477e-05 2.4827161e-05 --0.0069062292 0.00078383055 0.0039238425 0.0073296828 10.051707 0 4.2846351 3.0209921 0.30957174 0.30957174 1.0832637e-05 6.8811891e-05 --0.0047479565 -0.00026011372 -0.0032333871 0.0014003697 -1.3576608 0 5.5495776 4.6809332 0.30957174 0.30957174 3.0910454e-06 1.2485196e-05 --0.00083129422 -0.00070060033 -0.00050769209 -0.0024004433 -21.890588 0 0.24477411 0.16422283 0.30957174 0.30957174 4.5471154e-06 5.9753884e-06 --0.023737452 0.00023718034 0.0029193538 0.0014182361 -17.361663 0 4.9959201 2.3941407 0.30957174 0.30957174 6.2368114e-05 1.0587231e-05 -0.019994809 -0.0019506322 0.00015428983 -0.0067688574 10.534253 0 1.2185694 0.39727611 0.30957174 0.30957174 7.8548872e-05 4.5470956e-05 --0.005304593 -0.00093528684 -0.0051455186 0.00098270075 16.565705 0 6.1006042 4.8994702 0.30957174 0.30957174 1.1057515e-05 2.7650083e-05 --0.0011478989 -0.0050412159 -0.010623534 0.010310051 -10.932819 0 0.34930895 4.3203221 0.30957174 0.30957174 0.00023164905 0.00021921712 -0.010318465 0.0022076418 0.0012566058 0.00045542564 -6.6379339 0 3.0418242 2.2902048 0.30957174 0.30957174 5.6084242e-05 1.7976657e-06 --0.01225827 0.0030030862 -0.0070131512 -0.010383856 3.5639497 0 3.9371638 6.0596968 0.30957174 0.30957174 9.8648818e-05 0.00015653784 -0.00076048918 0.00022245183 0.0020897105 0.0068278099 10.302279 0 3.156867 3.2166074 0.30957174 0.30957174 5.142647e-07 5.0644521e-05 -0.003269906 6.612929e-05 -0.0010015671 0.00034662363 -10.656117 0 2.1272784 4.756011 0.30957174 0.30957174 1.213603e-06 1.1304905e-06 -0.00084999829 0.0015383165 0.0016945898 0.0056601603 17.885384 0 3.4553098 3.2227585 0.30957174 0.30957174 2.1635903e-05 3.4673408e-05 -0.010327747 0.00018127916 0.003915124 0.0010872431 3.5910023 0 2.1036481 2.2138885 0.30957174 0.30957174 1.2008427e-05 1.6625687e-05 --0.019112788 0.0021582291 0.0055102972 -0.0021475561 1.4061774 0 4.2871756 1.5762092 0.30957174 0.30957174 8.2532438e-05 3.5185596e-05 --0.031225251 3.2662294e-05 -0.00070414114 -0.0055347213 -6.8037993 0 5.0771609 0.24673712 0.30957174 0.30957174 0.00010704408 3.0885301e-05 -0.0038813125 -0.00043592658 0.0052948687 0.0044793991 -3.774098 0 1.1482747 2.6432568 0.30957174 0.30957174 3.3848179e-06 4.8166948e-05 --0.022815542 0.0050866908 0.0040801532 -0.011941519 12.848727 0 3.9734318 0.70603404 0.30957174 0.30957174 0.00029284418 0.00015823019 --0.013294255 -0.00032947878 -0.0030949053 -0.0098343343 -12.328587 0 5.3087295 0.067076161 0.30957174 0.30957174 2.0390562e-05 0.00010558863 --0.014414265 0.001711357 -0.0048550439 -0.0005451782 -12.891687 0 4.2621449 5.1976152 0.30957174 0.30957174 4.94875e-05 2.4058416e-05 --0.013747156 -0.0010996017 -0.00052540118 0.0015111233 4.3489437 0 5.7163773 3.853034 0.30957174 0.30957174 3.1760495e-05 2.5433263e-06 --0.0088024071 0.0021527796 -0.00014561258 0.0054839917 -9.7800381 0 3.9378004 3.5426553 0.30957174 0.30957174 5.0722822e-05 2.9852365e-05 --0.024987116 0.0026327922 -0.0071478594 0.0019275965 6.3154048 0 4.3217909 4.8253145 0.30957174 0.30957174 0.00013168243 5.5193967e-05 -0.014265784 -6.5939737e-05 -0.0018431144 0.00074851557 -24.740221 0 1.9030158 4.7037449 0.30957174 0.30957174 2.2380608e-05 3.980508e-06 -0.044843198 -0.00015857461 -0.00069762464 0.0039615768 11.74479 0 1.9128951 3.6915955 0.30957174 0.30957174 0.00022098098 1.6057838e-05 -0.010164937 6.8034856e-05 0.0001782731 -0.0019426117 -19.969628 0 2.0059911 0.46655554 0.30957174 0.30957174 1.1384977e-05 3.7752666e-06 -0.0011229639 -0.0031790193 0.0059673877 0.0039439376 -15.680635 0 0.41305872 2.5253783 0.30957174 0.30957174 9.2199285e-05 5.1328869e-05 --0.0027623688 -0.0010218553 -0.0036170993 0.00076857152 10.723272 0 0.085819696 4.8789647 0.30957174 0.30957174 1.0349577e-05 1.3775986e-05 -0.014412082 -0.00052431703 0.0072613555 0.0061628764 19.122596 0 1.6250847 2.6448459 0.30957174 0.30957174 2.5305816e-05 9.0831041e-05 -0.0042583543 0.00062154499 0.0058777628 -0.0016165417 -5.7166253 0 2.8710437 1.6787742 0.30957174 0.30957174 5.5097678e-06 3.7421802e-05 --0.019161626 0.00068111387 0.0028173097 -0.0027492102 -2.5176192 0 4.7735436 1.1759893 0.30957174 0.30957174 4.4532577e-05 1.5498979e-05 -0.0066474656 0.0018150256 -0.00060901186 0.0063921863 3.6546696 0 3.1336169 3.6116502 0.30957174 0.30957174 3.4860096e-05 4.0903575e-05 -0.016764661 0.00087644042 0.0038773164 -0.0018850267 8.0435758 0 2.3895476 1.4957603 0.30957174 0.30957174 3.7850596e-05 1.8680727e-05 -0.019056724 0.0038246189 -0.00050904525 -0.0044434775 8.5503028 0 3.0153713 0.25931574 0.30957174 0.30957174 0.00017311579 1.984608e-05 --0.025608346 -0.00064035831 0.0063703773 0.0043607878 23.880813 0 5.3106554 2.5415935 0.30957174 0.30957174 7.5725751e-05 5.9775226e-05 -0.022173414 -0.0027042346 -0.0074201491 0.00040028738 12.20247 0 1.1071807 5.0332304 0.30957174 0.30957174 0.00012058881 5.5666373e-05 -0.0023770707 0.0022329495 0.0066667269 -0.0057258504 -20.803329 0 3.3995583 1.239486 0.30957174 0.30957174 4.6040222e-05 7.7327819e-05 -0.012815999 -0.00047386059 0.0025174246 -0.0025348159 18.570824 0 1.6202191 1.1603155 0.30957174 0.30957174 2.0076308e-05 1.2762425e-05 -0.0039654508 0.0012612374 0.0040018822 0.0041706351 -10.578146 0 3.1835459 2.7470841 0.30957174 0.30957174 1.6216687e-05 3.3399162e-05 -0.0078162157 0.00065960921 -0.0039358227 -0.00066963985 -7.2520812 0 2.6004831 5.2538779 0.30957174 0.30957174 1.0669978e-05 1.6061769e-05 -0.013991379 0.0016816972 -6.0328988e-05 0.0079895475 0.7030157 0 2.775766 3.5235053 0.30957174 0.30957174 4.7252078e-05 6.3320395e-05 --0.020288588 -0.0011988518 -0.002377435 -0.0031466736 3.1879901 0 5.5804842 6.0065396 0.30957174 0.30957174 5.8279567e-05 1.5519765e-05 --0.0016153618 0.00074813481 -0.00063065676 -0.0012287412 -7.7945271 0 3.7486267 6.1799848 0.30957174 0.30957174 5.3850215e-06 1.8985669e-06 --0.019166306 -0.00067525677 -0.0090667321 -0.00098812394 -21.833345 0 5.3972415 5.1943733 0.30957174 0.30957174 4.4479898e-05 8.3844248e-05 --0.026976951 -0.00030616011 -0.00012567384 -0.0067316272 18.41502 0 5.1897052 0.35548114 0.30957174 0.30957174 8.0744711e-05 4.4964317e-05 --0.0043490056 0.0024302077 0.0053537321 0.0056871682 16.045788 0 3.7098753 2.7566328 0.30957174 0.30957174 5.5875458e-05 6.0978452e-05 --0.0061937298 0.00031729588 -0.0022037751 0.0022024325 -18.368002 0 4.6500673 4.3056551 0.30957174 0.30957174 5.1283985e-06 9.7077014e-06 --0.010340672 0.0024538173 0.0058125331 0.0027567809 6.6131817 0 3.9491862 2.3848237 0.30957174 0.30957174 6.6587955e-05 4.1599343e-05 -0.0020921532 -0.0017345841 0.0032096647 0.0015086035 -21.3153 0 0.50594109 2.3813557 0.30957174 0.30957174 2.7888635e-05 1.2643409e-05 --0.006380983 0.0017308419 -0.0048233961 -0.00057979171 -12.62736 0 3.9004511 5.2053611 0.30957174 0.30957174 3.1759779e-05 2.3788242e-05 --0.033122971 -0.00039290824 -0.010612939 -0.006225721 -4.5532761 0 5.194328 5.6136733 0.30957174 0.30957174 0.00012184604 0.00015199885 --0.0045065857 0.00096043654 -0.0093718765 0.0042224773 15.209593 0 3.9915463 4.6664124 0.30957174 0.30957174 1.0632334e-05 0.00010623321 --0.011662839 0.0035424073 -0.001874666 -0.0020742023 -17.736933 0 3.8627087 5.9185342 0.30957174 0.30957174 0.00012924244 7.8105481e-06 --0.011978722 0.00085858534 -0.0091111307 -0.00011830832 12.885648 0 4.5082623 5.0995686 0.30957174 0.30957174 2.2467025e-05 8.3703289e-05 --0.018193394 0.0017678074 -0.0015860073 -0.0066738831 -19.596983 0 4.3621474 0.13915143 0.30957174 0.30957174 6.4804242e-05 4.6716489e-05 --0.0070007113 -0.00018837734 0.004008629 -0.0052585544 -7.225989 0 5.3270678 1.0295495 0.30957174 0.30957174 5.7034215e-06 4.3628899e-05 -0.027207299 0.0026267461 -0.0091949309 0.0077489454 4.9128095 0 2.666453 4.3904224 0.30957174 0.30957174 0.00014411384 0.00014479659 --0.0073907898 -0.0015488543 0.0021890935 0.0040420088 -7.7563012 0 6.174955 3.0161256 0.30957174 0.30957174 2.784937e-05 2.1036924e-05 -0.0052508804 0.00088239266 -0.0027056899 0.0027090991 10.166981 0 2.9372341 4.3047208 0.30957174 0.30957174 1.0119457e-05 1.4660309e-05 --0.0062376206 -0.0022222885 -0.0055067903 7.6035586e-05 20.497722 0 0.075404228 5.0729941 0.30957174 0.30957174 4.9258454e-05 3.0577675e-05 -0.0011600668 0.003718085 0.0018418886 0.0021718015 13.957915 0 3.4816552 2.8084998 0.30957174 0.30957174 0.00012607718 8.0987918e-06 -0.004888941 0.0023026697 0.0048486751 0.007034925 3.2507007 0 3.2869066 2.9086333 0.30957174 0.30957174 5.0924399e-05 7.2791295e-05 --0.0019089773 0.0012738029 0.004061936 0.0046143931 -21.230847 0 3.678949 2.7900544 0.30957174 0.30957174 1.5180686e-05 3.7754278e-05 --0.029734062 0.0019073797 -0.0012412268 -0.0063364438 2.3875748 0 4.5578581 0.1793253 0.30957174 0.30957174 0.00013019623 4.1379071e-05 -0.020031614 0.001530832 -0.0011327292 0.0087640664 21.439185 0 2.5532312 3.6454635 0.30957174 0.30957174 6.5397065e-05 7.7481328e-05 --0.0070787735 0.00092624506 0.0036139567 -0.00089602157 -1.874055 0 4.2139452 1.7039532 0.30957174 0.30957174 1.3316026e-05 1.3963514e-05 -0.03130363 0.0033541902 -0.0043328567 -0.0024246554 11.0041 0 2.7183862 5.5934186 0.30957174 0.30957174 0.00021005825 2.4758104e-05 -0.0037076789 -0.0016062062 0.0066348832 0.004620631 -1.1152763 0 0.62247941 2.5496103 0.30957174 0.30957174 2.5010357e-05 6.5558126e-05 --0.020259577 -0.0013017734 -0.0050446273 0.01128397 23.927798 0 5.616245 3.9393336 0.30957174 0.30957174 6.0494895e-05 0.00015195414 --0.0093466108 0.0021014875 0.0023607995 0.0021515964 -9.7022676 0 3.9700932 2.6801257 0.30957174 0.30957174 4.9819305e-05 1.0210741e-05 -0.0094890192 -0.0019311107 -0.0072773686 -0.005558389 -12.365841 0 0.86898287 5.7350463 0.30957174 0.30957174 4.3855068e-05 8.4037682e-05 -0.010066771 0.0024601402 -0.0023800336 -0.0012690324 13.722735 0 3.0937028 5.5731793 0.30957174 0.30957174 6.6257373e-05 7.3081579e-06 -0.025552186 -0.0022270443 -0.0021756589 0.012337447 8.3123626 0 1.2740597 3.6918381 0.30957174 0.30957174 0.00011685497 0.00015575391 --0.0021155025 -0.0011176084 -0.00080616291 0.012863778 -14.559997 0 0.16942082 3.5789891 0.30957174 0.30957174 1.1869345e-05 0.00016479395 -0.021920659 0.0038012735 0.00043599585 0.0038769118 -19.943068 0 2.9515281 3.4029987 0.30957174 0.30957174 0.00018437711 1.5100553e-05 -0.018750118 -0.0015649991 -0.0062782236 -0.0022950601 7.1549394 0 1.2950208 5.4345473 0.30957174 0.30957174 6.0904849e-05 4.4962113e-05 --0.0066471652 0.00019015243 -0.00079220079 -0.0010423433 14.202663 0 4.8317707 6.0036877 0.30957174 0.30957174 5.1798514e-06 1.7103925e-06 -0.027695322 0.00052376453 0.00060012119 -0.0085295793 24.40146 0 2.1156955 0.44511286 0.30957174 0.30957174 8.670131e-05 7.2528528e-05 -0.0074560243 0.0026630042 0.0055591526 -0.013598815 -12.27528 0 3.2176979 0.76521899 0.30957174 0.30957174 7.0702732e-05 0.00021458856 -0.011226358 -0.00048339717 0.0059227359 0.0045865799 -8.4102312 0 1.5712962 2.6001069 0.30957174 0.30957174 1.596393e-05 5.6231371e-05 --0.026814494 -0.00031299507 0.0042738392 0.00035299145 0.13427279 0 5.1926214 2.0268397 0.30957174 0.30957174 7.9823944e-05 1.8538195e-05 --0.006427795 -0.00085511084 0.00011168055 0.0012591304 14.088858 0 5.9675759 3.4267105 0.30957174 0.30957174 1.1196515e-05 1.5851643e-06 -0.0066964733 -0.0016320533 -0.0047150402 0.0058993004 18.169431 0 0.79750812 4.194142 0.30957174 0.30957174 2.9186421e-05 5.6933174e-05 --0.040947452 0.0016762402 -0.0016506318 -0.0057957865 -12.377123 0 4.7297567 0.094701284 0.30957174 0.30957174 0.00020965777 3.6066323e-05 --0.02830496 -0.0020364804 -0.004811988 -0.0039479415 17.201355 0 5.6668511 5.7697912 0.30957174 0.30957174 0.000125729 3.8804199e-05 -0.005006217 0.00074965926 -0.0019519844 0.0014927436 7.4436993 0 2.8833026 4.43774 0.30957174 0.30957174 7.8706236e-06 6.0515693e-06 -0.0016251602 0.00015668475 -0.0043476644 -0.0064984946 -21.8418 0 2.6657656 6.0640931 0.30957174 0.30957174 5.1357324e-07 6.0945235e-05 -0.014281775 -0.0023607709 0.0063610052 -0.0052535583 -16.456791 0 0.96053044 1.258744 0.30957174 0.30957174 7.3159851e-05 6.8168933e-05 --0.023252427 -0.0026036045 -0.0052738386 -0.0026031997 -12.347361 0 5.8819826 5.5419944 0.30957174 0.30957174 0.00012110396 3.4761956e-05 -0.010808002 -0.00011239184 0.0059550097 0.00046712564 -24.705275 0 1.8506505 2.0227483 0.30957174 0.30957174 1.293844e-05 3.5967662e-05 -0.021605656 0.0014408571 -0.0033927374 -0.0064111319 -6.9149176 0 2.4910083 6.1673918 0.30957174 0.30957174 7.0156077e-05 5.2374762e-05 -0.0073987839 0.0020404545 -0.0021868327 -0.0064374073 8.2618246 0 3.1370631 0.044343759 0.30957174 0.30957174 4.3935887e-05 4.5926354e-05 --0.037176745 0.00078848148 -0.0065442641 0.00019485976 -13.649681 0 4.8958399 5.0571629 0.30957174 0.30957174 0.00015738725 4.3214175e-05 --0.021909615 0.00064453607 -0.0042486728 0.00059740293 -4.7642509 0 4.8248618 4.9481108 0.30957174 0.30957174 5.6480664e-05 1.8552375e-05 --0.026185593 -0.0020995784 -0.00028982399 -0.0022480944 14.607233 0 5.7175252 0.24505401 0.30957174 0.30957174 0.00011542869 5.0977459e-06 -0.0034217645 0.0001339692 -0.0020852364 0.0030476663 -5.7239748 0 2.2876843 4.1197303 0.30957174 0.30957174 1.4488137e-06 1.3596823e-05 --0.0048721576 -0.0058556415 -0.0026022567 -0.0062716623 2.1315881 0 0.28321361 6.261299 0.30957174 0.30957174 0.00031495308 4.5842643e-05 -0.017944814 0.00028504136 -0.005056525 0.0038126884 -6.1974411 0 2.0887956 4.4445228 0.30957174 0.30957174 3.6090111e-05 4.0195926e-05 -0.010425455 0.00087206452 0.00088527173 -0.00070877813 -1.0411508 0 2.5962195 1.273927 0.30957174 0.30957174 1.8859323e-05 1.288399e-06 -0.021522161 -0.0010890489 -0.0038693417 0.0016094824 -3.9707024 0 1.5131772 4.6953731 0.30957174 0.30957174 6.1653048e-05 1.766334e-05 -0.0052059477 -0.00050710556 -0.0026700002 0.0071725761 -19.695721 0 1.2193234 3.8749141 0.30957174 0.30957174 5.3176955e-06 5.8216877e-05 -0.025712181 1.0120373e-05 -0.0045443859 0.0066738137 5.5195191 0 1.9486821 4.1174864 0.30957174 0.30957174 7.257629e-05 6.4999436e-05 -0.020225793 0.0019869665 0.003241667 0.0035388229 12.554327 0 2.6750859 2.7702467 0.30957174 0.30957174 8.0872016e-05 2.3016073e-05 -0.0082860847 -0.0010711439 0.0003322145 0.00060757023 -0.64814905 0 1.078333 3.0120911 0.30957174 0.30957174 1.7988837e-05 4.7742292e-07 -0.0011446278 -0.00029682452 -1.5611505e-05 -0.0037437692 -19.52397 0 0.77475293 0.3700963 0.30957174 0.30957174 9.464066e-07 1.3902724e-05 --0.0042324736 0.0017616156 0.0071848418 0.0041271184 -2.2455352 0 3.7737714 2.4629957 0.30957174 0.30957174 3.023556e-05 6.8938141e-05 --0.013357413 -0.0032462497 0.0062322547 0.0022448595 19.298632 0 6.2332174 2.288249 0.30957174 0.30957174 0.00011558233 4.4156268e-05 -0.0095013745 -0.0029395819 -0.0079479382 -0.0041041856 19.294565 0 0.71526559 5.5600557 0.30957174 0.30957174 8.8625657e-05 8.0392806e-05 --0.01603816 0.0019533014 0.002471529 0.0098066038 24.63303 0 4.249457 3.2670766 0.30957174 0.30957174 6.2992915e-05 0.00010155011 --0.0043421477 0.0025370323 0.0074020104 -0.001636158 -21.310379 0 3.7016119 1.729257 0.30957174 0.30957174 6.0702566e-05 5.7891759e-05 --0.016126722 0.0018787924 -0.001465362 -0.0032400867 -3.7117633 0 4.2715807 6.2296973 0.30957174 0.30957174 6.0704663e-05 1.2578065e-05 --0.0097040906 0.00012628976 -0.0062010247 0.0030703677 22.848507 0 4.9686899 4.6301586 0.30957174 0.30957174 1.0482917e-05 4.8117096e-05 -0.022482148 -0.0020854861 0.0091822414 -0.005939123 6.0821665 0 1.2435108 1.3746666 0.30957174 0.30957174 9.5105427e-05 0.00011998883 -0.0202727 0.0048144472 0.0057533546 0.0084543108 -19.151054 0 3.0828991 2.9145768 0.30957174 0.30957174 0.00025626176 0.00010426835 --0.011109561 -0.00075416679 -0.00056096174 0.0041062419 20.174678 0 5.6405178 3.6527575 0.30957174 0.30957174 1.8730053e-05 1.7042128e-05 -0.0049750066 -0.0021415883 0.0022892864 -0.0064872658 -14.619444 0 0.62399514 0.71610252 0.30957174 0.30957174 4.4496308e-05 4.7027881e-05 -0.015887817 0.0025212833 -0.0045676084 0.0012234556 19.527695 0 2.9107202 4.8269999 0.30957174 0.30957174 8.5617326e-05 2.2517858e-05 -0.0041147532 -0.001364635 -0.0009113549 0.0089251318 -18.179421 0 0.69395665 3.618475 0.30957174 0.30957174 1.8822399e-05 7.9851211e-05 -0.011310797 -0.00032710892 -0.003019622 -0.004540903 -0.50689128 0 1.6875056 6.0669004 0.30957174 0.30957174 1.5018929e-05 2.9645517e-05 --0.0034138674 -0.0014003846 0.0041352945 -0.0014730754 14.496404 0 0.1128126 1.6054495 0.30957174 0.30957174 1.9143585e-05 1.9392467e-05 --0.022957674 0.0003748221 -0.002913449 0.00051122967 20.605711 0 4.9390458 4.9143621 0.30957174 0.30957174 5.9138283e-05 8.8166216e-06 -0.0013311338 4.0522475e-05 0.005337762 0.00064353056 -24.333332 0 2.2156076 2.0641184 0.30957174 0.30957174 2.0947398e-07 2.9134744e-05 -0.021494839 -0.0013308233 0.0044189549 -0.003217776 -24.530539 0 1.4315726 1.3195684 0.30957174 0.30957174 6.685359e-05 2.9956704e-05 --0.02686004 0.002043184 0.0079210855 0.0063402374 14.79848 0 4.4807239 2.6161396 0.30957174 0.30957174 0.00011722791 0.00010312864 -0.024501028 0.00089481408 -0.0014978706 -0.011199513 -8.2085742 0 2.2662663 0.24027406 0.30957174 0.30957174 7.3192976e-05 0.00012667679 -0.0092387462 0.00072715389 -0.0079020521 0.002632532 -0.94778913 0 2.5671223 4.7675345 0.30957174 0.30957174 1.4186561e-05 6.9825633e-05 --0.0098246877 8.4356434e-05 0.0014958299 -0.00063030212 -20.613587 0 5.0086335 1.5491991 0.30957174 0.30957174 1.0660991e-05 2.6498152e-06 --0.0025523367 0.0021574901 -0.0028483028 0.0084708775 -17.000106 0 3.6450376 3.8427236 0.30957174 0.30957174 4.311713e-05 7.935452e-05 --0.012828359 -0.00028889474 -0.0084537507 -0.0099369586 -22.817336 0 5.2890253 5.9485536 0.30957174 0.30957174 1.8825917e-05 0.0001699932 -0.0014591012 0.00052435568 -0.0046469369 0.0016068404 1.716489 0 3.2194239 4.756274 0.30957174 0.30957174 2.7383255e-06 2.4331111e-05 -0.015714131 -0.0019589263 -0.00723486 -0.0041020758 24.295166 0 1.0962988 5.599005 0.30957174 0.30957174 6.2063912e-05 6.9460854e-05 --0.029028111 0.00081749601 -0.0012852406 0.0096613752 -12.673425 0 4.8355646 3.6492106 0.30957174 0.30957174 9.8589319e-05 9.4252728e-05 -0.0074286172 0.002941368 -0.0024419753 0.0012856802 3.6454281 0 3.2454371 4.6054125 0.30957174 0.30957174 8.4869073e-05 7.6514621e-06 --5.3578682e-05 0.0010859801 -0.0068941839 0.00051967822 -21.105306 0 3.5213089 5.0120584 0.30957174 0.30957174 1.0743483e-05 4.8185106e-05 -0.0044573175 0.00041802641 0.005851585 0.0025429214 9.5932411 0 2.6520913 2.3520854 0.30957174 0.30957174 3.772842e-06 4.0934335e-05 -0.0047936907 -0.0007652408 -0.0044542739 0.0059099758 18.107891 0 0.97670643 4.1656564 0.30957174 0.30957174 7.8570087e-06 5.4647684e-05 --0.0039028195 0.0023818991 0.0065200931 -0.0011980711 -2.841534 0 3.693863 1.7648108 0.30957174 0.30957174 5.3353657e-05 4.4281928e-05 --0.0052138782 0.0011826479 -0.0019876325 0.0080195498 -22.502997 0 3.966633 3.7607481 0.30957174 0.30957174 1.5725121e-05 6.7776039e-05 --0.0087477686 -1.3185368e-06 0.0035281027 0.00326645 -17.851223 0 5.0880623 2.6879586 0.30957174 0.30957174 8.4005308e-06 2.3132399e-05 -0.0034459217 0.0011912271 2.7133168e-05 0.0009854791 -18.423739 0 3.2084073 3.4881426 0.30957174 0.30957174 1.4229939e-05 9.6405852e-07 -0.016021441 0.00017650266 0.0016492729 -0.0050924954 -19.214417 0 2.0451166 0.68989139 0.30957174 0.30957174 2.8462065e-05 2.8466089e-05 --0.0081908829 -0.00012511556 0.0017443296 -0.0033327885 -1.0397514 0 5.2249471 0.85982315 0.30957174 0.30957174 7.5075977e-06 1.4085155e-05 -0.0028714291 0.0023390693 -0.0028731433 0.0046433995 -6.5020952 0 3.3819383 4.0736307 0.30957174 0.30957174 5.0744758e-05 2.9709064e-05 -0.020496455 -0.00012544024 -0.0068028424 0.0052565026 1.468116 0 1.889404 4.4327466 0.30957174 0.30957174 4.6261168e-05 7.4063318e-05 -0.019663919 -0.00067710465 0.0038193258 0.00057454175 17.666863 0 1.6411453 2.0932175 0.30957174 0.30957174 4.6623821e-05 1.5033591e-05 -0.0009704135 0.00011921964 -0.0073880976 -0.0046864082 2.4409788 0 2.7866511 5.6482957 0.30957174 0.30957174 2.3285176e-07 7.6813779e-05 --0.028145522 -0.00024165442 -0.0072477818 -0.0024373053 2.5248433 0 5.1647425 5.4086472 0.30957174 0.30957174 8.7494046e-05 5.885098e-05 --0.0085113248 0.0038670299 0.00023254676 0.0013097145 -24.944456 0 3.7529681 3.3387662 0.30957174 0.30957174 0.00014417343 1.7560008e-06 --0.0072022412 0.0012948197 0.010471233 0.0067947705 8.4422412 0 4.0640833 2.5169962 0.30957174 0.30957174 2.0966782e-05 0.00015633613 -0.0013019153 0.0010555219 0.003523204 -0.0025129698 -2.5195787 0 3.3813089 1.3293579 0.30957174 0.30957174 1.0335068e-05 1.8778109e-05 -0.0029117239 0.00060616435 -0.0056042552 -1.0587839e-05 11.009424 0 3.0306319 5.0885632 0.30957174 0.30957174 4.2778101e-06 3.1663816e-05 -0.0082246031 0.00039601837 -0.0014642402 -0.0053836771 -20.716429 0 2.3584472 0.10668278 0.30957174 0.30957174 8.8543942e-06 3.0911095e-05 --0.0021089357 -0.0023089825 0.0029699799 0.0048145638 1.6092551 0 0.27436818 2.9595239 0.30957174 0.30957174 4.9053977e-05 3.188528e-05 --0.0095578027 -0.001782569 -0.0045131282 -0.0076899127 13.971151 0 6.1254878 6.1232109 0.30957174 0.30957174 3.8973825e-05 7.9190966e-05 -0.018430006 -0.0021132369 0.00079722465 0.0062312655 7.8997997 0 1.1379328 3.3876188 0.30957174 0.30957174 7.7967799e-05 3.9155454e-05 --0.010254556 -0.0029740318 0.0045738407 -0.0033933582 -22.681538 0 0.012451911 1.3106764 0.30957174 0.30957174 9.2114908e-05 3.2512327e-05 -0.016702139 0.0022057195 0.0024639242 -0.0032954458 -21.571876 0 2.8223837 1.0202101 0.30957174 0.30957174 7.4942473e-05 1.6892562e-05 -0.015252302 0.00044692279 0.0062601648 -0.013689817 -21.206452 0 2.2059382 0.80627553 0.30957174 0.30957174 2.7357226e-05 0.00022540484 --0.010456679 0.00083288514 0.010854169 -0.0010988288 8.8821185 0 4.4590068 1.845015 0.30957174 0.30957174 1.8322404e-05 0.00011997104 --0.029106988 -0.0015194858 0.0059991882 0.0047785651 -15.418346 0 5.530579 2.6137684 0.30957174 0.30957174 0.00011403698 5.893369e-05 --0.017521098 0.0045319198 -0.0035545396 -0.0043461613 -5.8082143 0 3.9172677 5.9679687 0.30957174 0.30957174 0.0002207914 3.1474131e-05 -0.0040274497 -0.00048124219 0.010554791 -0.0013725758 -15.025896 0 1.117356 1.8168136 0.30957174 0.30957174 3.8902988e-06 0.00011418049 --0.0083211505 -4.0008728e-05 -0.0018749552 -0.0036809549 0.92739881 0 5.1304599 6.1830815 0.30957174 0.30957174 7.6157102e-06 1.6983984e-05 --0.009266416 0.0020094124 0.0048718891 0.0050369513 -23.972833 0 3.9845178 2.7430937 0.30957174 0.30957174 4.620744e-05 4.9094521e-05 -0.0092427362 0.0009105188 -0.0029837337 0.001386056 18.489908 0 2.676463 4.6549059 0.30957174 0.30957174 1.6930127e-05 1.0880857e-05 -0.001853011 0.00021739583 0.010056025 0.0049202271 -8.808651 0 2.7636988 2.3969356 0.30957174 0.30957174 8.0745352e-07 0.00012596087 --0.0005861777 0.00011642088 0.0044535789 0.003929394 20.896541 0 4.0208265 2.6640207 0.30957174 0.30957174 1.611867e-07 3.5311341e-05 -0.018313581 0.001895374 0.00087204354 -0.0033902877 -22.451385 0 2.7010506 0.62802653 0.30957174 0.30957174 6.9542719e-05 1.2167771e-05 --0.017367809 0.00070440798 0.0038904499 -0.00061674373 -1.4572297 0 4.732784 1.789128 0.30957174 0.30957174 3.7633207e-05 1.563628e-05 --0.0018888253 0.00010013663 -0.0083897758 0.0032906554 13.498952 0 4.6367856 4.7156575 0.30957174 0.30957174 4.8298996e-07 8.1702985e-05 --0.0044808736 -0.0010340866 -0.00097804904 -0.0029056897 -8.4774386 0 6.2134806 0.047151908 0.30957174 0.30957174 1.1945104e-05 9.3391414e-06 -0.0097314168 0.0026011235 0.002825582 0.0058358737 9.2540472 0 3.1261952 3.0617932 0.30957174 0.30957174 7.2028551e-05 4.1831035e-05 --0.0025310071 0.0010572698 -0.0040989131 -0.0032319477 -7.3525137 0 3.7728782 5.7504281 0.30957174 0.30957174 1.0885868e-05 2.7299073e-05 -0.0066634802 -0.0032518584 0.001960526 0.0026861322 -8.0669032 0 0.59556457 2.8815294 0.30957174 0.30957174 0.00010120217 1.1031959e-05 -0.0089779683 -0.0025835325 -0.011105286 -0.0056138482 18.613118 0 0.73874274 5.5514753 0.30957174 0.30957174 6.9650265e-05 0.00015559318 -0.01009733 -0.0021845249 0.0054087619 0.0066158675 -19.418081 0 0.84386004 2.8265641 0.30957174 0.30957174 5.4663734e-05 7.290897e-05 --0.012828911 0.00052907861 0.010051038 0.0013506232 -17.695435 0 4.7273218 2.0776055 0.30957174 0.30957174 2.0617138e-05 0.00010365632 --0.01592016 -0.0016987307 -0.0043812131 -0.003121169 -15.077328 0 5.857889 5.7018564 0.30957174 0.30957174 5.4109944e-05 2.9014428e-05 -0.010367531 -0.00012658773 0.00048683125 0.0089760118 -10.608353 0 1.8343262 3.4612683 0.30957174 0.30957174 1.194543e-05 8.0156255e-05 -0.0018812124 0.0018283489 -0.0066856692 0.0010335194 24.312033 0 3.4034186 4.934537 0.30957174 0.30957174 3.0839864e-05 4.6122067e-05 --0.035713608 0.0038261506 0.0084334606 0.0073860078 -23.824135 0 4.313474 2.6603566 0.30957174 0.30957174 0.00027337243 0.00012581504 -0.0083634583 -0.00014143264 -0.0040470357 0.0028735532 -22.455303 0 1.7922514 4.4730847 0.30957174 0.30957174 7.8608357e-06 2.4702552e-05 --0.0096939978 0.0011222833 -0.0053561336 -0.00056104791 20.623313 0 4.2747223 5.1902195 0.30957174 0.30957174 2.178958e-05 2.9234257e-05 --0.026852622 0.00015732132 0.0073948765 0.0011937416 -0.16308284 0 5.0333708 2.1038717 0.30957174 0.30957174 7.9381619e-05 5.6543469e-05 --0.0091287137 0.00022960234 0.0017722976 -0.0031498745 1.9687386 0 4.8614606 0.8902856 0.30957174 0.30957174 9.628313e-06 1.3008128e-05 --0.014119352 -0.0019300219 -0.0027030041 -0.0078900495 -20.895062 0 5.9808637 0.041750218 0.30957174 0.30957174 5.5817e-05 6.9115303e-05 --0.01575739 0.0016383026 0.0059302966 0.0011998696 -18.773975 0 4.3284499 2.1431582 0.30957174 0.30957174 5.1707006e-05 3.6883148e-05 -0.0050254214 -0.00053039581 -0.0016955236 0.00015093639 2.6462729 0 1.1793617 4.998617 0.30957174 0.30957174 5.33505e-06 2.9208326e-06 -0.015420888 -0.00028318337 0.0029194086 -0.005150413 22.131699 0 1.7793501 0.89346304 0.30957174 0.30957174 2.683589e-05 3.4904686e-05 -0.016713076 0.001800153 -0.0017542133 0.0070929811 15.080008 0 2.7209876 3.7602436 0.30957174 0.30957174 6.0183067e-05 5.3005928e-05 --0.005803232 -0.00099206879 -0.0071653565 -0.0025378289 -8.8857127 0 6.0866455 5.4245365 0.30957174 0.30957174 1.2662468e-05 5.8149363e-05 -0.0057237815 -0.0014717238 -0.00044071578 0.0017913706 17.549319 0 0.77781398 3.7590138 0.30957174 0.30957174 2.3327124e-05 3.3788747e-06 -0.00064482392 -0.0016567268 -0.0034741173 0.0083041781 -17.038841 0 0.41700122 3.915023 0.30957174 0.30957174 2.504855e-05 8.0569657e-05 -0.006754238 -0.0016413079 0.0067927632 -0.0017100325 -8.4879665 0 0.7986081 1.700393 0.30957174 0.30957174 2.954767e-05 4.9418335e-05 -0.0068480309 0.002003633 -0.0040694099 0.0047844797 -11.869002 0 3.1569499 4.224712 0.30957174 0.30957174 4.1718053e-05 3.9401242e-05 --0.012454772 0.0017454962 0.0004579688 0.0010962501 4.3821046 0 4.1803678 3.1172751 0.30957174 0.30957174 4.4782811e-05 1.4034921e-06 --0.022007144 -0.0020917023 0.003591956 -0.0028126578 -2.8160697 0 5.8002931 1.2847179 0.30957174 0.30957174 9.302209e-05 2.08544e-05 --0.011004308 0.0018885232 0.0024759875 0.0087214221 -21.363802 0 4.0849675 3.2371336 0.30957174 0.30957174 4.5782194e-05 8.1628655e-05 -0.01205943 0.0035825733 -0.00039879259 0.0038473208 -9.0525965 0 3.1619315 3.6200146 0.30957174 0.30957174 0.00013288216 1.4842523e-05 --0.0006037204 8.4311494e-05 -0.00089224238 -0.0076024907 -24.618273 0 4.1820811 0.25652924 0.30957174 0.30957174 1.0476468e-07 5.8133104e-05 --0.017208456 0.00025463787 -0.0020662287 -0.0085191171 12.336419 0 4.9527031 0.13448834 0.30957174 0.30957174 3.3099023e-05 7.6292626e-05 --0.046296157 -0.0011160796 0.004484185 -0.0033187855 4.4056894 0 5.3028612 1.3118334 0.30957174 0.30957174 0.00024663573 3.1197107e-05 -0.010263922 0.00032991328 -0.00034828009 0.0054134007 -22.958289 0 2.2299374 3.5806633 0.30957174 0.30957174 1.2556288e-05 2.919024e-05 --0.011063364 0.00081998174 -0.0054030322 -0.0025024092 10.572918 0 4.4928308 5.517336 0.30957174 0.30957174 1.9561359e-05 3.5642148e-05 --0.011248791 -0.0030229635 0.0020514899 0.0036568983 -21.400515 0 6.2696794 3.0011783 0.30957174 0.30957174 9.7134959e-05 1.7507692e-05 --0.0083544498 -0.00072460522 -0.0022676445 0.0027832524 -12.367066 0 5.7553534 4.2035399 0.30957174 0.30957174 1.2444989e-05 1.2867987e-05 --0.01033679 -0.0019827191 0.0017255639 -0.004845136 8.8220387 0 6.1376708 0.71901171 0.30957174 0.30957174 4.7540143e-05 2.6287367e-05 --0.017287188 0.0024950869 -0.0031469823 0.0046577477 17.827751 0 4.1661366 4.1138572 0.30957174 0.30957174 8.951656e-05 3.1503422e-05 -0.0063572339 0.00020075661 -0.0018845503 -0.0077420501 -6.0031951 0 2.2252008 0.13365402 0.30957174 0.30957174 4.803711e-06 6.3035159e-05 -0.00016520961 -0.00016519788 0.0042442033 -0.0029305383 -24.054206 0 0.48364715 1.3445789 0.30957174 0.30957174 2.5159425e-07 2.6678715e-05 -0.0032011746 0.0010940523 0.0047507769 0.00086811748 -16.346477 0 3.2050971 2.1244041 0.30957174 0.30957174 1.2028413e-05 2.35014e-05 --0.0040441491 0.00031261351 9.3128358e-05 0.005351643 3.647434 0 4.4731791 3.498351 0.30957174 0.30957174 2.6856523e-06 2.8417246e-05 -0.0017542436 0.00029538813 -0.002380338 0.0013598323 16.406408 0 2.9381545 4.571147 0.30957174 0.30957174 1.1326554e-06 7.5463893e-06 --0.0063623629 -0.0013872394 -0.00027939614 -0.00063110786 -0.04334764 0 6.1910614 6.2376992 0.30957174 0.30957174 2.1974123e-05 4.737751e-07 --0.014498168 0.0010233016 0.0061316873 -0.0063750455 -14.033453 0 4.515284 1.1442996 0.30957174 0.30957174 3.2613628e-05 7.8216663e-05 --0.0055032796 -0.00096450523 0.0094534358 0.0053524008 23.400583 0 6.0979044 2.4568079 0.30957174 0.30957174 1.1798899e-05 0.0001185125 -0.024946727 8.0730908e-05 0.0095025147 -0.0011718623 22.577349 0 1.9745672 1.8233772 0.30957174 0.30957174 6.8377896e-05 9.2396031e-05 --0.0087465465 -1.5294253e-05 -0.0046742929 -0.002783183 18.482378 0 5.1026166 5.6201748 0.30957174 0.30957174 8.4002987e-06 2.9710596e-05 --0.011667827 0.00018035292 -0.0014194355 0.0021924083 -24.504992 0 4.9468027 4.0941707 0.30957174 0.30957174 1.5241144e-05 6.7990093e-06 -0.021252338 -0.00019862287 -0.0025600589 -0.0024045952 -19.728667 0 1.8601658 5.8367332 0.30957174 0.30957174 4.9941458e-05 1.2342653e-05 --0.0093259138 0.0018126013 0.011160069 0.0081509858 22.557053 0 4.0300335 2.572054 0.30957174 0.30957174 3.9476671e-05 0.00019146377 --0.0064703204 0.0022918046 -0.00017757641 -0.0050547524 -18.396142 0 3.8164321 0.3388981 0.30957174 0.30957174 5.244162e-05 2.5375714e-05 -0.036882334 0.0018510552 -0.002136524 0.00040315373 -5.9662818 0 2.3739074 4.9016598 0.30957174 0.30957174 0.00018054278 4.7631642e-06 --0.000929949 0.0037604455 -0.00018346378 0.0035494042 -15.644103 0 3.5430338 3.5679558 0.30957174 0.30957174 0.00012891018 1.2530336e-05 -0.0017897709 0.00033313943 0.010306247 0.0043174853 -23.400215 0 2.9830294 2.3389205 0.30957174 0.30957174 1.3626222e-06 0.00012557454 --0.016694051 0.0012432839 -0.0013125598 -0.0024907384 -1.3202587 0 4.4905953 6.1691345 0.30957174 0.30957174 4.4674761e-05 7.8904718e-06 -0.0076590306 0.00084688621 -0.00033244247 -0.0023630708 14.80508 0 2.7341097 0.23341073 0.30957174 0.30957174 1.2972994e-05 5.6503702e-06 -0.0086119818 -0.00022053165 -0.0017612922 0.010122982 0.080706975 0 1.715926 3.6895342 0.30957174 0.30957174 8.5847733e-06 0.0001047736 --0.015238587 -1.078569e-05 0.0044162149 0.0026284854 -21.743396 0 5.0931367 2.4784103 0.30957174 0.30957174 2.5492873e-05 2.6515009e-05 -0.0068330639 0.00067946982 -0.0039440834 -0.0010384082 -16.480264 0 2.6811195 5.3421376 0.30957174 0.30957174 9.3311816e-06 1.6752174e-05 --0.0096407755 0.0025119854 -0.012695401 0.00013726557 9.5404072 0 3.9146376 5.0759649 0.30957174 0.30957174 6.7683985e-05 0.00016250575 --0.036147363 0.0011197376 -0.0011343276 0.002233997 -18.894127 0 4.8116589 3.9890121 0.30957174 0.30957174 0.00015485956 6.2475761e-06 --0.0024557189 5.0741463e-05 0.0071262882 -0.0068193939 21.336684 0 4.9006428 1.185756 0.30957174 0.30957174 6.8547013e-07 9.7326069e-05 --0.016101091 0.00075801944 0.00088847143 -0.001065354 -7.5934224 0 4.6815552 1.0734094 0.30957174 0.30957174 3.3693339e-05 1.9216182e-06 -0.0084403551 0.0024615746 0.0012624293 0.011942485 13.04491 0 3.1558883 3.4097228 0.30957174 0.30957174 6.3017365e-05 0.00014307643 -0.0072905714 -0.0016271251 0.00048597473 0.00035264055 18.843642 0 0.83142424 2.568967 0.30957174 0.30957174 2.9952317e-05 3.6144649e-07 --0.034059196 -0.0005623167 0.0036284195 -0.0032659028 -24.557335 0 5.2359661 1.2162672 0.30957174 0.30957174 0.00013022487 2.3852626e-05 --0.024736767 0.001169105 0.0061351083 -0.0050207139 13.432062 0 4.6801475 1.2632376 0.30957174 0.30957174 7.9624139e-05 6.2950126e-05 --0.020157501 0.0019154821 -0.0019959614 -0.0018874696 15.881831 0 4.3731934 5.8401055 0.30957174 0.30957174 7.8028076e-05 7.5500725e-06 --0.0059296495 -0.00044044061 0.0018892424 -0.0045768811 -24.211326 0 5.6815533 0.76864623 0.30957174 0.30957174 5.6269498e-06 2.4376792e-05 -0.020048551 -0.0018980578 0.013320714 -0.0046406712 3.8752176 0 1.2334404 1.6123799 0.30957174 0.30957174 7.6941902e-05 0.00020024959 -0.0013341341 -0.002268578 -0.0026385852 -0.0052158388 -10.849156 0 0.43876985 6.1858675 0.30957174 0.30957174 4.707631e-05 3.4003884e-05 -0.023611897 0.0014020247 -0.0037865703 0.0005006172 2.4009631 0 2.440923 4.9562938 0.30957174 0.30957174 7.9109112e-05 1.4703587e-05 --0.014518577 0.00072383532 0.0041671872 0.0012158258 -2.7975386 0 4.6603852 2.2268029 0.30957174 0.30957174 2.7912537e-05 1.8973288e-05 -0.036477903 0.0019199048 -0.004231345 -0.0018830973 -18.97278 0 2.3921651 5.5023991 0.30957174 0.30957174 0.00017965085 2.1567615e-05 --0.013371849 0.0018316439 -0.0019797787 0.0012395815 21.698757 0 4.1915009 4.5309293 0.30957174 0.30957174 5.0190048e-05 5.4756126e-06 -0.0071122637 -0.00120309 0.0063986462 0.0028046292 -20.010583 0 0.94994732 2.3552149 0.30957174 0.30957174 1.8738137e-05 4.9078771e-05 -0.00070761696 0.00077383109 0.0050552371 -0.0020504683 -6.1235014 0 3.4158443 1.5625807 0.30957174 0.30957174 5.5097952e-06 2.9934169e-05 --0.0085880125 0.00088146908 0.0042565295 0.0021758784 4.0212164 0 4.33488 2.4143704 0.30957174 0.30957174 1.5174362e-05 2.2961903e-05 -0.01065017 -0.001228234 -0.0024863877 0.0067308857 19.567796 0 1.1350555 3.8723919 0.30957174 0.30957174 2.6193609e-05 5.1171012e-05 --0.0092613591 0.00129738 -0.0045532702 0.013069822 17.919371 0 4.1805809 3.8536545 0.30957174 0.30957174 2.4748732e-05 0.0001903403 --0.0010426416 -0.00052424815 0.0053348849 -0.0072124488 17.42298 0 0.15934531 1.0150482 0.30957174 0.30957174 2.6229245e-06 8.02918e-05 -0.013194642 0.003021991 -0.0081194348 -0.0084269381 20.58114 0 3.0689345 5.8866125 0.30957174 0.30957174 0.00010230276 0.00013690171 --0.013393602 0.0038521778 -0.0024285355 -0.00074335523 -7.5248944 0 3.8805094 5.381461 0.30957174 0.30957174 0.00015486928 6.4939712e-06 -0.022940433 0.0019172436 0.003177153 -0.0026172473 15.3116 0 2.5958 1.2600092 0.30957174 0.30957174 9.1256078e-05 1.6971183e-05 --0.010966187 -0.0012038565 -0.002088726 -0.0048552387 -13.009764 0 5.8720963 6.2482629 0.30957174 0.30957174 2.6403431e-05 2.7781073e-05 -0.022275252 0.0014240559 -0.0061590623 0.010971826 9.9649528 0 2.4724461 4.030883 0.30957174 0.30957174 7.294313e-05 0.00015765086 -0.017672727 -0.0036149889 0.0063484624 -0.0014136372 9.3211983 0 0.86685233 1.7277133 0.30957174 0.30957174 0.00015332878 4.2613728e-05 --0.019423649 -0.0013319146 -0.00012111239 -0.0053413944 -11.175346 0 5.6450342 0.35144511 0.30957174 0.30957174 5.7576465e-05 2.8314588e-05 --0.012381933 -0.00063378381 0.002136763 0.010194786 -21.324808 0 5.5229941 3.3076538 0.30957174 0.30957174 2.0489231e-05 0.00010769625 --0.00024468418 -0.001403428 -0.0040286965 0.0015514708 8.3752684 0 0.35516326 4.7218036 0.30957174 0.30957174 1.7948494e-05 1.87503e-05 --0.0068431231 0.00010889823 -0.0093725237 -0.010429326 8.6305019 0 4.9427297 5.9213677 0.30957174 0.30957174 5.2487002e-06 0.00019645161 --0.0046787373 0.0023222746 8.4705964e-05 -0.0010624035 7.2441161 0 3.733559 0.45450827 0.30957174 0.30957174 5.152958e-05 1.1268083e-06 -0.011384289 0.0025637408 0.0053414273 -0.0030830999 19.831525 0 3.0623238 1.4251145 0.30957174 0.30957174 7.4101131e-05 3.8192068e-05 -0.0038457653 0.0023132148 0.0047849111 0.0013333332 -1.4034043 0 3.3353733 2.2147644 0.30957174 0.30957174 5.0367526e-05 2.4845415e-05 --0.0040818745 -0.0019592149 0.0019050864 0.0023085614 -0.92638659 0 0.14945553 2.8219694 0.30957174 0.30957174 3.6795624e-05 8.9453025e-06 --0.0052465665 0.0010306105 -0.0035777018 0.0048258562 -1.4162307 0 4.0255021 4.1577308 0.30957174 0.30957174 1.2697369e-05 3.600487e-05 --0.016286977 -0.00063680974 0.001003173 -0.0067030453 14.307833 0 5.4288505 0.52405004 0.30957174 0.30957174 3.2814159e-05 4.5582072e-05 -0.012864515 -0.00025413965 -0.0035216 -0.0034820403 -3.9614501 0 1.7670457 5.8623801 0.30957174 0.30957174 1.8755973e-05 2.4529329e-05 --0.01224789 -0.0013834495 -0.0036022877 -0.0029613458 -15.64431 0 5.8863508 5.770766 0.30957174 0.30957174 3.3902469e-05 2.1780917e-05 -0.0028230857 -0.0034279499 0.001420614 0.0055273881 3.1054242 0 0.46446193 3.2623599 0.30957174 0.30957174 0.00010791773 3.2339575e-05 --0.011172317 -0.0011057631 -0.0030061962 0.0034968522 -14.06491 0 5.8203803 4.2299994 0.30957174 0.30957174 2.4840582e-05 2.1239986e-05 -0.020349504 0.001746135 0.0018689019 0.0068426358 0.80735863 0 2.6085483 3.247199 0.30957174 0.30957174 7.3233284e-05 4.9964338e-05 -0.0040320056 0.0013125199 0.00049828247 -0.010544132 -4.9397387 0 3.1906392 0.42190635 0.30957174 0.30957174 1.7477453e-05 0.00011053006 -0.00029281152 0.0012803998 -0.0057616225 0.00015561112 -24.992567 0 3.4907936 5.0599058 0.30957174 0.30957174 1.4943539e-05 3.3490922e-05 --0.024759085 -0.0011578942 0.0038225558 0.0051677639 15.83953 0 5.4894177 2.8751352 0.30957174 0.30957174 7.9507764e-05 4.1220891e-05 -0.0026213031 -0.00082140491 0.0041347305 -0.0057050972 -3.4704809 0 0.7112647 1.0053027 0.30957174 0.30957174 6.9004543e-06 4.9520313e-05 -0.0068238611 -0.00034475931 0.0029960451 0.0023324664 -24.628506 0 1.5137684 2.6026676 0.30957174 0.30957174 6.1945058e-06 1.4445868e-05 -0.021341319 0.00049869639 0.00096780924 -0.0014361933 -17.011648 0 2.1548309 0.97104217 0.30957174 0.30957174 5.2263627e-05 2.9902631e-06 -0.01707985 0.00077025989 0.002083915 0.0022620079 -24.775384 0 2.3348878 2.7674041 0.30957174 0.30957174 3.7428882e-05 9.4534096e-06 --0.0032639948 0.0009041162 0.0044487085 -0.0052339241 -19.713856 0 3.8932154 1.0827891 0.30957174 0.30957174 8.6157692e-06 4.7124797e-05 --0.01643993 0.00088061124 -0.0008670136 -2.9275059e-05 -21.264078 0 4.6327302 5.1201691 0.30957174 0.30957174 3.6733674e-05 7.5869048e-07 -0.017089655 0.0024017346 0.0045191778 -0.00095361207 9.9221083 0 2.8527686 1.738767 0.30957174 0.30957174 8.4606948e-05 2.1491475e-05 --0.0078338161 -0.00035546654 -0.00093505782 0.0049465135 3.9593897 0 5.4786478 3.7042095 0.30957174 0.30957174 7.8878972e-06 2.5151612e-05 --0.032671645 -0.0005708119 0.0017581321 -0.0049914753 16.883819 0 5.2445171 0.71550969 0.30957174 0.30957174 0.00012014803 2.7829594e-05 -0.0057935707 0.00091738534 0.007905678 -0.0033351046 6.101287 0 2.9096943 1.5487862 0.30957174 0.30957174 1.1351129e-05 7.4042214e-05 --0.0017668348 0.00018263501 -0.0027341681 -0.0064778403 7.9931724 0 4.3313485 6.2551738 0.30957174 0.30957174 6.4653964e-07 4.9159728e-05 -0.0075970333 -0.0012284858 -0.0086880521 -0.0021382214 10.969511 0 0.97070235 5.3261267 0.30957174 0.30957174 2.0083434e-05 8.0632586e-05 -0.01161521 -0.0034872414 0.012247736 -0.0047697307 -12.196327 0 0.72484175 1.5764658 0.30957174 0.30957174 0.00012558814 0.00017379624 --0.010969714 -0.0019230098 -0.0062562831 -0.0043274089 10.353042 0 6.0980113 5.6880234 0.30957174 0.30957174 4.6896146e-05 5.8035195e-05 -0.027333291 -0.0013670382 -0.0068586791 0.0034165994 9.4929626 0 1.517601 4.6277611 0.30957174 0.30957174 9.9038905e-05 5.9003714e-05 -0.032909942 -0.00014153298 0.0033595177 -0.0035457833 16.952728 0 1.9059407 1.136785 0.30957174 0.30957174 0.00011907801 2.3849282e-05 --0.0015808437 0.0038903992 -0.0043252945 -0.0018202428 2.6362502 0 3.5604707 5.4821339 0.30957174 0.30957174 0.00013814663 2.214717e-05 -0.010370751 0.00099213937 -0.0024354171 -0.0022203493 2.435111 0 2.6619223 5.8218859 0.30957174 0.30957174 2.0773516e-05 1.0869695e-05 --0.029249316 9.1433407e-05 -0.007148427 -0.0059371245 -5.0368721 0 5.058221 5.7757951 0.30957174 0.30957174 9.399284e-05 8.6480989e-05 -0.0043607386 -0.0020309532 0.0048716449 -0.0081117915 21.973347 0 0.6057816 0.9187241 0.30957174 0.30957174 3.9661617e-05 8.9195491e-05 --0.022434375 0.00060016139 0.0095932737 0.0073975246 -24.62905 0 4.8476555 2.5980535 0.30957174 0.30957174 5.8532032e-05 0.000147062 -0.0077166947 -0.00071216852 -0.0058661315 -0.013031246 9.4042922 0 1.2460276 6.2314524 0.30957174 0.30957174 1.1157062e-05 0.0002031323 -0.0087616801 -0.0010597927 0.005846442 0.0026138809 -10.480703 0 1.1112793 2.3625103 0.30957174 0.30957174 1.8658548e-05 4.1236647e-05 -0.0096928197 -0.0028807355 0.0017087298 0.00086426688 24.957752 0 0.72812329 2.4101074 0.30957174 0.30957174 8.5909043e-05 3.6844761e-06 --0.01428211 -0.001814169 0.0036709271 -0.0021011105 -12.914259 0 5.9447919 1.4287378 0.30957174 0.30957174 5.2373028e-05 1.7964526e-05 -0.00020475529 0.00047447037 0.0092583953 0.0085980715 13.81195 0 3.4685546 2.6894851 0.30957174 0.30957174 2.0553247e-06 0.00015974571 -0.031319116 -0.00089920954 -0.0078316555 0.0018718804 0.025976705 0 1.6892855 4.8539052 0.30957174 0.30957174 0.00011504447 6.531042e-05 --0.010746638 0.0018329078 -0.0013559368 -0.0043797389 1.0041605 0 4.0877845 0.071764553 0.30957174 0.30957174 4.3281585e-05 2.0880561e-05 -0.0022530813 0.0003200075 0.0075283651 0.0092231126 -6.6570102 0 2.8578909 2.8273414 0.30957174 0.30957174 1.4901132e-06 0.00014151627 --0.029899302 0.00088306143 0.0010260946 -0.0052048327 12.793803 0 4.8238714 0.57049336 0.30957174 0.30957174 0.00010524062 2.7932688e-05 -0.015033962 0.0021730399 0.0028817612 -0.0023175901 3.008617 0 2.8663513 1.2717449 0.30957174 0.30957174 6.782721e-05 1.3700037e-05 --0.014268185 0.0014212148 0.0062023695 0.0010555834 6.1045144 0 4.3498227 2.112334 0.30957174 0.30957174 4.0748111e-05 3.9888228e-05 --0.037640841 -0.0023250854 -0.0070405535 0.0026341992 3.2043286 0 5.5992221 4.7313234 0.30957174 0.30957174 0.00020478115 5.685637e-05 -0.040639615 0.0035191906 -0.0047804271 8.3476588e-05 15.873022 0 2.6129876 5.06937 0.30957174 0.30957174 0.00029412223 2.3045684e-05 --0.0025092893 0.00098625293 -0.0052903476 -0.0017801624 -12.306402 0 3.7882541 5.4088343 0.30957174 0.30957174 9.5518581e-06 3.1359282e-05 --0.022711854 0.00020517652 0.004527662 0.0026129869 -3.3578527 0 5.0045811 2.4650121 0.30957174 0.30957174 5.7009561e-05 2.7439325e-05 -0.0088922734 -0.00078239387 -0.0099722594 0.0064201986 -13.720662 0 1.2694442 4.5183698 0.30957174 0.30957174 1.425656e-05 0.00014114228 --0.020025398 -0.0013293701 -0.0018774155 -0.0065131417 -14.118982 0 5.6305712 0.091489365 0.30957174 0.30957174 6.0120711e-05 4.5631425e-05 -0.010583794 0.00026753329 0.004393252 0.00030728302 5.3976097 0 2.1714152 2.0143644 0.30957174 0.30957174 1.2948851e-05 1.9551658e-05 --0.02080904 -0.00085776293 0.0031108496 -0.00030368126 12.30602 0 5.4458936 1.8485668 0.30957174 0.30957174 5.4237503e-05 9.8477497e-06 --0.039667645 -0.00080496085 0.00020959061 0.00070191523 22.904526 0 5.2694791 3.2234894 0.30957174 0.30957174 0.00017863905 5.3298752e-07 -0.013266365 0.0013340027 -0.0061134111 0.0091920831 24.435387 0 2.6866791 4.1065413 0.30957174 0.30957174 3.5531072e-05 0.00012148964 --0.028606707 -0.0015264381 -0.0015251114 0.0054984049 6.7864216 0 5.5391319 3.7885627 0.30957174 0.30957174 0.00011106028 3.2332927e-05 -0.013653339 -0.00044977668 -0.0034795485 -0.00054587926 -10.411999 0 1.6535603 5.2410648 0.30957174 0.30957174 2.2306751e-05 1.2501528e-05 --0.0062689964 -0.0023146868 0.0066448973 0.013682727 23.253016 0 0.085308406 3.0605998 0.30957174 0.30957174 5.3120263e-05 0.00023021779 --0.031550715 0.00020679736 -0.010383531 -0.0050099352 12.519858 0 5.0270532 5.5330604 0.30957174 0.30957174 0.00010966681 0.00013359312 -0.014410572 -0.00058523453 0.0015665249 -0.0094960259 24.419514 0 1.5907649 0.53910301 0.30957174 0.30957174 2.591675e-05 9.1919374e-05 -0.018201416 0.0001674161 0.011668971 -0.0057786224 5.8637539 0 2.0286891 1.4885069 0.30957174 0.30957174 3.6623509e-05 0.00017039735 --0.002882336 0.00011771851 0.0051181967 0.00098795107 5.4416126 0 4.7305168 2.1342735 0.30957174 0.30957174 1.0382465e-06 2.7377636e-05 --0.011853312 0.0014265491 -0.0047921558 0.0066569488 -24.608321 0 4.2553781 4.1436866 0.30957174 0.30957174 3.3961746e-05 6.7108603e-05 --0.017087612 0.00037460349 -0.0067904162 -0.0035698894 -0.87846195 0 4.8895817 5.5673679 0.30957174 0.30957174 3.3331699e-05 5.9126691e-05 -0.00057212127 0.00061258847 -0.00021137816 -0.0044098556 20.114489 0 3.4137247 0.32601397 0.30957174 0.30957174 3.4543594e-06 1.9334627e-05 --0.00064267405 -0.00098580555 -0.0012108051 -0.0029725597 -21.033903 0 0.3028554 6.2678338 0.30957174 0.30957174 8.8979481e-06 1.0242663e-05 --0.019277209 0.00029000399 0.0081312706 -0.0030756046 -11.306209 0 4.9504972 1.5861632 0.30957174 0.30957174 4.1560434e-05 7.6039395e-05 -0.0055905976 -0.00090562252 0.0088940642 -0.0043465409 -15.708378 0 0.96988631 1.4937234 0.30957174 0.30957174 1.0902131e-05 9.8488875e-05 --0.028930867 0.0012336859 -0.0019960982 -0.0083613716 -18.011359 0 4.7161818 0.1381175 0.30957174 0.30957174 0.0001057471 7.3364119e-05 -0.0075377579 0.0016980206 -0.0028579282 -0.00075268588 -3.162084 0 3.062444 5.3422167 0.30957174 0.30957174 3.2502117e-05 8.7962907e-06 -0.027453357 -0.00021067013 -0.00061901789 -0.0050080481 12.92365 0 1.8753071 0.25032711 0.30957174 0.30957174 8.3141767e-05 2.5264054e-05 -0.0166109 0.00091059169 -0.0018277385 -0.0048747942 5.4966059 0 2.4082371 0.012908235 0.30957174 0.30957174 3.7843177e-05 2.6939329e-05 -0.012350508 -0.0019670097 -0.0064272789 -0.00095101865 15.300214 0 0.97778883 5.2324183 0.30957174 0.30957174 5.1990175e-05 4.2543787e-05 -0.003949641 0.00062407422 -0.00070087776 -0.0072306414 -24.372844 0 2.9086947 0.27688778 0.30957174 0.30957174 5.2603007e-06 5.2354662e-05 --0.019600894 0.00081894958 -0.0039473501 -0.010595147 -11.740161 0 4.7230172 0.015004416 0.30957174 0.30957174 4.828524e-05 0.00012705802 --0.013857994 -0.0010184602 0.0021602189 -0.0031678109 -20.47484 0 5.6766314 0.97657873 0.30957174 0.30957174 3.0530816e-05 1.4658471e-05 -0.0033639443 0.0012635625 -0.0013842638 0.00079636269 -1.9901519 0 3.2315558 4.5681339 0.30957174 0.30957174 1.5786191e-05 2.5608722e-06 -0.0058732236 0.0034044476 0.0013290996 0.0039445106 9.9127035 0 3.3287265 3.188427 0.30957174 0.30957174 0.00010936681 1.721426e-05 -0.0061424017 -0.0029212235 0.0030065153 0.0032152725 -4.7571514 0 0.60115303 2.7599835 0.30957174 0.30957174 8.187708e-05 1.9367205e-05 -0.013233236 0.0024614607 0.0036873733 -0.0028203516 -4.9291047 0 2.9827253 1.2960616 0.30957174 0.30957174 7.4415776e-05 2.1597624e-05 --0.012795993 0.00095983443 0.00093022892 0.0089821231 18.776694 0 4.4872599 3.4118611 0.30957174 0.30957174 2.6366909e-05 8.089856e-05 --0.0019787419 -0.0016779861 -0.0034187987 -0.00073249975 -2.5556189 0 0.24556321 5.2960976 0.30957174 0.30957174 2.6078523e-05 1.2315682e-05 --0.016165682 0.00055600678 0.0018749088 0.00083097348 10.6506 0 4.7830663 2.3592882 0.30957174 0.30957174 3.1504049e-05 4.2288724e-06 -0.0075164548 0.00090078555 0.0074973529 -0.0046162942 22.250222 0 2.7742994 1.3968141 0.30957174 0.30957174 1.3593562e-05 7.7806376e-05 -0.0087299709 -0.0004082759 -0.0010584378 0.0046302088 5.6874823 0 1.5423626 3.7423957 0.30957174 0.30957174 9.8848022e-06 2.2394905e-05 --0.01548348 0.00078740181 0.00037555342 -0.0032605751 12.908914 0 4.6528705 0.48990159 0.30957174 0.30957174 3.1965561e-05 1.0687576e-05 --0.024816892 -0.0017791258 -0.0068766423 -0.0039533501 -21.852138 0 5.6652072 5.6049441 0.30957174 0.30957174 9.6443055e-05 6.3176297e-05 -0.012418012 -3.571951e-05 0.00060559326 0.001167775 -7.9491265 0 1.9189001 3.0341606 0.30957174 0.30957174 1.6940005e-05 1.7224045e-06 --0.017200331 -0.00016806614 0.0041760957 0.0027235829 15.604426 0 5.1754639 2.5192969 0.30957174 0.30957174 3.2734982e-05 2.4939864e-05 -0.011348094 0.002013193 0.00090126864 -0.0072604803 -16.494764 0 2.961766 0.49879841 0.30957174 0.30957174 5.1056808e-05 5.3107238e-05 --0.019411152 -0.00018547292 0.0026861094 0.015248126 -16.295744 0 5.1735102 3.3401295 0.30957174 0.30957174 4.1676548e-05 0.00023789933 -0.0041947282 0.00010844846 0.0034050908 0.0064364061 -20.684918 0 2.1763912 3.0259237 0.30957174 0.30957174 2.038744e-06 5.2781508e-05 -0.010310707 -0.0018315471 0.003605674 -0.0070100199 7.7505181 0 0.92784304 0.85267986 0.30957174 0.30957174 4.2228459e-05 6.1849902e-05 --0.008271444 -0.0012320035 0.0018704906 0.0011345531 14.829614 0 6.022342 2.4867279 0.30957174 0.30957174 2.1337098e-05 4.8040587e-06 -0.018962772 0.0001025686 0.0048635293 0.00025692494 10.156093 0 1.9943289 1.9974484 0.30957174 0.30957174 3.9570182e-05 2.3912215e-05 -0.0044249253 0.00044473047 0.0041785379 0.0097085719 7.0002367 0 2.6864339 3.1065037 0.30957174 0.30957174 3.9511294e-06 0.00011109673 --0.0029773285 0.00078327776 0.0059293045 0.011660295 21.23955 0 3.9112022 3.0421774 0.30957174 0.30957174 6.5619381e-06 0.00017030634 -0.0019552148 0.00079923503 0.0018181802 0.0034706358 -13.365235 0 3.2535295 3.029983 0.30957174 0.30957174 6.2385196e-06 1.5280643e-05 --0.011431079 0.0024830827 -0.0012936031 0.0023953007 -13.796634 0 3.9838254 4.0144737 0.30957174 0.30957174 7.0510196e-05 7.3781232e-06 -0.013069559 -0.0013271819 -0.0011822292 0.0083703297 -24.865914 0 1.1986209 3.6573339 0.30957174 0.30957174 3.4796742e-05 7.0904962e-05 --0.0038879155 0.0011116245 0.0038442705 -0.00092502879 -14.054512 0 3.8824834 1.7108004 0.30957174 0.30957174 1.2915915e-05 1.5747645e-05 -0.024214413 0.00033496056 -0.0050832368 0.0072948312 5.5958341 0 2.0704469 4.1282998 0.30957174 0.30957174 6.5388459e-05 7.8834209e-05 --0.0099221346 7.1879093e-05 0.0085493297 -0.0044947695 -14.430152 0 5.0207936 1.4644019 0.30957174 0.30957174 1.0854473e-05 9.3726455e-05 -0.01996493 -0.00076243225 0.0041820578 0.0016055562 16.044422 0 1.6103169 2.3089521 0.30957174 0.30957174 4.9052245e-05 2.0189146e-05 --0.01094179 0.0014135107 -0.00061238502 -0.0040297147 3.5383372 0 4.2202526 0.22227621 0.30957174 0.30957174 3.1343455e-05 1.6485369e-05 --0.024186213 -0.00059529565 0.0075024637 -0.0041551169 -10.766487 0 5.3072509 1.4427484 0.30957174 0.30957174 6.7444719e-05 7.3871195e-05 -0.0018086349 -0.00081871293 -0.0012203512 -0.0081985167 7.1609271 0 0.61221769 0.22534809 0.30957174 0.30957174 6.4650301e-06 6.8173576e-05 --0.0036895102 5.5778809e-05 0.0045068112 0.0028790177 4.5533779 0 4.9498326 2.5098916 0.30957174 0.30957174 1.5226795e-06 2.8698642e-05 --0.0044866152 0.0018792743 0.0037758879 0.0019217728 -5.3697713 0 3.7722117 2.4126117 0.30957174 0.30957174 3.438111e-05 1.80369e-05 -0.010156477 0.00084436752 -0.0016455621 -0.0054993521 -17.431517 0 2.5932635 0.081314268 0.30957174 0.30957174 1.7818528e-05 3.2728282e-05 --0.022306608 0.0014774634 -0.0017626353 -0.0042234555 7.1340967 0 4.5438076 6.2592232 0.30957174 0.30957174 7.4508199e-05 2.0825554e-05 -0.011119846 0.00061312361 -0.00087487631 -0.002502207 -5.2925545 0 2.4105592 0.035407072 0.30957174 0.30957174 1.6998434e-05 6.9820617e-06 -0.0096585058 -0.001749794 0.0081711697 0.0047632129 -13.233809 0 0.9190808 2.4693442 0.30957174 0.30957174 3.8131637e-05 8.9817036e-05 -0.017596775 0.0011879827 -0.0021872979 -0.0044098028 -3.0563641 0 2.4964629 6.1937968 0.30957174 0.30957174 4.6848153e-05 2.4112392e-05 --0.010942504 0.00038643596 -0.0018955161 0.0038250299 10.964787 0 4.775446 3.9792169 0.30957174 0.30957174 1.450485e-05 1.8134821e-05 -0.006270523 0.00066347824 0.0015637366 0.0028675417 -7.0964933 0 2.7120916 3.0132275 0.30957174 0.30957174 8.3263503e-06 1.0621512e-05 -0.008374886 -0.0012983075 -0.00057762448 -0.009217373 -13.146115 0 0.99046147 0.31120635 0.30957174 0.30957174 2.3054403e-05 8.4609361e-05 --0.016032381 0.0033164869 -0.00012979211 -0.0091611097 24.571116 0 4.0037807 0.36001802 0.30957174 0.30957174 0.00012841159 8.32643e-05 --0.0033301124 -0.0016546868 -0.0030606779 -0.0023366991 -7.9873056 0 0.15686319 5.7348364 0.30957174 0.30957174 2.6158755e-05 1.4860126e-05 -0.010968121 -0.0028201254 -0.0019509407 0.0029579395 -23.142782 0 0.77781988 4.1026973 0.30957174 0.30957174 8.565399e-05 1.2515857e-05 --0.030433694 -3.608389e-05 -0.002642 -0.0034915567 20.523807 0 5.0974894 6.0058105 0.30957174 0.30957174 0.00010168838 1.9129459e-05 -0.002815689 -0.00024355516 0.0071314932 0.0035199702 -22.147312 0 1.2777435 2.4003816 0.30957174 0.30957174 1.4106837e-06 6.3562785e-05 --0.017645381 0.0017767886 0.0038610484 -0.00053367989 17.08026 0 4.3444186 1.8088422 0.30957174 0.30957174 6.2938204e-05 1.531173e-05 --0.0011310679 -0.0021010056 -0.013397127 0.00023415025 -18.564344 0 0.31527092 5.0693547 0.30957174 0.30957174 4.0351274e-05 0.00018100051 -0.011418461 -0.0030758549 0.0019186331 0.0043177713 9.7549524 0 0.76127587 3.0947205 0.30957174 0.30957174 0.00010049561 2.2203564e-05 --0.017899782 0.0030588741 0.0035991033 -0.0013523925 -13.401904 0 4.0868984 1.5883265 0.30957174 0.30957174 0.00012040659 1.4873316e-05 -0.025832021 0.0020079702 -0.0035842756 -0.0046009346 20.024863 0 2.5612305 5.9917215 0.30957174 0.30957174 0.00010998196 3.394919e-05 -0.00019889119 0.001868791 -0.0011611278 -0.013122045 17.905959 0 3.5042101 0.28532766 0.30957174 0.30957174 3.1817747e-05 0.00017215499 -0.0033334451 -0.00098633121 -0.0035052112 -0.0028716664 -9.0347535 0 0.72956547 5.7690853 0.30957174 0.30957174 1.0081876e-05 2.0566451e-05 --0.0067878477 -0.0012214575 -0.0026191944 -0.002616279 0.80109361 0 6.1097095 5.8674712 0.30957174 0.30957174 1.8648772e-05 1.3705671e-05 --0.014041521 -0.0013223099 -0.003349003 -0.0042958086 -17.6369 0 5.7957189 5.9913688 0.30957174 0.30957174 3.7571883e-05 2.9612005e-05 -0.013625093 0.0010245369 0.0035253268 0.0038412777 -7.6408108 0 2.5456696 2.7693123 0.30957174 0.30957174 2.994124e-05 2.7165343e-05 --0.014436789 0.0028440815 -0.0046559217 -0.0013766967 -10.127088 0 4.0242754 5.3719846 0.30957174 0.30957174 9.6563743e-05 2.3734287e-05 --0.017742156 0.003911977 0.0081478554 -0.0043932035 8.5495196 0 3.9778401 1.4539783 0.30957174 0.30957174 0.00017396198 8.6072901e-05 --0.019542389 -0.00044891541 -0.002003574 -0.0063042463 14.883153 0 5.2929677 0.064230749 0.30957174 0.30957174 4.3760147e-05 4.3469193e-05 -0.014099512 0.0010894224 -0.00072693435 0.0061114891 -13.396558 0 2.5584026 3.6352382 0.30957174 0.30957174 3.2634637e-05 3.7581031e-05 -0.0062252821 -0.00014840439 -0.0023008384 -0.0013688056 20.020538 0 1.7312584 5.6198017 0.30957174 0.30957174 4.4549364e-06 7.1954905e-06 --0.00061703128 0.0017822156 -0.007554726 0.00389425 -0.90305153 0 3.5538812 4.6140394 0.30957174 0.30957174 2.8975839e-05 7.2581699e-05 -0.0064382135 -0.0029352379 0.0031667317 -9.7420224e-05 21.598999 0 0.61058945 1.9145912 0.30957174 0.30957174 8.3033266e-05 1.0119352e-05 -0.013063457 -0.00037461221 -0.0032435054 -0.0062915036 21.111361 0 1.6895827 6.178171 0.30957174 0.30957174 2.0012231e-05 4.9869041e-05 --0.026589194 -0.0006006801 0.0011712344 0.0078225636 14.265591 0 5.289647 3.3660783 0.30957174 0.30957174 8.0897531e-05 6.2080679e-05 -0.0034140119 0.0010341491 -0.0023027371 -0.0011213908 -19.294116 0 3.1682106 5.5366803 0.30957174 0.30957174 1.1021656e-05 6.5931731e-06 --0.0021686746 -0.00052232651 0.001607533 0.0029480901 -7.6661164 0 6.2298281 3.0132613 0.30957174 0.30957174 3.0015632e-06 1.1226187e-05 --0.0021568052 0.0010202446 -0.0027483161 0.0021367629 -2.3180219 0 3.7439259 4.4297613 0.30957174 0.30957174 9.9926022e-06 1.2143651e-05 -0.010813362 0.0025608156 0.0086095825 0.0063809193 18.381174 0 3.0818306 2.579025 0.30957174 0.30957174 7.2573348e-05 0.00011511607 -0.0070524878 0.00081540829 0.00096024221 -0.0019970248 -12.984393 0 2.7564119 0.82567853 0.30957174 0.30957174 1.1516782e-05 4.8854424e-06 --0.029700697 -0.0020411425 -0.00013805019 -0.0045500816 20.642383 0 5.6460291 0.34372232 0.30957174 0.30957174 0.00013478979 2.0555052e-05 -0.0080979879 0.00023237956 0.006412199 -0.0029232952 9.3736509 0 2.2007777 1.5204067 0.30957174 0.30957174 7.6907994e-06 4.9928023e-05 --0.0032068499 0.004679227 -0.0012608892 0.0039875643 -22.312304 0 3.5909858 3.8244915 0.30957174 0.30957174 0.00020058025 1.73749e-05 --0.0053469047 -0.00088408215 -0.0032862175 -0.0017299117 -21.940632 0 6.0713812 5.5679055 0.30957174 0.30957174 1.0258358e-05 1.3855656e-05 --0.012251632 -0.0016988568 -0.0035233883 0.00028743478 17.935429 0 5.9878397 5.0059457 0.30957174 0.30957174 4.2768503e-05 1.2597414e-05 --0.0017900812 -0.001160013 -0.0053419873 -0.0055511701 -15.733093 0 0.20649036 5.8872312 0.30957174 0.30957174 1.2609621e-05 5.9335774e-05 -0.0049232677 0.0023075266 -0.0049684326 0.0012325234 6.6429634 0 3.2858233 4.8454175 0.30957174 0.30957174 5.1165346e-05 2.6393382e-05 -0.00027660361 0.001756303 0.0054216886 -0.0024464809 9.4790158 0 3.4986057 1.5242478 0.30957174 0.30957174 2.8107185e-05 3.55712e-05 --0.028702619 -0.0006579579 0.0058326266 -0.00082742196 -5.7038977 0 5.2925479 1.8053006 0.30957174 0.30957174 9.4382241e-05 3.4975944e-05 -0.0085658246 -0.0028263948 0.0058374378 0.0080865067 13.028055 0 0.69547719 2.886779 0.30957174 0.30957174 8.0825032e-05 9.92163e-05 -0.012133829 0.0010865405 -0.0034981018 -0.0045873461 20.86298 0 2.6293447 6.002079 0.30957174 0.30957174 2.6916706e-05 3.3210054e-05 -0.019121284 0.0025824442 0.00265052 -0.001216755 6.3689952 0 2.8333802 1.5178019 0.30957174 0.30957174 0.00010088765 8.5510463e-06 -0.00566184 -0.0035002005 0.0011450199 -0.008362478 12.967049 0 0.55004102 0.51147307 0.30957174 0.30957174 0.00011512171 7.0687343e-05 --0.022767991 0.0011737358 0.0016893292 -0.0057738843 15.95646 0 4.6476505 0.66113245 0.30957174 0.30957174 6.9455938e-05 3.5945272e-05 --0.010092863 -0.0001843258 0.0069110463 0.0064396156 6.5708818 0 5.2515438 2.69115 0.30957174 0.30957174 1.1492031e-05 8.928525e-05 --0.0062783414 0.0017505074 -0.0038088022 0.0047605787 -2.7918181 0 3.8909776 4.1946412 0.30957174 0.30957174 3.224079e-05 3.7105091e-05 -0.010698258 -0.0025596584 0.0072771176 -0.0027377538 -16.408597 0 0.80446469 1.5879295 0.30957174 0.30957174 7.2247554e-05 6.0822819e-05 -0.030806074 0.00068234035 0.0031199707 -0.0018397351 -1.7456145 0 2.1441921 1.4158568 0.30957174 0.30957174 0.00010842115 1.3170826e-05 --0.0041194701 -0.00036311236 -0.0095379629 -0.00014140399 14.394988 0 5.7632262 5.1013937 0.30957174 0.30957174 3.0639959e-06 9.1734159e-05 -0.013475085 -0.0024051442 -0.008961654 -0.0025702256 -2.4387883 0 0.92570356 5.3638507 0.30957174 0.30957174 7.262826e-05 8.7518566e-05 --0.0014944832 -0.0011249575 0.005090738 0.00026176198 24.941348 0 0.22948467 1.9960559 0.30957174 0.30957174 1.1773369e-05 2.6194837e-05 -0.008402708 0.00028498818 -0.0085883721 -0.0027353936 -13.702722 0 2.2447493 5.3926907 0.30957174 0.30957174 8.4907076e-06 8.1783289e-05 -0.0010757763 0.0017083141 0.0081884597 0.0065950914 -6.2489063 0 3.4468729 2.6191667 0.30957174 0.30957174 2.6711278e-05 0.00011074099 -0.019028765 0.00029269508 -0.0028593154 0.0067743052 23.031589 0 2.0843081 3.9182066 0.30957174 0.30957174 4.0529984e-05 5.3762471e-05 -0.0042158317 0.0029856197 0.0031687878 -0.0021262144 0.84204712 0 3.3621067 1.3578597 0.30957174 0.30957174 8.3151391e-05 1.4607303e-05 -0.019481958 -0.0012941899 0.0070224834 0.0031438494 12.104187 0 1.4009081 2.3630028 0.30957174 0.30957174 5.6923039e-05 5.952115e-05 --0.00054695398 0.00024560906 -0.0053638343 -0.004237852 -16.964096 0 3.755656 5.7514059 0.30957174 0.30957174 5.8235305e-07 4.6819423e-05 -0.017977042 -0.00047840719 0.0021339175 0.00036418821 -2.8102953 0 1.7072648 2.1127932 0.30957174 0.30957174 3.756197e-05 4.7222844e-06 --0.027974309 -0.0009999994 0.0054382365 -0.001425634 -10.988417 0 5.401494 1.6907001 0.30957174 0.30957174 9.5016665e-05 3.1831498e-05 -0.0067964487 4.1324745e-05 -0.00018877667 -0.001804247 8.5302331 0 2.0004282 0.26920692 0.30957174 0.30957174 5.0863441e-06 3.2649124e-06 --0.026422295 -0.0016049538 -0.0040455184 -0.001828335 -8.7667276 0 5.592082 5.5081173 0.30957174 0.30957174 0.00010010409 1.9815413e-05 --0.0099799393 0.0018508554 -0.00027859681 0.001699573 23.519857 0 4.0503538 3.6796706 0.30957174 0.30957174 4.2139378e-05 2.9434407e-06 -0.01357599 -0.0033239908 0.00014609248 -0.011075416 -15.436826 0 0.79578626 0.38759771 0.30957174 0.30957174 0.00012088145 0.00012169452 -0.010169907 -0.0010191461 0.0016780985 0.0021856673 5.0380635 0 1.2052173 2.8571875 0.30957174 0.30957174 2.081544e-05 7.5774842e-06 -0.0030856291 -0.0019850983 -0.0014465567 0.0022448702 7.5757734 0 0.54330941 4.0920123 0.30957174 0.30957174 3.6941746e-05 7.1082778e-06 -0.0019547426 0.002832307 0.003648214 -0.005195776 10.834059 0 3.4402738 0.9902911 0.30957174 0.30957174 7.349454e-05 4.0195762e-05 --0.010118251 0.00078090354 -0.015271484 -0.0030202092 -20.974131 0 4.4739253 5.2803982 0.30957174 0.30957174 1.6793851e-05 0.00024416726 --0.0093033111 0.0020237041 0.0023042756 0.0036943462 1.3799325 0 3.9832643 2.9545551 0.30957174 0.30957174 4.6807719e-05 1.8890806e-05 --0.00164575 -0.0026580148 -0.00099085622 0.0090064304 -12.438193 0 0.30643457 3.6263548 0.30957174 0.30957174 6.4655467e-05 8.1449696e-05 --0.0088280063 -8.6419686e-05 0.0098003282 0.0018305248 5.7782124 0 5.1756281 2.128291 0.30957174 0.30957174 8.623359e-06 0.00010015311 -0.0100538 0.00079657971 -0.0027852844 0.0083820375 13.225271 0 2.5702722 3.8391435 0.30957174 0.30957174 1.6876394e-05 7.7511501e-05 --0.016190736 -0.00047699822 0.0049424908 -0.0041099411 -13.981731 0 5.348884 1.2553984 0.30957174 0.30957174 3.0849567e-05 4.1382381e-05 -0.0079315447 0.00012589126 0.0034619806 0.0091365695 10.091811 0 2.0886876 3.1509963 0.30957174 0.30957174 7.050376e-06 9.4884931e-05 -0.0087829321 0.0037614723 -0.0037900511 -0.0023992945 12.890152 0 3.2649691 5.6473941 0.30957174 0.30957174 0.00013735378 2.0191651e-05 --0.023223796 -0.0012331639 -0.00093402115 0.0086597086 -3.8068108 0 5.5372122 3.6242049 0.30957174 0.30957174 7.3060207e-05 7.5263696e-05 -0.013180827 -0.00035711533 -0.0026991569 -0.0064557242 -6.3475595 0 1.703127 6.2585737 0.30957174 0.30957174 2.023375e-05 4.8684222e-05 --0.0041236359 -0.00023951 0.0022289563 0.00027858856 9.6064881 0 5.5733395 2.0684427 0.30957174 0.30957174 2.3892488e-06 5.0857305e-06 --0.013553767 -0.00016326311 0.0069718641 0.0037929488 2.9979386 0 5.1959798 2.4399492 0.30957174 0.30957174 2.0409347e-05 6.3273255e-05 -0.0023980418 -0.0015315699 0.0041311462 0.0023060255 0.47141487 0 0.54451933 2.4507693 0.30957174 0.30957174 2.1999207e-05 2.2480245e-05 --0.018454846 7.26949e-05 0.012082966 -0.002486523 23.583322 0 5.0508222 1.7437393 0.30957174 0.30957174 3.7436134e-05 0.00015332101 --0.0035754699 0.0020463283 0.0023537076 -0.0023774288 -12.477422 0 3.7054003 1.1587439 0.30957174 0.30957174 3.9548535e-05 1.1191565e-05 --0.0015719611 -0.001498807 0.0093950413 -0.0046268979 3.8492468 0 0.25966999 1.4906906 0.30957174 0.30957174 2.0734773e-05 0.00011022141 --0.00064233019 0.0012940632 -0.0053926682 0.0057455107 14.774212 0 3.5703288 4.2736752 0.30957174 0.30957174 1.5299851e-05 6.2061903e-05 -0.038421202 -0.0017166567 0.0054938346 0.0097083659 -14.87793 0 1.5585649 2.9974474 0.30957174 0.30957174 0.00018889608 0.00012391851 -0.00051735704 -2.4903973e-05 0.0036694854 0.0032433339 -8.459936 0 1.5318494 2.6648995 0.30957174 0.30957174 3.5032432e-08 2.4009046e-05 --0.0026245553 -0.0017545275 0.00033718039 0.0020586558 -9.7439637 0 0.21154013 3.3522477 0.30957174 0.30957174 2.8798177e-05 4.3184128e-06 -0.0061335626 -0.00090599183 0.0045941026 -0.0074576069 15.537779 0 1.0134287 0.93005467 0.30957174 0.30957174 1.1607045e-05 7.6444026e-05 -0.0022795985 0.00069393725 0.0010775918 0.003531915 -4.5696379 0 3.1697888 3.2174889 0.30957174 0.30957174 4.9570741e-06 1.3544227e-05 --0.0010588882 0.0002770654 0.00019668555 0.0003684251 -11.737593 0 3.9131346 3.0221491 0.30957174 0.30957174 8.2237029e-07 1.7364006e-07 --0.011513587 -0.0013088838 -0.0074616548 0.0037087032 19.476091 0 5.8895595 4.6286444 0.30957174 0.30957174 3.0158305e-05 6.9773417e-05 -0.0091854456 0.0027510396 -0.0048069783 -0.0026509216 1.7162689 0 3.1645647 5.5872374 0.30957174 0.30957174 7.8203905e-05 3.0265967e-05 --0.0034089564 0.0014553116 0.0012987723 0.00087067739 14.480084 0 3.7675842 2.5319197 0.30957174 0.30957174 2.0568755e-05 2.4525094e-06 --0.00065159284 0.0021491588 0.0034685494 0.0030758441 -17.004174 0 3.5491634 2.666532 0.30957174 0.30957174 4.2121759e-05 2.1513226e-05 --0.005516672 0.0010424144 0.0073076683 -0.0025758888 -21.094914 0 4.0421966 1.6087416 0.30957174 0.30957174 1.3239419e-05 6.041889e-05 -0.005509882 0.0021086768 -0.0082851476 0.0045555635 2.0723512 0 3.2365504 4.5873838 0.30957174 0.30957174 4.3837703e-05 8.978859e-05 --0.021892551 -0.00041801078 0.0094480461 -0.0013567227 -0.98355624 0 5.2588986 1.8036112 0.30957174 0.30957174 5.4206041e-05 9.1819061e-05 -0.0056947877 0.00079184956 0.0044846651 0.0058721717 5.8076589 0 2.8475939 2.8597515 0.30957174 0.30957174 9.2719481e-06 5.4479752e-05 --0.0044835905 0.0013483392 5.4597354e-05 -0.00015890308 -6.4252972 0 3.8659013 0.70775534 0.30957174 0.30957174 1.8767819e-05 2.8051189e-08 -0.0028738601 -0.00094380023 -0.0029117298 0.0024565146 3.8526345 0 0.69689323 4.3898851 0.30957174 0.30957174 9.0209142e-06 1.4532953e-05 --0.034228218 0.002447043 0.0061898397 0.0023691254 -10.319418 0 4.5094376 2.3079372 0.30957174 0.30957174 0.00018315866 4.4193815e-05 -0.024715258 0.0010062855 0.0045772103 0.003524218 -15.862376 0 2.3002588 2.5973228 0.30957174 0.30957174 7.6280868e-05 3.3441326e-05 --0.00161743 0.00074820313 -0.00094538082 0.004087213 21.469568 0 3.7488935 3.7449866 0.30957174 0.30957174 5.3866867e-06 1.7471264e-05 -0.013364449 -0.0015388208 0.0057978185 0.0014523742 -7.7521185 0 1.1358462 2.1886423 0.30957174 0.30957174 4.117783e-05 3.5981053e-05 --0.023423754 -0.00035869776 -6.469266e-05 -0.0062361297 -0.89396735 0 5.2252906 0.36384224 0.30957174 0.30957174 6.1403641e-05 3.857908e-05 -0.010346852 -0.00024342929 0.0042390046 -0.0018473055 4.0180177 0 1.7339749 1.5370895 0.30957174 0.30957174 1.2292237e-05 2.1500585e-05 --0.01021117 0.00010210393 -0.010053864 0.0030717309 7.1949557 0 4.9958531 4.7924303 0.30957174 0.30957174 1.1541193e-05 0.0001112634 -0.0073855321 0.00072167854 -0.0086804119 -0.0057792704 -8.8210311 0 2.6724286 5.6703405 0.30957174 0.30957174 1.073225e-05 0.00010909368 --0.036895505 0.0020171761 0.0019342872 0.0058204101 10.753698 0 4.6246157 3.1926095 0.30957174 0.30957174 0.00018650309 3.7375214e-05 -0.012850964 -0.0017977517 -0.0028925928 -0.002370209 -15.130518 0 1.0396573 5.7691749 0.30957174 0.30957174 4.7570068e-05 1.4007765e-05 -0.029211001 -0.0011005798 0.0053352014 0.0010585412 -14.145591 0 1.6144808 2.1394159 0.30957174 0.30957174 0.00010470476 2.9807858e-05 -0.003676416 3.4027826e-05 -0.002315428 0.0053695579 -21.304781 0 2.0292114 3.9259752 0.30957174 0.30957174 1.4942973e-06 3.4003929e-05 --0.0029224885 -0.0029317707 -0.0067191389 0.0023085449 12.484207 0 0.26530452 4.7582344 0.30957174 0.30957174 7.9235238e-05 5.0801142e-05 --0.0085909663 -0.00023425371 -0.0031108698 -0.0097282532 0.16679145 0 5.3301515 0.06243666 0.30957174 0.30957174 8.6019337e-06 0.00010363007 -0.021594728 0.0027929595 -0.0059026201 -0.00092881847 -22.00274 0 2.8121083 5.2415245 0.30957174 0.30957174 0.00012225137 3.5980667e-05 -0.0059457684 -5.2525732e-05 0.002234612 0.002928685 -4.2818127 0 1.8647962 2.8601987 0.30957174 0.30957174 3.9059864e-06 1.3542038e-05 -0.017099429 -0.0014046639 -0.0027632392 0.0079332256 16.072242 0 1.3026803 3.8535933 0.30957174 0.30957174 5.0071283e-05 7.012491e-05 -0.015810839 -0.0014367899 -0.0028420135 -0.0095376315 12.86917 0 1.253631 0.082469184 0.30957174 0.30957174 4.6247421e-05 9.8373755e-05 -0.0023965094 0.001823464 -0.0068706396 -0.0077596224 11.819093 0 3.3726059 5.9287446 0.30957174 0.30957174 3.0919346e-05 0.00010731537 --0.025037385 0.00070727825 0.0052986268 0.0042583218 14.249397 0 4.834824 2.6181076 0.30957174 0.30957174 7.3372871e-05 4.6290992e-05 --0.00054188843 0.0012389618 -0.007591263 0.00026968361 5.1321727 0 3.5638696 5.0514656 0.30957174 0.30957174 1.4015368e-05 5.8169179e-05 -0.0024012841 0.0015772411 -0.0018072868 -0.0016536766 -24.081915 0 3.3502926 5.823691 0.30957174 0.30957174 2.3294292e-05 6.0054458e-06 --0.0017861056 -0.0013548235 -0.0037220333 -0.00090189249 11.476197 0 0.23057574 5.3225675 0.30957174 0.30957174 1.7070894e-05 1.4773296e-05 -0.0090601154 -0.0020529225 -0.00083945354 -0.00023649377 7.7295849 0 0.82545194 5.3591837 0.30957174 0.30957174 4.7402506e-05 7.6590374e-07 --0.0069057503 0.0021474525 0.0048256635 -0.0028387325 -10.614439 0 3.8552551 1.4168971 0.30957174 0.30957174 4.7243563e-05 3.1470103e-05 -0.0020793238 -0.00032385936 0.00067129786 0.0019817893 9.3258119 0 0.9882525 3.1868154 0.30957174 0.30957174 1.4300664e-06 4.3500461e-06 --0.039731123 0.0048269441 -0.001651868 -0.0033704306 11.305197 0 4.2506862 6.1985682 0.30957174 0.30957174 0.00038553272 1.401886e-05 -0.017503358 -0.001155211 0.014343426 -0.00047237464 -8.275172 0 1.4037854 1.9124413 0.30957174 0.30957174 4.5788682e-05 0.00020763231 --0.0029315113 0.00043415851 -0.0035140871 -0.0042620033 15.94468 0 4.1537593 5.963986 0.30957174 0.30957174 2.6604564e-06 3.0467267e-05 --0.0017911654 0.00017997312 0.0033609606 0.0029691282 13.529052 0 4.3454884 2.6646473 0.30957174 0.30957174 6.4725029e-07 2.0132579e-05 --0.038547569 0.0019317494 -0.0087593771 0.0073193325 -23.312655 0 4.6584416 4.3946068 0.30957174 0.30957174 0.00019711235 0.00013049159 --0.010510569 0.00075390438 0.0070919582 0.0029104301 -4.11172 0 4.507928 2.3316797 0.30957174 0.30957174 1.7304803e-05 5.9107983e-05 -0.013393709 -0.00016203492 -0.0059090689 0.0087925763 -12.097574 0 1.8353357 4.111379 0.30957174 0.30957174 1.9932222e-05 0.00011188602 -0.0034371182 -0.0019988562 0.0023037654 -0.0037222877 12.342515 0 0.56087115 0.93214877 0.30957174 0.30957174 3.7692722e-05 1.9093992e-05 --0.0017376442 -0.0025265808 -0.0033211795 -0.0036535141 -20.607169 0 0.29894461 5.9156575 0.30957174 0.30957174 5.8482174e-05 2.4360384e-05 --0.018735534 -0.0017337154 0.0025439378 -0.010954749 16.160878 0 5.7870745 0.60427376 0.30957174 0.30957174 6.5914633e-05 0.00012556055 -0.0061786882 -0.0012149333 -9.131155e-05 0.0049393124 5.0216977 0 0.88348131 3.5345282 0.30957174 0.30957174 1.763688e-05 2.4207943e-05 -0.006074727 -0.0011267485 0.004358515 -0.0013062828 -9.7304839 0 0.90870501 1.6561327 0.30957174 0.30957174 1.5615946e-05 2.0844087e-05 -0.002672083 -0.00023377762 -0.0024889324 -0.0090198449 -20.88889 0 1.2722063 0.10297169 0.30957174 0.30957174 1.2816562e-06 8.6945038e-05 --0.0098950115 0.0006007266 -0.0084887174 -0.0086490557 16.907905 0 4.5815222 5.8773841 0.30957174 0.30957174 1.4035726e-05 0.00014684702 --0.0054744354 0.0041284597 -0.0062805968 -0.00082147197 -1.6744487 0 3.6604445 5.2157062 0.30957174 0.30957174 0.0001585518 4.0436811e-05 --0.0012987992 -0.0004877999 0.0053550242 0.003496902 -7.7822669 0 0.089933222 2.5198766 0.30957174 0.30957174 2.3527453e-06 4.1039493e-05 --0.00030500576 0.00074282028 -0.00047403935 0.0018466286 -19.63156 0 3.5609374 3.7691347 0.30957174 0.30957174 5.0366022e-06 3.6090093e-06 -0.018169658 -0.00055867447 -0.0057060342 -0.0031478814 -2.1754372 0 1.6720026 5.5873918 0.30957174 0.30957174 3.9084583e-05 4.2653272e-05 -0.0091462658 -0.00077536462 0.0029971414 -0.00042910019 -6.5115578 0 1.2875148 1.8040277 0.30957174 0.30957174 1.4659773e-05 9.238721e-06 -0.033805539 -0.0021071085 -0.0002469024 5.1107711e-05 -23.225842 0 1.4286978 4.8841818 0.30957174 0.30957174 0.00016589952 6.4048613e-08 --0.010006767 -0.0015760862 -0.0045786832 0.00088553618 -10.509506 0 6.0487841 4.8971517 0.30957174 0.30957174 3.3620688e-05 2.191307e-05 --0.0037237466 0.00085385635 0.0074514229 -0.0058786379 -9.8392419 0 3.9623946 1.2810874 0.30957174 0.30957174 8.1635788e-06 9.0255269e-05 --0.011721313 -0.00086131275 -0.0064849709 0.012122989 -4.9093857 0 5.6765685 4.0104781 0.30957174 0.30957174 2.1840051e-05 0.00018817618 --0.0045193836 0.0028428888 0.0015691685 -0.0093559849 -11.026284 0 3.6886671 0.54180133 0.30957174 0.30957174 7.586431e-05 8.9309023e-05 -0.00059709313 -0.0010499703 -0.0037694244 0.0059943536 1.7929003 0 0.43664693 4.0809061 0.30957174 0.30957174 1.0081657e-05 4.9966117e-05 --0.019910124 0.0016703916 0.0050102493 -0.0084299061 5.6456074 0 4.4341331 0.91412191 0.30957174 0.30957174 6.8934087e-05 9.5795937e-05 --0.012717807 0.003948948 -0.00097225717 0.0017586805 -15.391945 0 3.8557205 4.0243539 0.30957174 0.30957174 0.00015980897 4.0209377e-06 --0.013141941 0.00090526893 0.0010492429 0.0024167852 -5.87807 0 4.5263014 3.1033253 0.30957174 0.30957174 2.6424893e-05 6.9035074e-06 --0.00026187591 -0.0020850589 -0.0048889926 -0.010845127 15.534901 0 0.36051355 6.2309159 0.30957174 0.30957174 3.9610277e-05 0.00014076283 --0.0068016016 0.0017909711 -0.0027288176 0.0037091762 8.5202523 0 3.9108845 4.154055 0.30957174 0.30957174 3.429751e-05 2.1153891e-05 --0.0075484437 0.001179751 -0.004160526 -0.0021351956 10.53573 0 4.1282212 5.5575535 0.30957174 0.30957174 1.8933528e-05 2.197328e-05 -0.0014897658 -0.0026964869 0.00046897814 0.00053702428 -0.94333921 0 0.4348761 2.7940075 0.30957174 0.30957174 6.6478295e-05 5.0779655e-07 --0.0060015701 -0.00091710653 -0.0075946359 0.0022580265 8.6646729 0 6.0345279 4.7999045 0.30957174 0.30957174 1.1615795e-05 6.3206133e-05 -0.0090467291 0.0001772792 0.0011206681 0.0016909578 18.491022 0 2.1217429 2.9268682 0.30957174 0.30957174 9.270801e-06 4.102353e-06 --0.010338998 -0.0023906477 0.00048094846 0.0012037735 -17.142201 0 6.214233 3.1329829 0.30957174 0.30957174 6.3796477e-05 1.6705506e-06 --0.016959227 -0.0023278584 -0.0018588813 0.003401298 6.5133718 0 5.9828897 4.0194854 0.30957174 0.30957174 8.0936579e-05 1.4958892e-05 -0.0095456176 0.00033672597 -0.0016001417 0.00069937601 -3.2646276 0 2.2560122 4.6776098 0.30957174 0.30957174 1.1035611e-05 3.0664975e-06 -0.01057701 -0.00023398951 -0.0056650696 0.0021780437 -12.63851 0 1.7462382 4.7223542 0.30957174 0.30957174 1.2779845e-05 3.7060144e-05 -0.0032878305 -0.00069413446 0.0041274937 -8.9803699e-05 3.8857954 0 0.85379488 1.9235184 0.30957174 0.30957174 5.5757746e-06 1.7183079e-05 -0.021421796 -0.00044036385 -0.004740815 0.0029990077 8.0964245 0 1.7599807 4.5263098 0.30957174 0.30957174 5.2142424e-05 3.1579864e-05 --0.013538689 0.0013805384 -0.0053980589 0.0033584985 -23.817008 0 4.3381445 4.5337642 0.30957174 0.30957174 3.7483133e-05 4.0564883e-05 -0.012435012 -0.00031561359 0.0037440843 0.0001862656 -11.616292 0 1.7178836 1.9944036 0.30957174 0.30957174 1.7882167e-05 1.4166854e-05 -0.0096472577 -0.0017891374 -0.0024066112 0.0067395357 -10.179862 0 0.908766 3.861448 0.30957174 0.30957174 3.9376128e-05 5.0893061e-05 --0.012973721 -0.00021775524 -0.0013103042 0.005813257 20.078632 0 5.2384091 3.7393353 0.30957174 0.30957174 1.8909326e-05 3.5251596e-05 -0.0091666176 -0.0018995842 0.0059917799 3.8160103e-05 -11.722633 0 0.86145503 1.9514138 0.30957174 0.30957174 4.2094676e-05 3.6195531e-05 -0.0097407783 0.0018353937 0.00052891728 0.0045805396 -15.654743 0 2.9883605 3.4000027 0.30957174 0.30957174 4.110243e-05 2.1093725e-05 --0.029353753 -0.0016302626 -0.00013530109 0.0011981458 -14.808558 0 5.5550623 3.6292508 0.30957174 0.30957174 0.00011879906 1.4424012e-06 --0.0081611549 -0.00066575557 -0.0031339424 0.0010902579 -15.878562 0 5.7257648 4.7544095 0.30957174 0.30957174 1.134919e-05 1.1080709e-05 --0.0063196772 -0.00018386149 0.0038734242 0.0015313173 24.66498 0 5.345757 2.3188112 0.30957174 0.30957174 4.6922516e-06 1.7451691e-05 --0.0091766422 0.0017956407 0.00090168893 0.00094942279 10.356885 0 4.0271548 2.7522209 0.30957174 0.30957174 3.8616001e-05 1.7137857e-06 --0.0146384 0.0016714884 0.011462827 -0.00047639252 5.6349783 0 4.2816109 1.9038962 0.30957174 0.30957174 4.8973763e-05 0.00013269262 --0.0078859963 0.0015134468 0.005245014 0.0059942739 9.638223 0 4.0354744 2.7930351 0.30957174 0.30957174 2.7692136e-05 6.3375213e-05 --0.0043309535 -0.0016827161 0.0039055307 -0.0045934356 18.035806 0 0.098935324 1.0829438 0.30957174 0.30957174 2.7852608e-05 3.6306552e-05 -0.001564577 0.00071740819 -0.0047077777 -0.0080625952 18.580431 0 3.2809061 6.1254435 0.30957174 0.30957174 4.9570873e-06 8.6823655e-05 -0.0039969756 0.0014966258 0.0029577752 -0.00067448276 -16.512346 0 3.2307076 1.7226466 0.30957174 0.30957174 2.2157767e-05 9.2709981e-06 -0.01850351 -0.00062934001 0.0058536754 0.010712798 -4.9647631 0 1.6446484 3.0123796 0.30957174 0.30957174 4.1193377e-05 0.00014838092 -0.0088621515 -0.00025474286 -0.0012337461 -0.0023323116 20.65075 0 1.6889971 6.1675604 0.30957174 0.30957174 9.2127791e-06 6.9302305e-06 -0.0035538878 0.0018792205 -0.0041183729 -0.0010372604 7.429035 0 3.3111959 5.3315034 0.30957174 0.30957174 3.3555983e-05 1.8166468e-05 --0.013211155 -0.00088451291 0.0027581698 -0.0030453168 1.997821 0 5.6343496 1.1143015 0.30957174 0.30957174 2.6286726e-05 1.6868481e-05 -0.0030328436 -0.00049144304 0.0052167349 0.0050709365 12.312844 0 0.96974282 2.7122663 0.30957174 0.30957174 3.2098068e-06 5.2942642e-05 --0.016196639 0.0021600743 -0.010298415 0.007438486 -23.545493 0 4.2045783 4.4650056 0.30957174 0.30957174 7.1301554e-05 0.00016180559 --0.0065074256 -0.002578962 -0.0060210352 -0.0038252329 0.51840057 0 0.10407809 5.6490009 0.30957174 0.30957174 6.5235554e-05 5.1062481e-05 --0.045452434 0.0012482971 0.0022936832 -0.0058285061 -6.8387086 0 4.8415429 0.75199007 0.30957174 0.30957174 0.00024098555 3.9000664e-05 -0.0018338697 0.0018036808 -0.0060138137 0.004126142 7.2018902 0 3.4047386 4.4891278 0.30957174 0.30957174 3.0004398e-05 5.3348157e-05 --0.017290293 0.00047449002 -0.0086844919 -0.0084919808 -8.4940814 0 4.841725 5.8568221 0.30957174 0.30957174 3.4869189e-05 0.00014756585 --0.0287526 0.0014318282 0.0010592155 0.0051175304 18.329783 0 4.6608201 3.3101796 0.30957174 0.30957174 0.00010942938 2.7108439e-05 --0.0032505293 0.0010718716 -0.00093396475 0.0040037293 3.3981861 0 3.8372595 3.746871 0.30957174 0.30957174 1.162574e-05 1.6779634e-05 --0.0069229645 -0.00077762394 -0.0041293024 -0.00032655608 11.618596 0 5.8835604 5.1649721 0.30957174 0.30957174 1.0769761e-05 1.7295912e-05 --0.034589227 -0.00016637005 0.0097205171 0.0038714577 18.865773 0 5.1304763 2.3213341 0.30957174 0.30957174 0.00013159094 0.00011012569 --0.0096734654 -0.0027892218 0.00020278811 -0.0060455967 -19.360788 0 0.010520677 0.40810393 0.30957174 0.30957174 8.1141233e-05 3.6295165e-05 --0.010671821 -1.5900611e-05 0.0050901764 -0.00025797956 -1.6863648 0 5.100261 1.8948668 0.30957174 0.30957174 1.250456e-05 2.6187123e-05 --0.007768981 0.00033990469 0.0090920478 -0.0031641949 -0.60762693 0 4.7074343 1.6127009 0.30957174 0.30957174 7.678271e-06 9.3270376e-05 --0.0098777051 0.0011740644 -0.0024453038 -0.00081041715 -19.41495 0 4.2615851 5.4042983 0.30957174 0.30957174 2.3267451e-05 6.6797197e-06 -0.0071553781 0.0016315367 0.00058974383 0.010070428 17.529472 0 3.0671988 3.456922 0.30957174 0.30957174 2.9868878e-05 0.00010094413 -0.015253838 0.0011965687 -0.0020739939 -0.0033874331 -8.0552638 0 2.5655369 6.1044771 0.30957174 0.30957174 3.8585456e-05 1.5718435e-05 -0.011864184 0.00042633735 -0.0017533573 0.0015690083 -21.381745 0 2.261447 4.3607541 0.30957174 0.30957174 1.7107836e-05 5.5412039e-06 -0.0087346523 0.0023003393 -0.0058900923 -0.00013425076 -10.114683 0 3.1209576 5.1092937 0.30957174 0.30957174 5.6578162e-05 3.4993876e-05 -0.029950789 0.00038329485 -0.0083234202 -0.0086418178 1.8704677 0 2.0611499 5.8867958 0.30957174 0.30957174 9.9813732e-05 0.00014392123 -0.0056483155 0.00064046335 -0.0006645915 -0.00077492803 15.753829 0 2.7466837 5.9445716 0.30957174 0.30957174 7.2388721e-06 1.0409401e-06 -0.0052138033 -5.3853385e-05 0.00032996993 -0.00055923844 23.956345 0 1.851282 0.91092015 0.30957174 0.30957174 3.0105687e-06 4.1998652e-07 --0.035800652 0.00058279161 0.0053870824 -0.0037726889 -1.5918725 0 4.9394724 1.3379644 0.30957174 0.30957174 0.00014379368 4.337532e-05 -0.040207677 0.00081100637 -0.0042228841 0.0030212111 2.5433331 0 2.1268099 4.4695142 0.30957174 0.30957174 0.00018346331 2.703203e-05 -0.0087151751 0.00093191193 0.0090952366 -0.0017050421 -7.3775867 0 2.717357 1.7612468 0.30957174 0.30957174 1.624916e-05 8.6281332e-05 -0.0079115367 0.00074006386 0.0049310846 0.00040810567 8.2329782 0 2.6508159 2.0270056 0.30957174 0.30957174 1.1860363e-05 2.4679014e-05 -0.032364705 9.1192789e-05 0.00058531533 -0.0072601643 -2.5286017 0 1.9707581 0.45539932 0.30957174 0.30957174 0.00011506432 5.2629167e-05 -0.0098030269 0.0014181645 0.0038558445 -0.0054925462 15.396525 0 2.866764 0.9901998 0.30957174 0.30957174 2.8870188e-05 4.4912862e-05 --0.011292037 0.0037786518 0.011757722 0.0048098359 -5.1636503 0 3.8328855 2.3305682 0.30957174 0.30957174 0.00014406327 0.00016231841 -0.007438261 -0.0013996151 0.007991686 -0.0085067623 -13.547182 0 0.90243219 1.1325413 0.30957174 0.30957174 2.3918273e-05 0.00013616755 -0.0086113693 0.0021442659 -0.0039122162 -0.0086497597 -3.8392289 0 3.1006622 6.2296707 0.30957174 0.30957174 5.0024377e-05 8.9643574e-05 --0.0056268108 -0.0013173402 -0.0039203041 -0.0028349059 -20.27975 0 6.21903 5.7089233 0.30957174 0.30957174 1.9283926e-05 2.3465776e-05 --0.012856447 -0.001569797 -0.0011270314 -0.00067993519 -18.504863 0 5.9251899 5.6259456 0.30957174 0.30957174 4.0592743e-05 1.7391279e-06 --0.01908434 -0.00046708786 0.002397749 -0.0010712907 -11.841093 0 5.3060529 1.5279307 0.30957174 0.30957174 4.1969506e-05 6.9344503e-06 -0.0032582967 0.00046489402 -0.0064878581 0.0066582157 2.1538096 0 2.8600956 4.2923914 0.30957174 0.30957174 3.1342245e-06 8.6408805e-05 -0.00056423343 2.6459384e-05 0.011867648 -0.0056869687 15.282435 0 2.3488112 1.5013835 0.30957174 0.30957174 4.1326e-08 0.00017406927 -0.02461119 0.0031353631 0.0026734061 -0.0046741437 21.649828 0 2.8046455 0.89735026 0.30957174 0.30957174 0.00015604284 2.8876324e-05 -0.0096929528 0.00081873598 0.0054704254 0.0081700843 -24.869606 0 2.6009255 2.9221254 0.30957174 0.30957174 1.6420191e-05 9.6380044e-05 -0.00064349306 0.0005144088 -0.0046127263 0.0048854509 11.481806 0 3.3794224 4.2766392 0.30957174 0.30957174 2.4559474e-06 4.5125332e-05 -0.021394539 -0.0026909286 0.0017576685 -0.00035841844 -14.948097 0 1.0918799 1.7455211 0.30957174 0.30957174 0.0001162097 3.2420076e-06 --0.012943639 -7.581971e-05 -0.0082116826 -0.001819152 18.185477 0 5.1399985 5.3029924 0.30957174 0.30957174 1.844416e-05 7.1263974e-05 -0.00045090822 0.0014310061 -0.0011612268 -0.0022830845 19.050732 0 3.4813161 6.1836757 0.30957174 0.30957174 1.8676306e-05 6.5297675e-06 -0.029060755 -0.0011368333 -0.0057270294 0.0053770026 -21.924026 0 1.6027747 4.3368534 0.30957174 0.30957174 0.00010448255 6.1744612e-05 -0.035007087 -0.0049832966 0.0037306455 0.0037640785 -4.7572227 0 1.0312136 2.7308963 0.30957174 0.30957174 0.00036074667 2.8084894e-05 -0.0017527926 -0.00074936594 0.00092886202 0.0059402027 -14.18392 0 0.6256425 3.3595363 0.30957174 0.30957174 5.4526301e-06 3.5870508e-05 --0.00364744 -0.0027752095 0.0027396533 0.004409734 20.276288 0 0.23100988 2.9563316 0.30957174 0.30957174 7.1618938e-05 2.6855403e-05 --0.016695509 0.0019284204 -0.0051626672 -0.00050533824 3.216389 0 4.2758692 5.1834776 0.30957174 0.30957174 6.4475239e-05 2.7123705e-05 -0.01726334 -0.00021845912 0.0018756224 0.0010838941 8.2685245 0 1.8303285 2.4655863 0.30957174 0.30957174 3.3150799e-05 4.7119637e-06 --0.0023764885 0.00029966261 0.0029594647 -0.001451634 13.992473 0 4.2322207 1.4922753 0.30957174 0.30957174 1.4379881e-06 1.0920031e-05 --0.0096863594 -0.00058782021 0.0014972915 0.0062401907 -23.461754 0 5.5916841 3.278553 0.30957174 0.30957174 1.3447474e-05 4.0885273e-05 --0.0014745029 0.00041829832 -0.0013550191 0.001060077 4.6980538 0 3.8851113 4.4267499 0.30957174 0.30957174 1.832572e-06 2.9657208e-06 --0.0105806 -0.0010769415 -0.0026421059 -0.0016276364 -13.19038 0 5.834327 5.6351988 0.30957174 0.30957174 2.2854517e-05 9.6654081e-06 -0.0025553295 -0.00090144924 -0.0043161952 0.00060282613 19.619228 0 0.67598558 4.9490287 0.30957174 0.30957174 8.1191891e-06 1.9141866e-05 -0.0011329221 0.0020032374 0.0032834944 0.0036906449 5.0614168 0 3.4538886 2.784775 0.30957174 0.30957174 3.6696467e-05 2.4379946e-05 -0.01702603 -0.0036409136 -0.0062764892 0.0011360225 14.555866 0 0.84857149 4.9090487 0.30957174 0.30957174 0.00015257898 4.0995562e-05 --0.0056697892 0.00095564133 0.0073987946 -0.0027908757 11.328349 0 4.0931839 1.5870654 0.30957174 0.30957174 1.1848089e-05 6.2914414e-05 --0.0080139393 5.0415193e-05 -0.0022765482 -0.00089523433 13.219255 0 5.0294453 5.4585994 0.30957174 0.30957174 7.0733856e-06 6.0198838e-06 -0.018605025 -0.0014134512 -0.0034150617 0.0088623633 -23.86234 0 1.3397243 3.8864339 0.30957174 0.30957174 5.619809e-05 8.9664124e-05 --0.0072151507 0.00020491099 -0.0072520213 0.002487369 -22.113761 0 4.8335325 4.7587568 0.30957174 0.30957174 6.0973039e-06 5.9157507e-05 --0.0057375165 -0.00032187861 -0.0029100483 -0.0028370422 18.069682 0 5.5591316 5.8553274 0.30957174 0.30957174 4.557544e-06 1.652114e-05 --0.0022184018 -0.0010724992 -0.0049863785 -0.0024376839 3.0217484 0 0.15101904 5.5381968 0.30957174 0.30957174 1.1018349e-05 3.096091e-05 -0.0080750932 -0.0021351794 -0.00045793368 -0.001143217 -20.253627 0 0.76781427 6.2736808 0.30957174 0.30957174 4.8687808e-05 1.50779e-06 --0.0059891043 0.0030266135 0.0021765837 0.0029684939 -13.670746 0 3.7297979 2.8793362 0.30957174 0.30957174 8.7383069e-05 1.351684e-05 -0.030035728 0.0010075511 0.0052875165 -0.00080444833 14.183194 0 2.24166 1.795316 0.30957174 0.30957174 0.00010828223 2.8827641e-05 --0.008264135 0.00030631272 0.0060934384 0.00017567713 -9.0731918 0 4.761066 1.9736862 0.30957174 0.30957174 8.3520315e-06 3.746328e-05 -0.010794962 0.00030662295 0.0043372702 0.0024251205 1.1240746 0 2.1982889 2.4514754 0.30957174 0.30957174 1.3648888e-05 2.4798918e-05 --0.018800693 0.00039534571 0.00090603191 -0.0094361685 -3.0129246 0 4.8974276 0.47079925 0.30957174 0.30957174 4.0226221e-05 8.9148885e-05 -0.0024250272 0.0023540682 0.001432405 0.00043748814 -5.3302836 0 3.4032853 2.2392599 0.30957174 0.30957174 5.1126433e-05 2.258358e-06 --0.022483098 -0.0015108246 0.001499743 -0.0041486349 17.302558 0 5.6359831 0.72378939 0.30957174 0.30957174 7.628412e-05 1.9339568e-05 --0.0033884476 0.001995213 0.0013410424 -0.00042824925 15.471914 0 3.7002099 1.6383369 0.30957174 0.30957174 3.7523702e-05 1.9949692e-06 --0.0061502172 -0.0014007615 -0.00072903568 0.0013005103 7.7046772 0 6.2083499 4.0302904 0.30957174 0.30957174 2.2026141e-05 2.2134769e-06 --0.0075217573 0.00033728908 -0.0012382525 -0.0020640844 20.323381 0 4.6988933 6.1135483 0.30957174 0.30957174 7.2471532e-06 5.7717632e-06 -0.0092716147 -0.0043129955 -0.0014161256 0.0035495779 -7.0068624 0 0.60604718 3.8983015 0.30957174 0.30957174 0.00017888873 1.4519385e-05 -0.0058116229 -2.5137914e-05 -0.0035608267 0.0006225045 -13.190786 0 1.9057148 4.91499 0.30957174 0.30957174 3.7134701e-06 1.3167226e-05 -0.016401972 0.0013411334 0.0041383052 0.0040060861 -18.28802 0 2.5852889 2.7102052 0.30957174 0.30957174 4.5917199e-05 3.3184132e-05 --0.015059671 0.00011778342 -0.0045797086 0.0039561638 11.199297 0 5.0155639 4.3782253 0.30957174 0.30957174 2.5023102e-05 3.6669383e-05 --0.017421833 -0.0017283774 -0.0050807164 -0.0048894326 9.0190838 0 5.8215552 5.8488484 0.30957174 0.30957174 6.0531878e-05 4.9737353e-05 -0.0008306681 0.0018020536 0.0059597953 0.0046756831 11.321868 0 3.4653336 2.606399 0.30957174 0.30957174 2.9657511e-05 5.7493943e-05 --0.0066749446 -0.00029227125 0.0040269708 0.0012794226 3.1769349 0 5.4662177 2.2503888 0.30957174 0.30957174 5.669247e-06 1.7972373e-05 -0.0040799613 0.0006659704 -0.0063688887 -0.0071898559 -4.7777863 0 2.9238412 5.9285309 0.30957174 0.30957174 5.8675166e-06 9.2169438e-05 -0.013130009 -0.0017027748 -0.0038902349 -0.003936048 -13.183809 0 1.07675 5.8738819 0.30957174 0.30957174 4.5337348e-05 3.0624499e-05 -0.011995213 0.00055900541 -0.00039921137 0.0051199213 20.693223 0 2.3465594 3.5943394 0.30957174 0.30957174 1.864184e-05 2.6162303e-05 --0.0049107058 -0.00593902 0.0022993821 -0.0032726794 17.465959 0 0.28377872 0.99059277 0.30957174 0.30957174 0.00032395284 1.5954085e-05 -0.020741861 0.00012453615 0.0026701765 -0.0058586838 4.437857 0 1.9997357 0.80500906 0.30957174 0.30957174 4.7370063e-05 4.1234599e-05 -0.025032259 -0.0016349115 0.0058560339 0.0045904825 1.3834959 0 1.4083962 2.6059984 0.30957174 0.30957174 9.3136579e-05 5.5474824e-05 -0.027558766 -0.00052567213 0.0043439454 0.0077662778 -18.64601 0 1.7730566 3.0024453 0.30957174 0.30957174 8.5891249e-05 7.8851056e-05 -0.011894573 -0.00064810358 -0.012623441 -0.0025298065 8.9764043 0 1.4843767 5.2829163 0.30957174 0.30957174 1.9357632e-05 0.00016699844 -0.012973282 0.0021497129 -0.0041132468 -0.00030601234 -1.3123219 0 2.930786 5.160351 0.30957174 0.30957174 6.057298e-05 1.7149604e-05 -0.004086932 -0.0019220589 -0.01311424 -0.0082917587 -13.96381 0 0.60361643 5.6468396 0.30957174 0.30957174 3.5486472e-05 0.00024158259 --0.0016045434 -0.0026218524 -0.0012948054 0.00041501882 -23.146671 0 0.30721882 4.7788612 0.30957174 0.30957174 6.2901484e-05 1.8610355e-06 --0.0036301007 -0.0016639693 0.00048853409 0.00089736523 -18.348408 0 0.13923897 3.0139351 0.30957174 0.30957174 2.6668586e-05 1.0393642e-06 --0.013135924 0.00064329183 -0.00039002789 0.0021722039 24.39563 0 4.66708 3.6949714 0.30957174 0.30957174 2.2711976e-05 4.8336787e-06 --0.0072388981 -0.0016582505 0.0067051651 0.00063287974 1.9075627 0 6.2106009 2.0384482 0.30957174 0.30957174 3.0801412e-05 4.5723035e-05 --0.0086318165 -0.00097947012 0.0027938128 -0.0058828416 -0.96716514 0 5.8886373 0.82082829 0.30957174 0.30957174 1.691848e-05 4.2197009e-05 --0.0076242088 0.00027340189 -0.0013978452 0.0015880986 22.536375 0 4.7709571 4.2416893 0.30957174 0.30957174 7.0620916e-06 4.4715636e-06 -0.0086861082 -0.00054699359 -0.0010153272 0.0026749874 18.488761 0 1.4242788 3.88136 0.30957174 0.30957174 1.1008051e-05 8.1369913e-06 --0.01170888 -0.0021676963 0.0030800809 0.0023384233 -11.079201 0 6.1222557 2.5905593 0.30957174 0.30957174 5.7854307e-05 1.4988242e-05 --0.0092001608 -0.00016375433 0.0033220557 0.007340934 -11.67858 0 5.2474289 3.0878722 0.30957174 0.30957174 9.536122e-06 6.4579588e-05 -0.031421509 0.0010179836 -0.0014930835 0.0060108471 -21.38887 0 2.2320727 3.7612697 0.30957174 0.30957174 0.00011782402 3.8085609e-05 --0.019690095 0.00045082866 0.0095840895 0.011433524 1.1115343 0 4.8810668 2.8142634 0.30957174 0.30957174 4.4411973e-05 0.00022227199 --0.01570854 -0.0006530411 -0.00027841256 0.00086458224 3.0022718 0 5.4486983 3.8298035 0.30957174 0.30957174 3.0973186e-05 8.1960367e-07 --0.012695067 0.00090074437 -0.0021190892 0.0044674725 -12.271985 0 4.5128974 3.9619523 0.30957174 0.30957174 2.5082986e-05 2.4324076e-05 -0.021179081 0.00081779997 0.0021427473 0.0051817785 3.5989954 0 2.2833257 3.1209143 0.30957174 0.30957174 5.5333173e-05 3.126251e-05 --0.0053322307 0.0005283056 0.0018108325 -0.0019811531 -11.660275 0 4.3524743 1.1188571 0.30957174 0.30957174 5.6637437e-06 7.1990757e-06 --0.0144917 -0.00092171902 0.011271584 0.003641828 13.780752 0 5.6118134 2.25524 0.30957174 0.30957174 3.0793214e-05 0.00014123994 --0.014987117 0.0024501919 -0.0012634609 -0.0066887021 13.995419 0 4.1072164 0.1861189 0.30957174 0.30957174 7.9345014e-05 4.598633e-05 --0.0031059558 0.00093318258 -0.0060538452 -0.0097283192 -5.904292 0 3.8661995 6.0971883 0.30957174 0.30957174 8.9917305e-06 0.00013082274 -0.010336006 0.0014088129 0.0028976006 -0.0042940429 11.075262 0 2.8378689 0.97167947 0.30957174 0.30957174 2.9807677e-05 2.6754244e-05 -0.015996685 0.0019790325 0.0014484064 -0.011005954 6.4261212 0 2.7901184 0.50620479 0.30957174 0.30957174 6.3768776e-05 0.00012226655 --0.0053433695 0.0047392556 0.0015160856 0.0013302901 17.218535 0 3.6390369 2.6612901 0.30957174 0.30957174 0.00020773586 4.072615e-06 --0.016217958 0.00092129447 -0.0017003862 -0.00015603714 14.031196 0 4.6091581 5.1774628 0.30957174 0.30957174 3.6605672e-05 2.9390334e-06 --0.0030918086 0.0018078705 0.014901977 -0.0071456536 15.982098 0 3.7014726 1.5011318 0.30957174 0.30957174 3.0822437e-05 0.00027452666 -0.0020020352 0.0019097868 0.0012849198 -0.0078392602 -5.0731445 0 3.4013174 0.53806484 0.30957174 0.30957174 3.3664502e-05 6.262157e-05 --0.019195158 0.0020506937 -0.0073443004 -0.00095041259 10.577479 0 4.3148772 5.214353 0.30957174 0.30957174 7.8755853e-05 5.5274426e-05 -0.0047201981 -0.0015915405 -0.0014285433 -0.003489543 -18.3684 0 0.68905407 6.2660658 0.30957174 0.30957174 2.5519922e-05 1.4135821e-05 --0.016550679 0.00047918381 0.0046163855 -6.4907857e-05 10.158702 0 4.8288218 1.9311509 0.30957174 0.30957174 3.2162329e-05 2.1488917e-05 --0.0038755785 0.0020524802 0.002074921 0.0079749726 21.488513 0 3.7202838 3.2593717 0.30957174 0.30957174 4.0023706e-05 6.7426318e-05 -0.0032253191 0.0016295598 -0.0059416773 -0.005880639 -3.2677494 0 3.3019414 5.8628655 0.30957174 0.30957174 2.5331609e-05 6.9893606e-05 -0.017060654 0.0011004805 0.0016919859 -0.0061188428 12.790686 0 2.4763421 0.64617239 0.30957174 0.30957174 4.2984319e-05 4.0023653e-05 -0.026222029 -8.8085133e-05 -0.01124217 0.00070897352 2.549528 0 1.9145059 5.0242168 0.30957174 0.30957174 7.5552771e-05 0.00012791523 --0.00082981975 0.00024851887 -0.00049003355 0.0003570268 16.37534 0 3.8672367 4.4609001 0.30957174 0.30957174 6.3820246e-07 3.6852784e-07 --0.0088406423 -0.0013470688 0.00583404 0.0055100573 0.27083044 0 6.0331645 2.6978912 0.30957174 0.30957174 2.5109659e-05 6.4428716e-05 -0.010788098 -0.00046872151 0.0051508104 0.0064819033 21.25952 0 1.5682296 2.8404679 0.30957174 0.30957174 1.477751e-05 6.8422463e-05 --0.0093138018 0.0011864331 -0.0011741129 0.00028680766 2.4590664 0 4.2271847 4.8489699 0.30957174 0.30957174 2.2345387e-05 1.4713722e-06 -0.029484115 -0.0014823567 0.013686159 0.008294551 1.1942449 0 1.5156204 2.4863638 0.30957174 0.30957174 0.00011544735 0.00025708113 --0.0025274873 -0.0024440853 -0.0016536031 0.0025962447 -22.495257 0 0.26126118 4.0867038 0.30957174 0.30957174 5.5116621e-05 9.4426773e-06 -0.0054614631 0.0021845608 -0.0012178716 -0.0058688555 -22.20249 0 3.2480422 0.16806872 0.30957174 0.30957174 4.6747115e-05 3.5660261e-05 --3.0131858e-05 -0.0026187149 0.0088447983 -0.0010862357 -23.08151 0 0.37303714 1.8238762 0.30957174 0.30957174 6.2469177e-05 8.0038543e-05 -0.0091353518 0.00091975867 -0.0026583351 -0.012378634 -2.17257 0 2.6873029 0.16108843 0.30957174 0.30957174 1.6867533e-05 0.00015911592 -0.012178429 0.00093694444 0.0051009602 -0.0044931349 -13.372875 0 2.5563778 1.2269928 0.30957174 0.30957174 2.4278282e-05 4.6256925e-05 --0.017159358 0.00042531939 0.00097898853 0.0049692863 24.225382 0 4.8646239 3.3198306 0.30957174 0.30957174 3.3970985e-05 2.5460367e-05 -0.012275958 -0.0017498146 0.0018461174 -8.8460746e-05 15.845328 0 1.0305725 1.8976026 0.30957174 0.30957174 4.4434855e-05 3.4436938e-06 -0.0076806474 0.0015342008 -0.0023011423 0.0050697208 12.149061 0 3.0133761 3.9450484 0.30957174 0.30957174 2.7917399e-05 3.0832667e-05 -0.030725684 0.00050262451 -0.0011655325 0.0033305978 -5.848557 0 2.0930233 3.8550597 0.30957174 0.30957174 0.00010593822 1.2372726e-05 -0.030587103 -0.0020940168 0.0033482801 0.0032490873 -10.714642 0 1.3874795 2.7114037 0.30957174 0.30957174 0.00014264792 2.1773579e-05 -0.015659967 0.00029974621 -0.0012609831 -0.0088155464 16.635116 0 2.117723 0.23108074 0.30957174 0.30957174 2.7739571e-05 7.8688515e-05 -0.014236703 0.0014921015 0.0007110179 -0.0049742562 -20.376082 0 2.7073363 0.51741977 0.30957174 0.30957174 4.2530824e-05 2.5052822e-05 -0.0087149698 0.0033384954 0.0095703936 -0.0028877698 9.7247268 0 3.2368049 1.654282 0.30957174 0.30957174 0.00010986667 0.00010061086 --0.025854986 0.0019372001 -0.0022755325 -0.0059849418 -10.556839 0 4.4877877 0.0082649623 0.30957174 0.30957174 0.00010756892 4.0750155e-05 --0.026709917 0.00063532766 -0.0010640424 0.0064854033 6.4059742 0 4.8733102 3.6798135 0.30957174 0.30957174 8.1993986e-05 4.2861776e-05 -0.0033870994 -0.0013408914 -0.0033240602 -0.0052976156 21.009216 0 0.64480102 6.0934552 0.30957174 0.30957174 1.7637977e-05 3.8977252e-05 -0.013274749 0.00089366826 0.002079564 -0.0017048288 -19.250058 0 2.495203 1.2623752 0.30957174 0.30957174 2.6619927e-05 7.2427797e-06 -0.013410625 0.00060989398 -0.0041125628 0.002372118 -4.2990507 0 2.3378524 4.5670114 0.30957174 0.30957174 2.313125e-05 2.263249e-05 --0.0084679982 -0.00072808001 0.0072558763 -0.0049588432 -22.462961 0 5.751118 1.3493585 0.30957174 0.30957174 1.2700663e-05 7.7468208e-05 -0.010589229 0.0047250288 -0.00013587669 -0.0010594765 -2.7060684 0 3.2746632 0.24571925 0.30957174 0.30957174 0.00021568449 1.1320272e-06 --0.012492895 0.00017408063 -0.0033806381 0.0042533457 10.256849 0 4.960431 4.1914247 0.30957174 0.30957174 1.7409213e-05 2.9466547e-05 --0.0014405789 0.0015468254 0.011796964 0.0060054731 6.695474 0 3.6177757 2.4126988 0.30957174 0.30957174 2.2023538e-05 0.00017607692 --0.0043722707 0.00068479124 0.0037906217 0.0064155397 5.9501996 0 4.1272271 2.9786659 0.30957174 0.30957174 6.3703219e-06 5.5312286e-05 -0.0076921856 0.00085156756 0.0049831856 0.0073816582 -0.43706074 0 2.7347062 2.9183199 0.30957174 0.30957174 1.3101296e-05 7.9082853e-05 --0.0134015 -0.0019976729 -0.00019382739 -0.0020373493 -23.183498 0 6.0227162 0.27868018 0.30957174 0.30957174 5.6068735e-05 4.1551049e-06 --0.0085277868 -0.0030853755 0.00147144 -0.0008814477 -10.361046 0 0.079711735 1.4089573 0.30957174 0.30957174 9.4700421e-05 2.9534531e-06 --0.02650534 -0.0026276735 -0.0072293996 -0.00072460586 19.303341 0 5.8212039 5.1857836 0.30957174 0.30957174 0.00014001919 5.3211073e-05 --0.010934771 0.0013723999 0.0032044261 -0.0041145234 3.0481288 0 4.2345315 1.039925 0.30957174 0.30957174 3.0283293e-05 2.7144466e-05 --0.026636728 0.00087504028 -0.0027982906 0.00058572669 -24.504903 0 4.7959196 4.8819744 0.30957174 0.30957174 8.4863466e-05 8.234564e-06 --7.1098925e-06 8.6789794e-05 -0.0031454967 0.0040877676 20.592087 0 3.5248857 4.1756794 0.30957174 0.30957174 6.862164e-08 2.6549535e-05 -0.017833988 0.0050516577 -0.0022497524 0.0018034155 -3.9132651 0 3.1461666 4.4149282 0.30957174 0.30957174 0.00026737911 8.3286545e-06 -0.03075434 4.299098e-05 0.0031363804 -0.0010941387 2.2174577 0 1.9578298 1.6119601 0.30957174 0.30957174 0.00010384715 1.110453e-05 -0.0026990192 -0.0010228089 -0.00024730955 -0.0037083195 12.570461 0 0.65626514 0.30716719 0.30957174 0.30957174 1.0329359e-05 1.37021e-05 -0.0096467156 0.0010412076 -0.0028971666 -0.0023055198 12.448586 0 2.7220292 5.7549023 0.30957174 0.30957174 2.0091347e-05 1.3734439e-05 --0.0050546603 -0.00011962211 -3.54559e-05 0.001237095 -11.84169 0 5.2990196 3.5447791 0.30957174 0.30957174 2.9351074e-06 1.5192969e-06 -0.005973405 -0.0014657192 -0.0028270396 -0.0006310847 19.426846 0 0.79497838 5.3045999 0.30957174 0.30957174 2.3486987e-05 8.4523506e-06 -0.013573359 0.0010790106 -0.010729016 -0.0061498011 -17.565401 0 2.5718458 5.6036692 0.30957174 0.30957174 3.0830599e-05 0.0001535644 -0.0087547438 -0.00092409183 0.011425365 0.0025703505 -7.2728015 0 1.179311 2.1646492 0.30957174 0.30957174 1.619283e-05 0.00013815638 -0.0027039674 -0.0015902752 -0.0047677341 -0.0033494915 2.6542342 0 0.55883216 5.6952997 0.30957174 0.30957174 2.3840017e-05 3.4044966e-05 -0.0072525544 0.0019803473 -0.0038638067 0.0080995486 20.090072 0 3.1336358 3.9641672 0.30957174 0.30957174 4.1499148e-05 8.0122934e-05 --0.0026134928 -0.00063192924 -0.0038745696 0.0057744477 21.834888 0 6.231303 4.1106415 0.30957174 0.30957174 4.3875037e-06 4.8209296e-05 -0.010096395 5.0704293e-06 -0.0029897302 -0.00039427937 18.886252 0 1.9496713 5.2167622 0.30957174 0.30957174 1.1190593e-05 9.1655502e-06 --0.018103299 -0.0031654646 -0.011852963 0.0011583272 -4.3866576 0 6.0968647 4.9900566 0.30957174 0.30957174 0.00012725462 0.00014296886 --0.029483946 0.00056341486 0.011030756 0.0086410789 15.446945 0 4.9143432 2.6056725 0.30957174 0.30957174 9.8321126e-05 0.00019673395 --0.010511025 8.4743143e-05 -0.0069642357 0.0063453921 -12.958983 0 5.0133783 4.3517938 0.30957174 0.30957174 1.2193762e-05 8.8834376e-05 -0.045149009 0.001612561 0.0093461304 0.0084838831 20.44706 0 2.259649 2.6781343 0.30957174 0.30957174 0.00024746064 0.0001594565 --0.013779681 0.0011134235 -0.0065145473 0.0018665134 -19.563904 0 4.4521733 4.809792 0.30957174 0.30957174 3.2137415e-05 4.6240985e-05 --0.0052031672 -0.00045299794 -0.0034329621 -0.00030009612 2.6937193 0 5.7571965 5.1731822 0.30957174 0.30957174 4.841296e-06 1.1970629e-05 -0.0082234826 0.0010455748 -0.00011953263 0.002735423 -3.6110827 0 2.8036708 3.5599187 0.30957174 0.30957174 1.7382355e-05 7.4364409e-06 --0.0036015131 -0.00051950932 -0.0086750624 0.0035708554 -12.923703 0 6.0069612 4.6990528 0.30957174 0.30957174 3.8824351e-06 8.8518089e-05 --0.00044382777 8.4947233e-05 0.0027275464 0.0069134876 11.568894 0 4.0366421 3.1373351 0.30957174 0.30957174 8.7357769e-08 5.4909991e-05 --0.020648534 0.0023167151 -0.0010206039 0.0040970565 16.456681 0 4.2903868 3.7619417 0.30957174 0.30957174 9.5696299e-05 1.7700267e-05 -0.0025017944 0.00022872235 -0.00061627198 -0.0083411256 -24.429703 0 2.6395256 0.29995173 0.30957174 0.30957174 1.1636386e-06 6.9394694e-05 --0.0034325137 -0.0002173174 -0.0034697233 -0.00034594475 0.17203139 0 5.609821 5.1852664 0.30957174 0.30957174 1.7236163e-06 1.2255829e-05 --0.0050760437 0.0013838715 0.010874863 0.00025376799 11.390521 0 3.8986922 1.9682391 0.30957174 0.30957174 2.0273908e-05 0.00011929057 -0.028483382 0.0011815882 -0.0013083276 -0.0048024977 -9.7416164 0 2.3063969 0.10626203 0.30957174 0.30957174 0.00010178047 2.4603166e-05 -0.00095193054 -7.8821304e-05 0.0047974797 -0.0087328873 12.712654 0 1.2988681 0.88008385 0.30957174 0.30957174 1.5607153e-07 9.8850096e-05 -0.0073218216 0.002125703 -0.0022444722 0.0015792638 -11.622401 0 3.1543911 4.477351 0.30957174 0.30957174 4.7046794e-05 7.5526285e-06 -0.0086478708 -0.00018611341 -0.0063444993 -0.00027799826 6.1673539 0 1.7515062 5.1301248 0.30957174 0.30957174 8.5252784e-06 4.065746e-05 -0.036552095 -0.0015407497 0.00038449594 0.0026434749 0.52174705 0 1.5784765 3.3702939 0.30957174 0.30957174 0.00016829301 7.0804982e-06 --0.009905176 0.0011974998 0.0020612834 0.0046963638 -13.330746 0 4.2531244 3.0993032 0.30957174 0.30957174 2.3833395e-05 2.6161018e-05 --0.011066672 0.000638599 0.003957333 -0.0029137387 9.3256549 0 4.6027298 1.3143004 0.30957174 0.30957174 1.7159407e-05 2.4209371e-05 --0.012064219 0.0012421543 -0.011989748 0.004507845 -10.746587 0 4.3333154 4.7297303 0.30957174 0.30957174 3.0032823e-05 0.00016508226 -0.001705221 0.0030585777 0.0038681301 0.0030571613 11.076873 0 3.4547662 2.6099774 0.30957174 0.30957174 8.5536494e-05 2.4355063e-05 -0.0082287486 0.0028582756 -0.004120409 -0.0029241165 -0.11400505 0 3.2097869 5.7000468 0.30957174 0.30957174 8.185449e-05 2.5597488e-05 -0.0032002972 -0.00076317396 -0.0021065228 0.0061913799 -16.16651 0 0.80571906 3.8463255 0.30957174 0.30957174 6.4299405e-06 4.249684e-05 --0.0069230313 1.5015614e-05 -0.0061770083 -0.0046792366 23.299504 0 5.0669342 5.7310854 0.30957174 0.30957174 5.2634855e-06 6.0184679e-05 -0.01274272 0.0028308307 -0.0012630677 0.0069418928 -23.977469 0 3.0569355 3.697308 0.30957174 0.30957174 9.0824172e-05 4.9408563e-05 --0.0050049067 -0.0021714881 0.0072640177 -0.0068300251 -8.077359 0 0.126484 1.194532 0.30957174 0.30957174 4.5703809e-05 9.9468133e-05 --0.00078058279 0.004049128 0.0040350959 0.010278693 20.012333 0 3.5370524 3.1390392 0.30957174 0.30957174 0.00014941911 0.00012121196 --0.012490052 -0.0015706184 -0.0095803402 -0.0027722301 -6.3631316 0 5.9398001 5.3662019 0.30957174 0.30957174 3.9596761e-05 0.00010015423 --0.013836674 0.0001227075 -0.00032026887 0.0054464485 10.766195 0 5.0060798 3.5751062 0.30957174 0.30957174 2.1154355e-05 2.9527352e-05 --0.0030772173 -0.00079770168 -0.0069295491 0.001357879 4.1400835 0 6.2569063 4.8947126 0.30957174 0.30957174 6.8360587e-06 5.0239015e-05 -0.013101749 -0.0013815893 0.0025068989 -0.0098009884 5.5140133 0 1.1797965 0.62666774 0.30957174 0.30957174 3.623174e-05 0.00010161842 -0.0021418189 -0.0020801868 0.0042868782 0.0041587216 -18.410781 0 0.48685207 2.7112646 0.30957174 0.30957174 3.9921475e-05 3.5682253e-05 --0.014460043 -0.00051308376 -0.009491176 -0.0045249817 19.678922 0 5.3993165 5.5284242 0.30957174 0.30957174 2.5351672e-05 0.00011112665 -0.0026588088 -0.0014520157 0.00035759982 -7.5185935e-05 -21.458125 0 0.57267101 1.7394921 0.30957174 0.30957174 1.9981794e-05 1.3452728e-07 -0.025379279 -0.001345557 -0.0077496822 -0.0067885269 -22.349362 0 1.4951734 5.8020493 0.30957174 0.30957174 8.720096e-05 0.00010625862 --0.0055294648 -0.0017852216 0.0050553872 -0.012745054 14.263364 0 0.046545358 0.75471032 0.30957174 0.30957174 3.2388162e-05 0.00018688824 --0.0050781246 1.3506838e-06 -0.0019091307 0.0028481947 -2.769715 0 5.0842663 4.1101639 0.30957174 0.30957174 2.8308744e-06 1.172111e-05 -0.00099020928 -0.00096748179 0.00074029546 0.0079054492 -4.3079711 0 0.48618684 3.4217649 0.30957174 0.30957174 8.6342059e-06 6.2543297e-05 -0.022790382 0.00035022636 -0.00066064295 -0.0018475959 -22.237405 0 2.0841792 0.028316471 0.30957174 0.30957174 5.8135678e-05 3.8260156e-06 --0.013934218 0.0018206363 0.0049969927 -0.0066346308 7.761239 0 4.2146564 1.0237318 0.30957174 0.30957174 5.1509569e-05 6.8835885e-05 --0.0058883343 0.0019793098 0.0032004767 0.0032010718 -15.297023 0 3.8315535 2.7265284 0.30957174 0.30957174 3.9493746e-05 2.0490556e-05 --0.0085309004 0.0014741203 -0.0032859227 -0.0096613694 20.275738 0 4.0818589 0.043980754 0.30957174 0.30957174 2.7784115e-05 0.00010347261 -0.017540695 0.0010727824 0.0074338768 0.0051951419 4.2406477 0 2.4533944 2.5512416 0.30957174 0.30957174 4.4259379e-05 8.2484278e-05 --0.0046925985 0.0011284276 -0.00050498425 0.0021530653 -7.7952698 0 3.944148 3.7480823 0.30957174 0.30957174 1.4016757e-05 4.8552945e-06 -9.9184416e-05 -0.00035243 0.0022080093 -0.0017020822 6.4331203 0 0.405185 1.2922952 0.30957174 0.30957174 1.1325275e-06 7.7887058e-06 -0.011257575 0.00022966777 0.003571046 0.0015679428 -12.43604 0 2.1288424 2.3558446 0.30957174 0.30957174 1.4392862e-05 1.529489e-05 -0.011418027 -0.0021549129 0.0054588009 -0.0024336082 -9.5539263 0 0.9011288 1.5287406 0.30957174 0.30957174 5.6612527e-05 3.5915979e-05 -0.0091369273 0.00019965582 0.0051989583 -0.0014167392 -5.8379308 0 2.1415822 1.6811042 0.30957174 0.30957174 9.5276833e-06 2.9240424e-05 -0.015170435 -0.00047710491 -0.0057871414 -0.0047381621 15.711812 0 1.6660829 5.7687765 0.30957174 0.30957174 2.7337867e-05 5.6032669e-05 -0.018389635 -0.00070404803 0.0018172442 -0.0036599746 6.4627354 0 1.6095332 0.83840038 0.30957174 0.30957174 4.163961e-05 1.6616397e-05 --0.0057709479 -0.00029768153 -0.0015655999 -0.0017782401 1.6106538 0 5.5259576 5.9315648 0.30957174 0.30957174 4.4632165e-06 5.607653e-06 --0.0049178247 0.00024764192 0.0033721026 0.0079157826 2.2300826 0 4.6566144 3.1102422 0.30957174 0.30957174 3.2136029e-06 7.3616728e-05 -0.0075604245 -0.00074635387 0.0032564815 0.0075490993 19.76457 0 1.2126882 3.1056753 0.30957174 0.30957174 1.134918e-05 6.7219215e-05 --0.0061468953 -0.0002170131 0.00047943518 -0.0016363444 -13.416394 0 5.3978447 0.66151318 0.30957174 0.30957174 4.5768525e-06 2.8877038e-06 -0.025979926 -0.00041155639 0.00066760529 -0.0047679932 -19.200241 0 1.8017813 0.51453322 0.30957174 0.30957174 7.5637638e-05 2.2999267e-05 --0.014450573 0.002728072 -0.00036729829 0.0026100698 -24.514415 0 4.0425893 3.6568231 0.30957174 0.30957174 9.0718944e-05 6.8933875e-06 -0.0010014315 -0.0032288667 -0.0028431976 -0.001676254 14.437681 0 0.40833441 5.6158568 0.30957174 0.30957174 9.508063e-05 1.0936777e-05 -0.026569479 0.0020789408 0.0059332015 -0.0028554856 -23.046017 0 2.5643399 1.4997075 0.30957174 0.30957174 0.00011686635 4.3577713e-05 --0.00063264105 -0.0009518125 -0.0058771307 0.0034156389 -6.1788948 0 0.30146389 4.563747 0.30957174 0.30957174 8.2965494e-06 4.6394488e-05 --0.016547052 -0.001899653 0.011217532 0.0030440366 24.904248 0 5.8944637 2.2080347 0.30957174 0.30957174 6.2930324e-05 0.00013605001 -0.0043943452 0.0013227064 -0.0018088711 -0.0058222628 -15.233509 0 3.1661782 0.070764681 0.30957174 0.30957174 1.8057154e-05 3.692333e-05 -0.00071578714 -0.00012242219 -0.0074752671 0.0094641563 5.4988424 0 0.94492639 4.188367 0.30957174 0.30957174 1.9276836e-07 0.00014518114 -0.0012069607 0.00044499023 0.0054970605 0.011297287 13.465781 0 3.2265002 3.0598348 0.30957174 0.30957174 1.9637232e-06 0.00015706071 -0.0076283383 -0.002235705 -0.0062747869 0.0069393338 22.732298 0 0.7326892 4.2550832 0.30957174 0.30957174 5.1920191e-05 8.7458895e-05 -0.012658203 0.0025579818 0.0012570319 0.011511981 -17.131866 0 3.0182601 3.4062509 0.30957174 0.30957174 7.71947e-05 0.00013304714 --0.0035378036 0.0013141796 0.0073404942 -0.00041874625 -14.102493 0 3.8032367 1.8885721 0.30957174 0.30957174 1.7106489e-05 5.4496027e-05 --0.0085851494 0.0019669351 0.00024048667 0.0075038563 11.238133 0 3.9627197 3.4835945 0.30957174 0.30957174 4.3333756e-05 5.5910866e-05 -0.010933066 0.00074491545 0.0015901648 0.00047722788 -12.401869 0 2.5005688 2.2344287 0.30957174 0.30957174 1.8176641e-05 2.7751419e-06 --0.014563427 -0.0013843486 -0.00065110865 0.0051771132 -4.1933339 0 5.8003452 3.6420119 0.30957174 0.30957174 4.0740377e-05 2.7013178e-05 --0.0097880127 0.0033101341 -0.00077489715 -0.0073747235 19.766384 0 3.8297709 0.26876257 0.30957174 0.30957174 0.00011032853 5.4552144e-05 --0.0028551226 1.8501129e-05 -0.0080069078 -0.0011921261 -3.6881286 0 5.0277291 5.2333127 0.30957174 0.30957174 8.9798994e-07 6.6042861e-05 -0.0084820599 -0.0012957074 0.0045427345 0.0060672742 -10.798228 0 0.99742088 2.8693072 0.30957174 0.30957174 2.3191291e-05 5.7318821e-05 --0.025386701 0.00049028152 0.0039915369 -0.0050824105 19.636881 0 4.9125461 1.0439997 0.30957174 0.30957174 7.2939258e-05 4.1684275e-05 -0.0086802976 0.00053170168 -0.005673922 -0.0045041379 12.494769 0 2.4540492 5.7537077 0.30957174 0.30957174 1.0846711e-05 5.2579042e-05 --0.0035774127 -0.00089281527 -0.00096087216 0.0049359931 -16.969709 0 6.2430923 3.7096833 0.30957174 0.30957174 8.6661712e-06 2.5097825e-05 -0.0018558905 -0.00036893321 0.0021550188 0.0061274721 -18.70076 0 0.87885 3.1751572 0.30957174 0.30957174 1.618001e-06 4.1924287e-05 -0.0070427799 0.0013487755 0.0015555476 -0.0037973785 -13.914761 0 2.9954029 0.765943 0.30957174 0.30957174 2.2016757e-05 1.6742938e-05 --0.0022413579 0.0013480177 -0.0029248313 -0.00049558109 -22.835638 0 3.6964324 5.2532022 0.30957174 0.30957174 1.7104606e-05 8.8679883e-06 --0.013294272 -0.0031832699 0.011105932 0.0012871588 15.051479 0 6.2276178 2.0595553 0.30957174 0.30957174 0.00011170893 0.00012599056 --0.0058827221 0.0018535632 0.0044285514 0.0014852455 21.187624 0 3.8511446 2.266248 0.30957174 0.30957174 3.5096044e-05 2.1960058e-05 --0.010335859 -0.0018219777 -0.014223643 0.0012827058 20.448493 0 6.1005047 4.9974746 0.30957174 0.30957174 4.1966985e-05 0.00020559325 --0.019377616 0.0034336704 0.0027552231 -0.0018203802 23.525338 0 4.0705395 1.3649631 0.30957174 0.30957174 0.00014862078 1.0940126e-05 -0.010195217 -0.0003778014 0.0074759156 0.0027450009 -22.243579 0 1.6195435 2.2943744 0.30957174 0.30957174 1.2710706e-05 6.3819015e-05 -0.013457655 0.00086337546 -0.015091667 0.0017940426 4.8273825 0 2.4739753 4.9693161 0.30957174 0.30957174 2.6671831e-05 0.00023280763 --0.020010125 0.0049519796 0.0033472036 0.00010612248 -13.2109 0 3.933404 1.9765347 0.30957174 0.30957174 0.00026733633 1.1306274e-05 -0.0048662408 0.00039795593 -0.0021302733 -0.0033467124 -13.13398 0 2.5853611 6.086956 0.30957174 0.30957174 4.0421942e-06 1.5684976e-05 -0.0032653925 1.7164269e-05 -0.0049273851 0.002087069 -20.62922 0 1.9929427 4.688942 0.30957174 0.30957174 1.1732126e-06 2.8797678e-05 -0.0077025718 -0.0010264468 6.6233555e-05 0.00052405354 9.4695248 0 1.0633733 3.3891586 0.30957174 0.30957174 1.6110602e-05 2.7683412e-07 --0.0059932814 0.0015393609 0.0048140082 0.00065643327 3.9056746 0 3.9197955 2.0795371 0.30957174 0.30957174 2.5528995e-05 2.379101e-05 --0.011453789 -0.0032762648 0.00049571937 -0.0039840471 -22.838381 0 0.0078550093 0.49908884 0.30957174 0.30957174 0.0001121808 1.5992028e-05 --0.0012182408 -0.00025881959 0.0013504848 -0.0035327429 8.8156629 0 6.1805591 0.74215114 0.30957174 0.30957174 7.731363e-07 1.4218035e-05 --0.0082618221 -0.0015070802 0.00079469813 0.0001774728 21.704013 0 6.115745 2.1630918 0.30957174 0.30957174 2.8183168e-05 6.6793526e-07 -0.0056095248 0.002240611 -0.003903946 0.001330327 18.283151 0 3.2476808 4.7607362 0.30957174 0.30957174 4.9186475e-05 1.7120494e-05 --0.0033159775 0.0033357582 -0.0065488339 -0.00059314351 23.260396 0 3.6245888 5.1762887 0.30957174 0.30957174 0.00010256968 4.3585807e-05 --0.00088779187 -0.0020514516 -0.0054045302 -0.00072292781 -9.800178 0 0.32682857 5.2186005 0.30957174 0.30957174 3.8422915e-05 2.996545e-05 -0.012392932 -0.0017929147 0.001220568 -0.0046275962 7.3169923 0 1.0234079 0.63419483 0.30957174 0.30957174 4.6142558e-05 2.2743422e-05 --0.0093957199 0.0005116993 -0.0050378179 -0.0016991663 2.3713255 0 4.6261627 5.4095389 0.30957174 0.30957174 1.2076228e-05 2.8450319e-05 -0.0081804408 0.00061798576 -0.0035676259 0.000517598 -2.3042054 0 2.547833 4.9437617 0.30957174 0.30957174 1.0825163e-05 1.3097451e-05 -0.0097410769 0.0026189677 0.00039957578 0.0032027285 22.965215 0 3.1282448 3.3907719 0.30957174 0.30957174 7.2897725e-05 1.0335491e-05 -0.013834204 0.00078776486 0.010003345 0.0084230598 -4.1683747 0 2.423606 2.6409448 0.30957174 0.30957174 2.666273e-05 0.00017125689 -0.0073932123 0.0020186136 0.0001474246 -0.0031019761 13.391476 0 3.1336116 0.4221771 0.30957174 0.30957174 4.3119261e-05 9.5663626e-06 -0.020318644 -0.00022295062 0.00080431116 0.0053648943 4.9689257 0 1.8454729 3.365885 0.30957174 0.30957174 4.5773934e-05 2.9201553e-05 --0.00082804524 -0.00088751573 0.0023758694 0.00019743869 -15.479016 0 0.27223509 2.0273404 0.30957174 0.30957174 7.2505815e-06 5.7294369e-06 -0.026355009 0.00065577685 -0.0053723941 -0.010640353 -9.1861413 0 2.1679938 6.1866453 0.30957174 0.30957174 8.0167044e-05 0.00014139956 -0.0039352618 0.0040704722 0.00026567382 -0.0028623793 -9.6042622 0 3.4101582 0.46760094 0.30957174 0.30957174 0.00015263097 8.1981239e-06 --0.014551558 -0.00056553015 -0.0015851558 0.0033530367 15.491706 0 5.426946 3.9606508 0.30957174 0.30957174 2.6158442e-05 1.3685149e-05 -0.01598731 -0.00031423548 -0.0013052638 0.0007851029 -21.358526 0 1.7679263 4.5487541 0.30957174 0.30957174 2.8957846e-05 2.3290045e-06 -0.014724751 -0.00229823 0.0015442538 0.0034935996 -21.594763 0 0.98726486 3.0966816 0.30957174 0.30957174 7.1916121e-05 1.4510708e-05 -0.0048825909 -0.00077411651 0.0029473526 -0.00060776208 4.2351066 0 0.97990549 1.7433407 0.30957174 0.30957174 8.075902e-06 9.1240888e-06 -0.01435394 -0.0020269573 -8.3156273e-05 0.0067913622 -14.402257 0 1.0351006 3.5282365 0.30957174 0.30957174 6.0044354e-05 4.5756631e-05 -0.0024751112 -0.0015704354 -0.0095293512 0.0051900978 3.9972195 0 0.54562013 4.5913706 0.30957174 0.30957174 2.3138672e-05 0.00011826809 -0.021958353 0.0053680968 0.0024893999 -0.0039300861 -8.8174992 0 3.0938327 0.94260879 0.30957174 0.30957174 0.00031543111 2.1568315e-05 --0.010923068 -0.0012466691 -0.0048143802 0.0043269186 -1.0517096 0 5.8915338 4.3586004 0.30957174 0.30957174 2.7255514e-05 4.193804e-05 --0.023883842 -0.00075359171 -0.00014712087 -0.0004592308 -15.1073 0 5.3665674 0.0619008 0.30957174 0.30957174 6.7794179e-05 2.3100867e-07 -0.012210397 0.00045188354 0.010662736 0.0029894737 10.129175 0 2.2702519 2.2163421 0.30957174 0.30957174 1.8227192e-05 0.00012348543 -0.0061453173 -0.00087318279 -0.00603246 0.0022616396 7.4761825 0 1.0321045 4.7306566 0.30957174 0.30957174 1.1091148e-05 4.1760876e-05 -0.016027883 0.0030594642 0.0035990799 -0.00024096574 -0.6506144 0 2.9939847 1.8787833 0.30957174 0.30957174 0.00011346764 1.3116565e-05 --0.022579186 0.000786885 -0.00030832545 -0.00023279619 17.197452 0 4.7792903 5.7295045 0.30957174 0.30957174 6.1606885e-05 1.4959539e-07 -0.00025108739 0.001450807 0.0066058886 0.0010159207 0.93272394 0 3.4968964 2.0964762 0.30957174 0.30957174 1.918071e-05 4.501724e-05 -0.025758203 0.0015156898 -0.0053873174 0.0025525899 20.680973 0 2.4371456 4.6473419 0.30957174 0.30957174 9.3762506e-05 3.572281e-05 --0.007733249 -0.0017652096 0.0048328017 -0.0064887827 2.8775825 0 6.2092144 1.0183545 0.30957174 0.30957174 3.4949508e-05 6.5310216e-05 --0.0032569132 0.00090690887 0.0034465582 -0.0030467734 11.425011 0 3.8914186 1.225216 0.30957174 0.30957174 8.6567715e-06 2.1183365e-05 --0.0082169783 -0.0023265433 -0.004106569 0.0036609104 -22.759811 0 0.004429271 4.362634 0.30957174 0.30957174 5.6719272e-05 3.0295276e-05 -0.021710425 0.00059843075 0.00024628324 0.0048530493 17.5451 0 2.1911035 3.4647757 0.30957174 0.30957174 5.5004815e-05 2.3422798e-05 --0.0061342207 -0.00081724364 -0.0021285725 -0.0056132485 -1.3599174 0 5.9682899 0.0091482351 0.30957174 0.30957174 1.0214797e-05 3.582154e-05 --0.0089663347 -0.00020492511 0.0033877865 0.00061983364 -2.1718924 0 5.2919514 2.1246245 0.30957174 0.30957174 9.2080807e-06 1.1951743e-05 -0.038419849 0.0017765608 0.0033373133 -6.7333073e-06 -21.038398 0 2.3437646 1.9430953 0.30957174 0.30957174 0.00019079088 1.1228497e-05 -0.013614736 -5.6521928e-05 0.0022031687 0.0037767353 19.191045 0 1.9072968 2.9842634 0.30957174 0.30957174 2.037748e-05 1.9041916e-05 -0.0013331653 0.00012195691 0.0052985308 0.009032929 -18.63801 0 2.6398262 2.9818497 0.30957174 0.30957174 3.305981e-07 0.00010923733 --0.0077816852 -0.0017650433 0.0033062384 -0.007264086 23.811926 0 6.2067339 0.80449675 0.30957174 0.30957174 3.5026656e-05 6.3360601e-05 -0.0098631282 -0.0011045588 -0.00058714272 -0.010798893 -9.5770958 0 1.1497256 0.31954121 0.30957174 0.30957174 2.1793146e-05 0.0001160207 -0.013169749 0.0009561132 0.0086336151 0.0059186859 -2.768428 0 2.5293979 2.5422709 0.30957174 0.30957174 2.7367333e-05 0.00010989453 --0.0094283636 -0.00080078417 0.001109851 -0.0063498887 -20.681884 0 5.7451813 0.54871734 0.30957174 0.30957174 1.5599957e-05 4.1236866e-05 -0.0068048861 -0.00076643532 -0.0042857408 -0.0035339673 24.283037 0 1.1468706 5.7722618 0.30957174 0.30957174 1.0434444e-05 3.0905244e-05 --0.00092672454 0.0005273891 -0.0044746019 -0.0052902752 -10.90047 0 3.7064517 5.9514195 0.30957174 0.30957174 2.6279538e-06 4.794599e-05 -0.017455217 -0.0006371127 -0.010293965 -0.013169593 23.375122 0 1.6241045 5.9900934 0.30957174 0.30957174 3.7144971e-05 0.00027886532 --0.0010719694 -0.00070804363 0.010194669 -0.0062937656 -18.258532 0 0.20960468 1.3956336 0.30957174 0.30957174 4.6929122e-06 0.0001440697 diff --git a/examples/Diagnostics/Tunes/outputs/test_tune_4d_uncoupled/bunch.dat b/examples/Diagnostics/Tunes/outputs/test_tune_4d_uncoupled/bunch.dat deleted file mode 100644 index c1a734c5..00000000 --- a/examples/Diagnostics/Tunes/outputs/test_tune_4d_uncoupled/bunch.dat +++ /dev/null @@ -1,1015 +0,0 @@ -% PARTICLE_ATTRIBUTES_CONTROLLERS_NAMES ParticlePhaseAttributes -% PARTICLE_ATTRIBUTES_CONTROLLER_DICT ParticlePhaseAttributes size 6 xAction 0 xLastPhase 0 xLastTune 0 yAction 0 yLastPhase 0 yLastTune 0 -% BUNCH_ATTRIBUTE_DOUBLE charge 1 -% BUNCH_ATTRIBUTE_DOUBLE classical_radius 1.5347e-18 -% BUNCH_ATTRIBUTE_DOUBLE macro_size 0 -% BUNCH_ATTRIBUTE_DOUBLE mass 0.938272 -% SYNC_PART_COORDS 0 0 0 x, y, z positions in [m] -% SYNC_PART_MOMENTUM 0 0 1.6960377525279 px, py, pz momentum component in GeV/c -% SYNC_PART_X_AXIS 1 0 0 nxx, nxy, pxz - x-axis ort coordinates -% info only: energy of the synchronous particle [GeV] = 1 -% info only: momentum of the synchronous particle [GeV/c] = 1.6960377525279 -% info only: beta=v/c of the synchronous particle = 0.8750256554045 -% info only: gamma=1/sqrt(1-(v/c)**2) of the synchronous particle = 2.0657889919897 -% SYNC_PART_TIME 1.9060246584653e-07 time in [sec] -% x[m] px[rad] y[m] py[rad] z[m] (pz or dE [GeV]) PhaseVars --0.0065531414 -0.0024538659 -0.0039554139 -0.0024547054 -15.578108 0 0.089127141 5.6384829 0.30957174 0.30957174 5.9565954e-05 2.1749693e-05 -0.0067244185 0.0015019813 0.0001870957 0.0030399609 11.339613 0 3.0590884 3.4539252 0.30957174 0.30957174 2.5514154e-05 9.201928e-06 --0.020130179 -0.0021668843 -0.0045131537 -0.00091774902 10.998651 0 5.8622753 5.2857242 0.30957174 0.30957174 8.7256338e-05 2.1370049e-05 --0.02147704 0.00053907159 0.0044073995 0.0046012529 -12.389897 0 4.8619087 2.7479537 0.30957174 0.30957174 5.328326e-05 4.0583858e-05 --0.0056441714 -0.0031942063 0.0014449309 0.0043188522 0.82244228 0 0.18270342 3.1905848 0.30957174 0.30957174 9.643968e-05 2.0606507e-05 --0.0045869272 -0.0015149463 -0.003128741 -0.0071240879 21.728024 0 0.053407227 6.2406705 0.30957174 0.30957174 2.3216284e-05 6.0211068e-05 -0.0004646444 -0.00041465876 0.0013024706 -0.0032995213 -0.15138849 0 0.49669562 0.75304955 0.30957174 0.30957174 1.5899836e-06 1.250907e-05 --0.0026087612 0.0011855278 -0.0019262376 -4.5620885e-05 11.763354 0 3.7529171 5.1101774 0.30957174 0.30957174 1.3550114e-05 3.742702e-06 -0.011703034 0.0010136363 0.0046197826 -0.0048363974 -20.392113 0 2.6130889 1.140851 0.30957174 0.30957174 2.4394673e-05 4.4717976e-05 --0.031011777 0.00091308606 -0.0021205755 -0.0026887306 -1.0612575 0 4.8246473 5.9857277 0.30957174 0.30957174 0.00011317059 1.1704315e-05 --0.025561411 0.00093028768 -0.0076093943 -0.00035563125 -2.1948909 0 4.7665638 5.133014 0.30957174 0.30957174 7.9610296e-05 5.8500344e-05 --0.00096168216 0.0010037899 -0.0022658996 0.0054457754 17.835121 0 3.6206797 3.9130752 0.30957174 0.30957174 9.2800793e-06 3.4592826e-05 -0.031754674 0.0002561193 -0.0063042394 -0.0032101638 0.98805445 0 2.0184371 5.5544004 0.30957174 0.30957174 0.00011129221 5.0289239e-05 --0.036882645 0.00073076145 0.0061171183 -0.0018738756 10.010427 0 4.9081261 1.6501059 0.30957174 0.30957174 0.0001541974 4.1207187e-05 -0.030752874 0.00045081675 -0.0060041739 0.0079291025 10.954454 0 2.0778487 4.1679183 0.30957174 0.30957174 0.00010567176 9.8706278e-05 --0.01307366 0.0031049299 0.0029834187 0.00026619131 -6.7260973 0 3.9488694 2.0333687 0.30957174 0.30957174 0.00010658291 9.0436294e-06 --0.0022960788 -0.00017468141 -0.0010802472 -0.010458711 3.8422701 0 5.6927183 0.27054537 0.30957174 0.30957174 8.5670172e-07 0.0001096766 -0.015535593 0.00013911156 0.0055819355 -0.0078061018 19.674894 0 2.0264852 0.99891744 0.30957174 0.30957174 2.6671471e-05 9.1854508e-05 --0.0058679284 0.0043459207 0.00062431074 -0.0044971499 14.512262 0 3.6630441 0.51335237 0.30957174 0.30957174 0.00017582894 2.0453767e-05 -0.013932724 -0.00090658437 -0.00016331776 -0.0037608119 -21.13271 0 1.4100358 0.33054801 0.30957174 0.30957174 2.8796951e-05 1.4056232e-05 --0.034912173 -0.0011370673 0.0053607121 -0.0016367446 -19.491218 0 5.3751035 1.651024 0.30957174 0.30957174 0.00014558048 3.1628765e-05 -0.031320576 0.004865127 -0.001858321 -0.006815964 -9.2108194 0 2.9006716 0.10605962 0.30957174 0.30957174 0.0003233029 4.9563225e-05 -0.0068231751 0.00080941263 -0.0013557678 -0.0038948743 -7.2868164 0 2.7692224 0.036799139 0.30957174 0.30957174 1.1078744e-05 1.6900473e-05 --0.023319076 0.0027052731 0.0050568577 -0.00037462181 23.839278 0 4.2736874 1.8717455 0.30957174 0.30957174 0.00012636146 2.5919472e-05 -0.014222602 -0.00065967296 -0.0023834893 -0.0056231423 -1.8157145 0 1.5453358 6.2536458 0.30957174 0.30957174 2.6170069e-05 3.7091388e-05 -0.0086870504 -0.00094254511 0.0058864052 -0.0092961787 -19.666632 0 1.1655486 0.94245535 0.30957174 0.30957174 1.6376995e-05 0.00012065239 -0.00055711184 -0.0017053234 -0.0025458902 -0.00715952 1.5802735 0 0.41014794 0.030078698 0.30957174 0.30957174 2.6525304e-05 5.7378649e-05 -0.0074322187 0.0016282848 0.0015936596 0.0017753118 -22.600759 0 3.0513887 2.7803242 0.30957174 0.30957174 3.0215643e-05 5.686702e-06 --0.028081993 -0.00013466427 -0.00015393525 0.0015887185 -5.6512704 0 5.1303446 3.6132666 0.30957174 0.30957174 8.6735146e-05 2.5275068e-06 --0.018980004 0.001505113 -0.0070696351 -0.0040479532 21.403056 0 4.4611052 5.6032116 0.30957174 0.30957174 6.018219e-05 6.6640595e-05 --0.017785205 -0.002004791 0.0023713914 0.0074390016 -8.3107904 0 5.8853245 3.2049416 0.30957174 0.30957174 7.1336236e-05 6.0560622e-05 --0.0056875204 0.0016557158 -0.0036868103 -0.00023226966 10.137631 0 3.8764973 5.1490989 0.30957174 0.30957174 2.8523451e-05 1.3756887e-05 -0.0071094851 -0.002461612 -0.007578791 0.011159853 -17.669394 0 0.68132636 4.1162411 0.30957174 0.30957174 6.074723e-05 0.00018144158 --0.0011128757 0.00051022412 -0.004369446 8.6842962e-05 24.509149 0 3.7509085 5.0669775 0.30957174 0.30957174 2.5073898e-06 1.9255174e-05 -0.038045244 0.0017533594 0.00073972152 -0.002538738 -16.887285 0 2.3425684 0.66001231 0.30957174 0.30957174 0.00018690035 6.9447242e-06 -0.0016816339 0.0014499955 -0.006809468 0.0074207987 -1.6102069 0 3.3892602 4.2624034 0.30957174 0.30957174 1.9462783e-05 0.00010136982 --0.0093545698 -1.506727e-05 0.0039976694 0.0069525202 12.072819 0 5.1013605 2.9905464 0.30957174 0.30957174 9.6084307e-06 6.4058323e-05 --0.015576416 0.00029714147 0.0072713264 0.011790707 6.6672328 0 4.9146336 2.9596507 0.30957174 0.30957174 2.7438911e-05 0.00019119985 --0.011594328 -0.00052445256 0.00025985938 0.0041820982 -16.693002 0 5.4775397 3.453332 0.30957174 0.30957174 1.7262688e-05 1.7416601e-05 -0.0068907084 0.0021102997 0.0058266913 0.00077695611 -21.783984 0 3.1717084 2.0765994 0.30957174 0.30957174 4.5779792e-05 3.4825867e-05 --0.0069557323 -0.0022910858 0.0039337986 -0.0056646673 -12.399361 0 0.052595243 0.98509719 0.30957174 0.30957174 5.3127049e-05 4.7429911e-05 -0.0007079716 -0.0022917308 0.0073706264 0.0054041269 -10.069777 0 0.40820007 2.5738906 0.30957174 0.30957174 4.7897745e-05 8.3737431e-05 -0.028644041 -0.0018141606 0.0055198027 0.0013829772 -4.3901508 0 1.4218061 2.1886841 0.30957174 0.30957174 0.00012005053 3.2613753e-05 -0.0044039159 0.0014881764 0.0042203877 0.0021451289 16.963621 0 3.2017879 2.4120729 0.30957174 0.30957174 2.2303321e-05 2.2521239e-05 -0.0042003418 -0.0010951778 0.0028730238 -0.0030788409 -4.4689062 0 0.77280208 1.1291827 0.30957174 0.30957174 1.28627e-05 1.7724166e-05 -0.012046832 -0.0017393145 -0.0015065601 0.0080925765 14.291593 0 1.0243842 3.7014179 0.30957174 0.30957174 4.3489337e-05 6.7248479e-05 --0.0031030391 -0.0022950243 -0.00011010221 -0.00074264806 -15.898762 0 0.22694961 0.2259338 0.30957174 0.30957174 4.9037358e-05 5.5928789e-07 -0.0066578664 -0.00097966736 0.0061824864 -0.00022236048 -23.243868 0 1.0152684 1.9094363 0.30957174 0.30957174 1.3608812e-05 3.858377e-05 -0.019086738 -0.0006524921 0.0036423481 0.0014786035 21.724724 0 1.6432053 2.3278987 0.30957174 0.30957174 4.387043e-05 1.5543438e-05 -0.0049387976 0.00026410442 -0.008723031 0.0019343027 9.5993721 0 2.3983937 4.8701832 0.30957174 0.30957174 3.3130393e-06 8.0422822e-05 -0.0031607406 -0.0013167729 0.0016109654 -0.003477443 -12.292534 0 0.63194885 0.81123222 0.30957174 0.30957174 1.6891368e-05 1.4611195e-05 --0.011794882 0.000183652 -0.0047598537 -0.0035217929 13.429923 0 4.9457917 5.7198146 0.30957174 0.30957174 1.5579334e-05 3.5143632e-05 -0.014621092 -0.0029696475 -0.005918874 0.00023230545 -10.432857 0 0.86981146 5.047778 0.30957174 0.30957174 0.00010380155 3.5372181e-05 -0.011286783 0.0016250809 0.0058940602 0.012607273 13.54764 0 2.8644767 3.0754483 0.30957174 0.30957174 3.8041497e-05 0.00019268128 --0.011582495 -0.0010466926 -0.0026842104 0.0012610385 -21.3653 0 5.7754177 4.6506097 0.30957174 0.30957174 2.4706963e-05 8.8410787e-06 --0.0026006372 0.00064853394 0.002581573 -0.0082410838 -22.475123 0 3.9305744 0.68019789 0.30957174 0.30957174 4.5738262e-06 7.4085153e-05 -0.010381531 -0.0014392665 -0.0033752192 0.011113192 -9.6018191 0 1.0440391 3.8130176 0.30957174 0.30957174 3.070131e-05 0.00013398939 -0.020975984 -0.00082319282 -0.00027904187 0.00016977818 18.389754 0 1.6017619 4.5436907 0.30957174 0.30957174 5.4473924e-05 1.0709066e-07 --0.010430764 7.3559631e-05 -0.0073391503 -0.00036431797 19.850485 0 5.0225364 5.1358885 0.30957174 0.30957174 1.1993119e-05 5.4433862e-05 -0.010244227 0.0018632949 0.00097537519 5.5432149e-05 -14.830634 0 2.9728716 2.0014091 0.30957174 0.30957174 4.3147012e-05 9.6215989e-07 -0.015505623 -0.00064186126 -0.0046944561 -0.0033655587 -1.7122958 0 1.5844982 5.7048427 0.30957174 0.30957174 3.0145998e-05 3.3452963e-05 -0.041809595 0.0042244472 -0.015733972 2.2943842e-05 11.810633 0 2.6890756 5.0852428 0.30957174 0.30957174 0.00035446034 0.00024957642 --0.021654569 -6.7552775e-05 0.0055849337 0.0063709602 8.2915818 0 5.1150989 2.7921176 0.30957174 0.30957174 5.1518235e-05 7.1706686e-05 -0.022134535 0.0019956208 -0.0061833373 -0.0016104935 -4.3364492 0 2.6326848 5.3395121 0.30957174 0.30957174 9.0061994e-05 4.111805e-05 -0.018499269 -0.00070324916 -0.0031162043 0.0046862362 10.328685 0 1.6117283 4.1064689 0.30957174 0.30957174 4.2073335e-05 3.1573127e-05 -0.023918145 0.0013948532 0.00025016456 0.001517336 -0.25396261 0 2.4334217 3.3511838 0.30957174 0.30957174 8.0524312e-05 2.3467847e-06 -0.0044261035 0.0013671518 -0.0018968669 0.0033282369 23.654256 0 3.1744165 4.0374096 0.30957174 0.30957174 1.9176947e-05 1.4615027e-05 -0.0079253588 0.001446299 -0.0074431583 0.00052212604 16.308261 0 2.974334 5.01722 0.30957174 0.30957174 2.5950056e-05 5.6122631e-05 -0.0055796391 -0.0020457572 -0.0010331202 -0.0020050737 -16.851762 0 0.66521383 6.1783968 0.30957174 0.30957174 4.1541476e-05 5.063851e-06 -0.00016564096 0.00087936671 0.0030315673 -0.00028433139 18.945998 0 3.4952178 1.8523318 0.30957174 0.30957174 7.0471636e-06 9.345509e-06 --0.014158573 0.00012133334 -0.0014914195 -0.0058603387 -20.218616 0 5.0087835 0.12314928 0.30957174 0.30957174 2.2140572e-05 3.6308337e-05 --0.00092799732 0.001996267 0.0002340455 -0.0052605526 15.573462 0 3.5668803 0.41912357 0.30957174 0.30957174 3.6396152e-05 2.7504874e-05 -0.0029295689 -0.00019645597 0.0008118266 0.0017193858 8.8017048 0 1.3967214 3.071621 0.30957174 0.30957174 1.2937231e-06 3.5968185e-06 --0.00087612484 -0.0016070374 0.0078298682 0.0066328765 8.6875137 0 0.31452334 2.6439177 0.30957174 0.30957174 2.3609861e-05 0.00010544591 --0.018462703 -0.00051404789 0.00074975316 -0.0038302796 -7.685929 0 5.3350794 0.56913624 0.30957174 0.30957174 3.9826949e-05 1.5119126e-05 --0.033194976 0.005710137 -0.0049980945 0.0023579794 11.948636 0 4.0839076 4.6489998 0.30957174 0.30957174 0.00041798126 3.0699697e-05 --0.0030112848 -0.00024264511 0.0037691056 0.0072442276 6.9390765 0 5.719885 3.0328127 0.30957174 0.30957174 1.5317694e-06 6.637646e-05 --0.0011719289 -0.00078697992 0.003854556 0.0024900366 18.886698 0 0.21225947 2.5149593 0.30957174 0.30957174 5.7925473e-06 2.1128865e-05 -0.034388639 0.002280395 0.0058846119 0.0019411462 24.008331 0 2.4884998 2.2613178 0.30957174 0.30957174 0.0001771905 3.8648523e-05 -0.00075697382 -3.5073931e-05 -0.0057149455 0.0048477741 22.328976 0 1.5457039 4.3872071 0.30957174 0.30957174 7.4109425e-08 5.6237732e-05 -0.0064411086 -0.0014158339 -0.0044662226 -0.0082023711 -18.089897 0 0.83747799 6.1554546 0.30957174 0.30957174 2.2814941e-05 8.6844632e-05 --0.002471486 -0.0022408433 0.0019765549 0.0023575407 2.6629438 0 0.25381077 2.8141738 0.30957174 0.30957174 4.6412174e-05 9.4516734e-06 -0.017254978 0.0003193331 -0.004250782 0.0017784013 7.1761349 0 2.1121109 4.6933298 0.30957174 0.30957174 3.361329e-05 2.1353581e-05 --0.0088620786 0.0012062984 -0.0023200407 -0.0028312376 -20.439627 0 4.194571 5.9670171 0.30957174 0.30957174 2.1877057e-05 1.3377557e-05 --0.0083244818 5.7702594e-05 0.0047380741 0.00070168214 -4.7756439 0 5.0236297 2.0909504 0.30957174 0.30957174 7.6375465e-06 2.3120725e-05 -0.0058376073 -3.610965e-05 -0.0020621022 0.0097254168 18.842584 0 1.8888083 3.7264842 0.30957174 0.30957174 3.7528207e-06 9.8105869e-05 --0.017806352 -0.0024484373 -0.0063183978 0.0055422121 0.022346617 0 5.9837471 4.3706628 0.30957174 0.30957174 8.9415873e-05 7.0715336e-05 --0.0040601306 0.0017824173 -0.0034370004 0.0040124523 19.057965 0 3.7609268 4.2282103 0.30957174 0.30957174 3.0750231e-05 2.7878861e-05 -0.0046630021 0.0037083975 -0.0070915515 -0.0086539388 9.1830694 0 3.3787243 5.9670079 0.30957174 0.30957174 0.00012766103 0.00012498516 -0.0067857929 0.00035468944 -0.00597157 0.0075058227 -3.5325348 0 2.3894761 4.1918991 0.30957174 0.30957174 6.2009012e-06 9.1832176e-05 -0.013343619 0.00014922433 -0.0029108017 -0.0032969489 -14.230386 0 2.0466183 5.9301813 0.30957174 0.30957174 1.9748879e-05 1.9323814e-05 --0.024553261 -0.0027332548 -0.00036759548 -0.0061435721 -14.000384 0 5.8790636 0.31405136 0.30957174 0.30957174 0.00013423371 3.7574517e-05 --0.0047776405 0.0014819187 0.00073298825 0.0017123914 -22.541451 0 3.8560523 3.1084969 0.30957174 0.30957174 2.2510702e-05 3.4502256e-06 --0.026713266 0.00191441 0.0015113932 0.0023124905 5.4989476 0 4.5083308 2.9332824 0.30957174 0.30957174 0.00011172226 7.6073028e-06 -0.010495151 -0.00040247712 -0.010290458 0.0080172416 23.729418 0 1.609015 4.4287582 0.30957174 0.30957174 1.3567347e-05 0.00017051319 --0.0018685172 -0.0031604437 -0.0077319204 -0.0058799409 15.369712 0 0.30948883 5.7329539 0.30957174 0.30957174 9.1371406e-05 9.4564075e-05 --0.040580751 0.0025793289 0.0074306027 -0.0019500104 15.004581 0 4.5618573 1.6904404 0.30957174 0.30957174 0.00024138458 5.9435742e-05 -0.010066628 -0.0024914206 -0.0033261502 0.0059914338 -0.96646623 0 0.79178234 4.0261349 0.30957174 0.30957174 6.7667982e-05 4.6760479e-05 --0.0027983167 0.0019129271 0.00032874895 0.0019849328 5.3976481 0 3.6751203 3.3504469 0.30957174 0.30957174 3.4193469e-05 4.0170572e-06 -0.0091100956 -0.00045031031 0.0043575461 -0.0010121052 19.555325 0 1.5220142 1.7186608 0.30957174 0.30957174 1.0958008e-05 2.015907e-05 --0.013004534 -0.0025198802 0.0067115715 -0.0069680488 7.897808 0 6.1420367 1.1450089 0.30957174 0.30957174 7.6407943e-05 9.3573496e-05 -0.0040365862 -0.0013369206 0.0013728399 -0.0030568963 2.4040119 0 0.69435621 0.79944448 0.30957174 0.30957174 1.8070414e-05 1.1169109e-05 --0.0009657902 4.7548911e-05 -0.0070432019 0.0033579208 24.237712 0 4.6650972 4.6449512 0.30957174 0.30957174 1.2298995e-07 6.1195534e-05 --0.027149451 0.00096588737 0.016302328 0.006645286 -3.902847 0 4.7732884 2.3293319 0.30957174 0.30957174 8.9414309e-05 0.00031173513 -0.0071708731 0.0014030395 -0.0043032894 0.010186576 -24.231125 0 3.0045939 3.9185178 0.30957174 0.30957174 2.3576878e-05 0.00012159656 --0.0084205776 0.00013513635 -0.00058066244 0.00074975135 3.2289706 0 4.9415271 4.1788081 0.30957174 0.30957174 7.9502155e-06 8.9749919e-07 -0.012156542 0.0049596989 0.0087510769 -0.00083959577 -12.314551 0 3.2530476 1.8502161 0.30957174 0.30957174 0.00024030105 7.7904843e-05 -0.0062433181 -0.0013535104 0.00056957172 0.00037774645 -8.5296565 0 0.84302833 2.5269696 0.30957174 0.30957174 2.0967289e-05 4.6859507e-07 -0.017481646 0.0031230827 0.0021616909 -0.0049714224 13.889274 0 2.9648918 0.78743904 0.30957174 0.30957174 0.00012239836 2.9226198e-05 --0.01304874 0.0015822308 0.0027577039 -0.0043066542 -14.334919 0 4.2516486 0.94754468 0.30957174 0.30957174 4.1496595e-05 2.6064225e-05 --0.00042382219 -0.00077313814 -0.0020712648 0.011479532 19.846054 0 0.31419473 3.6958275 0.30957174 0.30957174 5.464781e-06 0.00013503922 --0.039444251 -2.1466408e-05 0.0014052377 0.01268929 10.632501 0 5.0916467 3.4047086 0.30957174 0.30957174 0.00017080061 0.0001617069 --0.004841251 0.0044583764 0.00012848023 0.0094743369 13.835906 0 3.6345374 3.5022224 0.30957174 0.30957174 0.0001836411 8.9053889e-05 -0.018911202 -0.00061318542 0.0051921396 -0.0014967804 -23.527593 0 1.6578961 1.6665816 0.30957174 0.30957174 4.268503e-05 2.9400309e-05 --0.030168934 -0.0020252106 -0.002153421 0.005672987 -14.302048 0 5.6355242 3.8813853 0.30957174 0.30957174 0.00013727704 3.6597579e-05 --0.016348223 -0.0030062645 0.006317731 0.0030319675 -16.900427 0 6.1192948 2.3893878 0.30957174 0.30957174 0.00011166662 4.9357588e-05 -0.015865557 0.00068838178 0.0012482855 -0.007627867 -9.4404975 0 2.3214942 0.53780943 0.30957174 0.30957174 3.1949272e-05 5.9284804e-05 --0.030119676 0.0012853838 -0.0015995219 0.005883607 -20.332103 0 4.715918 3.7834007 0.30957174 0.30957174 0.00011463975 3.691625e-05 --0.012273872 0.00042686376 0.0046139843 0.0024257192 -24.080106 0 4.7798843 2.425781 0.30957174 0.30957174 1.819752e-05 2.7298929e-05 --0.0011933209 0.0010923206 0.0013872278 0.0044932826 10.243554 0 3.6352503 3.2141469 0.30957174 0.30957174 1.1025306e-05 2.1966426e-05 --0.0071551576 0.0026117035 0.0099984998 -0.0013670798 13.735951 0 3.8080383 1.8102961 0.30957174 0.30957174 6.775519e-05 0.00010263873 -0.0007797964 4.1762765e-05 0.0066331413 -0.0049213406 -11.342576 0 2.3989865 1.3106593 0.30957174 0.30957174 8.2641385e-08 6.8380988e-05 -0.015168849 -0.0036163919 -0.015545706 0.0048334156 2.0605114 0 0.80581561 4.7875418 0.30957174 0.30957174 0.0001443941 0.00026681202 --0.020626581 0.0026996177 -0.0078511519 0.00026275482 11.707855 0 4.2138237 5.053505 0.30957174 0.30957174 0.00011309381 6.2211549e-05 --0.012434667 -0.0025854074 0.0046683541 -0.0013209811 9.6038233 0 6.1717063 1.6714602 0.30957174 0.30957174 7.7863914e-05 2.3702067e-05 -0.0034361663 0.00048428957 -0.0024290981 -0.0077813852 20.687445 0 2.8541524 0.069400973 0.30957174 0.30957174 3.4326435e-06 6.6008973e-05 -0.020917883 0.00054671247 0.0060966696 0.0026481694 -16.839446 0 2.178829 2.3519127 0.30957174 0.30957174 5.0756528e-05 4.4428474e-05 --0.014105435 0.0013579749 -0.0045370967 0.0098359332 2.8896722 0 4.3667341 3.9511818 0.30957174 0.30957174 3.8640157e-05 0.00011671636 -0.0095692345 -0.001385253 1.689435e-05 -0.0064817645 0.68466562 0 1.0231126 0.37692795 0.30957174 0.30957174 2.7532526e-05 4.1673845e-05 -0.028482951 -0.0029262154 -0.0061066344 0.00032048415 4.1478359 0 1.1928199 5.0346792 0.30957174 0.30957174 0.00016706091 3.7696851e-05 --0.0068944566 -0.00041495009 -0.0035775301 -0.008449912 -1.5144286 0 5.5881936 6.2540642 0.30957174 0.30957174 6.7865734e-06 8.3726727e-05 -0.0015986257 0.0033596995 0.0043688882 0.012922173 -6.2664881 0 3.4637058 3.1873941 0.30957174 0.30957174 0.00010310337 0.00018487513 -0.0093903958 0.00066918055 0.007404215 0.0058613577 9.8076183 0 2.5208772 2.6107623 0.30957174 0.30957174 1.3759287e-05 8.9347019e-05 -0.013095252 0.00096793668 -0.0003865677 0.004965771 -20.443123 0 2.5376915 3.5942134 0.30957174 0.30957174 2.7359765e-05 2.4610146e-05 --0.018097522 0.00085297436 0.0027169089 -5.043951e-06 -9.7010187 0 4.6811448 1.9432551 0.30957174 0.30957174 4.258186e-05 7.4417925e-06 --0.00089126407 -0.00041239043 -0.0063135767 0.0059281163 5.4048295 0 0.14135561 4.3368184 0.30957174 0.30957174 1.6363956e-06 7.5044595e-05 --0.0094484552 0.0012985887 0.0027381376 -0.0060567833 -10.195648 0 4.1898596 0.80193645 0.30957174 0.30957174 2.5161594e-05 4.3946512e-05 -0.0295688 0.0033481194 0.0034380688 -0.0047797271 -2.3082346 0 2.7459839 1.0017172 0.30957174 0.30957174 0.00019809479 3.4577737e-05 --0.0071938402 0.0011590448 -0.0002701563 -0.0015816127 -23.212166 0 4.1139939 0.20376971 0.30957174 0.30957174 1.7918505e-05 2.5548512e-06 -0.020270098 -0.0018033112 -0.0073126633 -0.0036759418 11.427292 0 1.2640417 5.5492299 0.30957174 0.30957174 7.4727896e-05 6.7314249e-05 -0.013108084 0.0025961196 0.0022355745 -0.0011296176 -6.397717 0 3.0097729 1.4804846 0.30957174 0.30957174 8.0257799e-05 6.3042525e-06 -0.0023698168 0.0011974175 -0.0020206087 -0.00077544419 -12.197719 0 3.3019573 5.4504168 0.30957174 0.30957174 1.3677615e-05 4.7125935e-06 -0.010526649 -8.6129268e-05 0.002341865 0.00012060355 -16.727804 0 1.870701 1.9961348 0.30957174 0.30957174 1.2232001e-05 5.5434663e-06 --0.02549516 -0.0010780839 0.00065798676 0.002424879 20.659739 0 5.4543701 3.2488657 0.30957174 0.30957174 8.1942904e-05 6.2689687e-06 --0.017553557 0.00018912499 0.0027827393 0.0076782741 18.696349 0 4.9888566 3.1655902 0.30957174 0.30957174 3.4151121e-05 6.6285946e-05 -0.0031311425 0.0029821731 0.0052735078 0.0025281534 -13.543929 0 3.4011386 2.3889773 0.30957174 0.30957174 8.2089193e-05 3.4376463e-05 --0.016676039 0.0046188114 -0.00086977661 -0.0012186174 5.9375906 0 3.893245 6.0337532 0.30957174 0.30957174 0.00022486206 2.235699e-06 -0.0017097511 0.001060044 0.0011805215 0.00071869541 24.001766 0 3.3406492 2.4883585 0.30957174 0.30957174 1.0557052e-05 1.9173381e-06 -0.030824147 0.0027037329 -0.00086038704 -0.0058385548 6.7624593 0 2.6192439 0.22681474 0.30957174 0.30957174 0.00017089331 3.4559386e-05 --0.0019297784 -1.2229486e-05 -0.0015322089 -0.004697676 18.710951 0 5.1443536 0.056615414 0.30957174 0.30957174 4.1017682e-07 2.4256521e-05 --0.0092209776 0.00079208286 -0.0020829794 -0.0037514382 -8.8680438 0 4.4227128 6.147169 0.30957174 0.30957174 1.5049125e-05 1.8333666e-05 -0.010693223 -0.0027477108 -0.0071091333 -0.0055542349 15.13882 0 0.77804758 5.745977 0.30957174 0.30957174 8.1327468e-05 8.1551846e-05 --0.0032482678 0.00019394049 -0.0049486583 -0.0036129771 -15.124172 0 4.5885547 5.7134655 0.30957174 0.30957174 1.500914e-06 3.7636904e-05 -0.0040024332 -0.0028459587 -0.011786092 0.0022910193 2.2549016 0 0.52747655 4.8962151 0.30957174 0.30957174 7.553979e-05 0.00014525067 --0.0050710684 -0.00047185144 -0.0044742437 -0.0014342245 16.77636 0 5.7897923 5.39454 0.30957174 0.30957174 4.8511422e-06 2.2222413e-05 -0.01701157 0.0017754342 -8.7868829e-05 -0.0089361372 -7.4403968 0 2.7052333 0.36438746 0.30957174 0.30957174 6.0483022e-05 7.9216638e-05 -0.013320325 0.0012997079 -0.0013187731 0.0073584925 13.329603 0 2.671707 3.6946433 0.30957174 0.30957174 3.4865777e-05 5.5462922e-05 -0.016925059 0.0011624582 -0.0044933985 -0.0047977183 -19.474158 0 2.5041677 5.9007779 0.30957174 0.30957174 4.3756041e-05 4.3187199e-05 -0.01252266 0.00084578827 -0.0040936873 -0.004770801 18.873921 0 2.4966561 5.9443096 0.30957174 0.30957174 2.3731364e-05 3.9471389e-05 --0.012819144 0.0030682137 0.0050798869 0.0035303951 15.780689 0 3.9459198 2.5486429 0.30957174 0.30957174 0.00010379479 3.8378519e-05 -0.0082542992 -0.00085957506 -0.0043740293 0.0033807337 4.0930086 0 1.1860597 4.4326101 0.30957174 0.30957174 1.4210125e-05 3.0625038e-05 --0.0045317837 -0.0029001698 -0.006321193 0.00013696973 -21.551156 0 0.20441694 5.0651994 0.30957174 0.30957174 7.8873327e-05 4.0301815e-05 --0.024887245 0.0020585991 -0.0080263036 0.0055903471 -16.118418 0 4.4409515 4.4821161 0.30957174 0.30957174 0.00010659711 9.5945982e-05 --0.0099539511 -0.0036669441 -0.0076233601 -0.0058530641 -1.7771606 0 0.084687992 5.7375553 0.30957174 0.30957174 0.00013336588 9.2570715e-05 --0.0081529089 -5.1713635e-05 0.00057581573 0.00037749637 19.552854 0 5.1444056 2.5216717 0.30957174 0.30957174 7.3212296e-06 4.7561783e-07 -0.0019726997 -0.0002734071 0.005857485 -0.00820903 -1.2285923 0 1.044186 0.99790059 0.30957174 0.30957174 1.1081411e-06 0.0001014331 -0.0019162358 0.00037713247 0.0016470283 0.0086444058 -17.896439 0 3.0070929 3.3261201 0.30957174 0.30957174 1.6987133e-06 7.6856345e-05 --0.0064344813 0.0010206272 0.0013439564 0.0034295106 12.204592 0 4.1212852 3.1396399 0.30957174 0.30957174 1.4034102e-05 1.3487383e-05 -0.00043602159 -0.0017958076 -7.7090908e-05 -0.00476901 -20.852495 0 0.40094778 0.35800497 0.30957174 0.30957174 2.9397928e-05 2.2565548e-05 -0.012293625 -0.0012714263 0.0050719633 -0.00091292129 -5.1999049 0 1.1894994 1.7684199 0.30957174 0.30957174 3.1316484e-05 2.6761201e-05 -0.017397383 -0.0015850472 0.0016861411 -0.0052627893 11.560161 0 1.252364 0.68672308 0.30957174 0.30957174 5.6112253e-05 3.0339245e-05 --0.012955623 0.0014968807 0.0027622492 -0.0043845949 1.6901121 0 4.2757233 0.94014747 0.30957174 0.30957174 3.8836808e-05 2.6761443e-05 -0.0094013772 0.0020595284 0.0025818863 0.00053158639 -19.978761 0 3.0513559 2.1465522 0.30957174 0.30957174 4.8341591e-05 7.0007768e-06 -0.0089340782 0.00018992787 0.0036694549 0.0056239711 11.296838 0 2.1363833 2.9340639 0.30957174 0.30957174 9.090752e-06 4.4947965e-05 --0.0042627565 0.0011053335 0.0026797257 0.0025188276 -2.2196194 0 3.9163726 2.6955035 0.30957174 0.30957174 1.312426e-05 1.3532659e-05 -0.01037583 0.00093299964 -0.0042385234 -0.00286417 -8.5366625 0 2.6313875 5.6771914 0.30957174 0.30957174 1.9747961e-05 2.6248665e-05 -0.014872145 -0.0023813497 -0.007510834 0.0035785165 23.242491 0 0.97528659 4.6452052 0.30957174 0.30957174 7.5938248e-05 6.9574725e-05 --0.025785586 8.8981052e-05 0.0050375241 -0.0011935944 23.530539 0 5.0552649 1.7142611 0.30957174 0.30957174 7.3062458e-05 2.6996661e-05 --0.023011002 0.0012219761 0.0025469138 -0.0032397101 -2.3470811 0 4.6361306 1.0444902 0.30957174 0.30957174 7.1729953e-05 1.6950503e-05 -0.0052459359 0.0022947159 0.0024774721 -0.00089124359 -24.317765 0 3.2700105 1.6023499 0.30957174 0.30957174 5.0988483e-05 6.975795e-06 --0.014620414 -0.00018968582 -0.00084095458 0.0078511685 11.767461 0 5.204329 3.6234613 0.30957174 0.30957174 2.3793308e-05 6.1855397e-05 --0.0098133911 -0.00094003494 0.01039642 -0.0027619866 21.178962 0 5.8041564 1.6874353 0.30957174 0.30957174 1.8621459e-05 0.00011653353 --0.0065405189 -0.00081270219 0.00625529 -0.0025881499 -9.1537174 0 5.9338781 1.5556499 0.30957174 0.30957174 1.0712688e-05 4.6091978e-05 --0.0098278853 -0.0011478624 -0.00082454866 0.00081689293 24.851444 0 5.9030586 4.3100141 0.30957174 0.30957174 2.2605473e-05 1.347341e-06 -0.0026259509 0.0013770346 0.0034045554 -0.002387066 -13.855488 0 3.3095325 1.3374177 0.30957174 0.30957174 1.8030401e-05 1.7337495e-05 --0.0024396063 0.00047727525 0.0049465625 0.0067353514 -20.361572 0 4.0272398 2.8785611 0.30957174 0.30957174 2.7283975e-06 6.9666085e-05 -0.017346787 -0.0004292625 -0.0028963252 -0.0054634289 22.875619 0 1.7233824 6.1666584 0.30957174 0.30957174 3.4711658e-05 3.8064782e-05 --0.010005291 0.0018270511 0.0085726134 6.9368966e-05 4.9191965 0 4.0571652 1.9531229 0.30957174 0.30957174 4.1397472e-05 7.4093545e-05 --0.016848109 0.0016331809 -0.0022046495 0.0013006173 6.5439954 0 4.3633335 4.5572435 0.30957174 0.30957174 5.5458421e-05 6.5780281e-06 -0.010486989 0.0019626083 -0.0020471726 -0.0003589527 -15.922661 0 2.9853982 5.2588897 0.30957174 0.30957174 4.7160721e-05 4.3528841e-06 -0.011150218 -0.001655241 -0.0053076396 0.00025882022 -14.468934 0 1.0110422 5.0383575 0.30957174 0.30957174 3.8606362e-05 2.8467129e-05 --0.0030465132 -0.0014443592 0.0063652456 -0.0023369077 19.86531 0 0.14676309 1.5958571 0.30957174 0.30957174 2.0022607e-05 4.6263612e-05 --0.012140351 0.0018411003 -0.0038962388 -0.0019482593 -6.8790692 0 4.142465 5.5471259 0.30957174 0.30957174 4.7057426e-05 1.9069449e-05 -0.0083720335 0.00085815892 0.0023443804 -0.0011446376 7.6949815 0 2.6962423 1.4940881 0.30957174 0.30957174 1.4402853e-05 6.840524e-06 --0.012216474 0.0021237893 0.0078272527 0.0010566207 13.054091 0 4.0791241 2.0782058 0.30957174 0.30957174 5.7471033e-05 6.287273e-05 -0.010865338 0.0015449754 0.0031211727 -0.0014972221 -19.54605 0 2.8584423 1.5009796 0.30957174 0.30957174 3.4703404e-05 1.204468e-05 --0.0071125759 -0.00051579294 -5.4578764e-05 -0.0025568463 -10.858152 0 5.6704786 0.35278346 0.30957174 0.30957174 7.9769595e-06 6.487605e-06 -0.013311499 0.00021761423 0.0077364911 -0.0051632493 22.696838 0 2.0929288 1.3603369 0.30957174 0.30957174 1.9883427e-05 8.6784786e-05 --0.0059431226 0.0036828078 -0.0016085026 0.00038318991 10.93206 0 3.6912262 4.8546443 0.30957174 0.30957174 0.00012742854 2.7540187e-06 --0.005173045 -0.0010634304 0.00010985101 -0.0097247848 4.021131 0 6.1670024 0.38568784 0.30957174 0.30957174 1.3239327e-05 9.3818913e-05 -0.013131171 0.0009405609 -0.0055229278 0.0025275331 12.968162 0 2.5232184 4.660561 0.30957174 0.30957174 2.6987244e-05 3.7088151e-05 -0.027502156 -0.00042470579 0.0069947979 -0.0072617744 3.3376434 0 1.8053409 1.1450312 0.30957174 0.30957174 8.4674977e-05 0.00010163301 --0.011487109 0.00042380962 -0.0013519233 -0.009836243 -7.2589703 0 4.7624645 0.23661352 0.30957174 0.30957174 1.6121655e-05 9.7811951e-05 -0.0040557346 0.00017378348 -0.00389906 -0.00080332507 7.3569343 0 2.3172357 5.2882779 0.30957174 0.30957174 2.0808294e-06 1.5966711e-05 -0.015386043 0.0001372912 -0.00081160191 6.9333009e-05 -22.850761 0 2.0262022 5.0021546 0.30957174 0.30957174 2.6159246e-05 6.6883541e-07 -0.026973089 -0.0021653264 0.000437436 -0.0079874229 15.48986 0 1.3136869 0.42945631 0.30957174 0.30957174 0.00012257856 6.3475965e-05 --0.0013259354 -0.0015975612 -0.0083571604 0.00021830351 -1.8635335 0 0.28343901 5.0607845 0.30957174 0.30957174 2.3441966e-05 7.0458739e-05 -0.008162438 -0.0032809413 0.0029379784 -0.0064060707 4.2496077 0 0.64090569 0.80738733 0.30957174 0.30957174 0.00010537251 4.9407998e-05 -0.017553464 0.0012875576 0.0044942505 0.0047507763 -4.2207382 0 2.5341451 2.7541811 0.30957174 0.30957174 4.8926503e-05 4.2750318e-05 -0.0244078 -0.00093240343 -0.0043102373 0.0038601209 15.134012 0 1.6102156 4.3603598 0.30957174 0.30957174 7.3318098e-05 3.350964e-05 -0.00088357374 0.0023474596 -0.003955744 -0.0033889969 13.284859 0 3.4745968 5.7910676 0.30957174 0.30957174 5.0283529e-05 2.7167901e-05 -0.0070746128 -8.4643718e-05 0.0098746793 0.007060881 8.1611374 0 1.8365366 2.5620152 0.30957174 0.30957174 5.5596192e-06 0.00014775708 -0.016975886 -0.0005379168 -0.0040583532 0.00048083073 10.310914 0 1.664085 4.9697046 0.30957174 0.30957174 3.4271451e-05 1.6833821e-05 -0.015286381 0.0026140691 0.00035948989 0.0037608882 -18.002877 0 2.9451999 3.4198239 0.30957174 0.30957174 8.7899591e-05 1.4160197e-05 -0.013921416 -0.0023785673 0.00077270608 -0.00046427257 -13.120129 0 0.94539146 1.4076371 0.30957174 0.30957174 7.2812471e-05 8.1574802e-07 --0.010096044 0.00090285448 -0.0054274628 -0.0065670216 10.866825 0 4.4030969 5.9628203 0.30957174 0.30957174 1.8615055e-05 7.2474545e-05 -0.036670871 -0.0010423778 0.0029121168 0.0052649176 -9.2364973 0 1.6917253 3.0072136 0.30957174 0.30957174 0.00015752073 3.6044777e-05 --0.020931067 0.00086541705 0.00023823683 0.0024292138 6.7937949 0 4.7264844 3.4173422 0.30957174 0.30957174 5.4916788e-05 5.9105839e-06 --0.039121989 0.0012841428 -0.0015863989 0.0022857809 -8.2330067 0 4.7961439 4.1264087 0.30957174 0.30957174 0.00018303855 7.7197241e-06 --0.011102685 -0.0025508726 0.0059830203 0.0088479847 24.955459 0 6.2117512 2.9175453 0.30957174 0.30957174 7.2806435e-05 0.00011374215 -0.0086941947 -0.00039445 -0.0017154031 0.0036775299 -4.6022163 0 1.553189 3.9554648 0.30957174 0.30957174 9.7152708e-06 1.6381466e-05 --0.028657489 -0.0010916049 -0.0054116951 0.0012749727 5.8663612 0 5.4206794 4.8571183 0.30957174 0.30957174 0.00010100929 3.1137592e-05 --0.009267806 0.00057070918 0.00033777126 0.0080844743 7.5868428 0 4.5754756 3.473797 0.30957174 0.30957174 1.2395996e-05 6.4945262e-05 -0.026600234 -0.00053652049 0.0012614135 0.013053033 10.41298 0 1.7633892 3.4187741 0.30957174 0.30957174 8.0297352e-05 0.00017060813 --0.009405454 -0.0013222178 -0.014401689 0.00011756091 -0.92862561 0 5.9945081 5.0785924 0.30957174 0.30957174 2.5636713e-05 0.0002091131 --0.0018683399 0.001906715 0.0015189872 0.0049147517 -15.162343 0 3.6230485 3.2138406 0.30957174 0.30957174 3.3500904e-05 2.6285603e-05 --0.017019767 -0.0022052201 -2.7787084e-05 0.004283682 -0.41471172 0 5.9545886 3.5224324 0.30957174 0.30957174 7.6098234e-05 1.8202334e-05 -0.0043557308 0.0018196992 0.0053295533 0.00045895031 10.045701 0 3.2589337 2.0303077 0.30957174 0.30957174 3.2246657e-05 2.8844615e-05 -0.0018533047 0.0020107617 -0.004185443 0.0024762155 -16.885766 0 3.4150554 4.556001 0.30957174 0.30957174 3.7207747e-05 2.3742799e-05 --0.023801326 0.00014761024 -0.0055414102 0.0075953435 -15.820598 0 5.030255 4.150067 0.30957174 0.30957174 6.2387494e-05 8.818032e-05 -0.013090622 -0.00030516161 -0.00030760351 0.0053514107 -20.766352 0 1.7358519 3.5737776 0.30957174 0.30957174 1.9660166e-05 2.8501428e-05 -0.0072862876 -0.00081375811 -0.0017132808 -0.0010553428 10.207415 0 1.1510899 5.6351556 0.30957174 0.30957174 1.1860309e-05 4.064002e-06 --0.036897015 0.00054477551 -0.0037664906 -0.0018157094 -12.440095 0 4.9529938 5.5327219 0.30957174 0.30957174 0.00015215276 1.757224e-05 -0.024430021 -0.001205018 0.0012388445 -0.0030923979 -12.157902 0 1.522806 0.75814299 0.30957174 0.30957174 7.8745194e-05 1.1032847e-05 --0.015512371 0.00053412656 0.0076254944 -0.0029038521 -8.9467597 0 4.7827509 1.5839353 0.30957174 0.30957174 2.9014864e-05 6.698635e-05 --0.0030593019 -0.0015406771 0.0039197179 -0.0002292041 -24.860905 0 0.15967494 1.8871597 0.30957174 0.30957174 2.2650239e-05 1.5541544e-05 --0.015630477 -0.0028212029 -0.0068421012 0.011162884 5.3373514e-05 0 6.1110556 4.0693917 0.30957174 0.30957174 9.932304e-05 0.00017079837 --0.010458894 0.00017842489 -0.0056570188 0.0015505907 21.581757 0 4.9325198 4.8212223 0.30957174 0.30957174 1.2298338e-05 3.4647624e-05 --0.01911267 0.0011602931 0.0072460775 -0.0023313994 -23.018194 0 4.5815361 1.6361696 0.30957174 0.30957174 5.2364667e-05 5.8325126e-05 --0.0046239799 0.00097388567 0.0038448159 0.0017049654 -1.2746418 0 3.9963704 2.3594859 0.30957174 0.30957174 1.0986981e-05 1.7786516e-05 --0.027998745 0.00043399243 -0.0090480094 0.0014709836 22.007768 0 4.9464173 4.9268049 0.30957174 0.30957174 8.7773194e-05 8.4680129e-05 -0.0013357812 0.00023491086 0.0004156573 0.00044965703 -8.3806332 0 2.9578486 2.7657182 0.30957174 0.30957174 6.9856011e-07 3.7473593e-07 -0.017756506 0.00069854739 0.0043382114 0.00089726391 -21.162324 0 2.2892051 2.1474446 0.30957174 0.30957174 3.9057062e-05 1.9772068e-05 -0.0027408305 0.00015436318 -0.0022227546 0.0025242601 21.357371 0 2.4191207 4.2418903 0.30957174 0.30957174 1.0417196e-06 1.130128e-05 --0.022787354 -0.00079313401 0.006460073 0.0065935813 14.801842 0 5.3937229 2.7366632 0.30957174 0.30957174 6.2733548e-05 8.5196516e-05 --0.023519505 0.0018871359 -0.00056532439 0.0038567323 0.61965493 0 4.4555184 3.6626072 0.30957174 0.30957174 9.316608e-05 1.5076309e-05 -0.013300885 0.0017559607 -0.0018597849 -0.0033573676 16.649482 0 2.8222208 6.1481726 0.30957174 0.30957174 4.750887e-05 1.466777e-05 -0.016535247 0.0014028568 0.00633976 0.0051719834 12.358523 0 2.6030577 2.625425 0.30957174 0.30957174 4.794193e-05 6.7053318e-05 -0.023183336 -1.3414449e-05 -0.0051847566 -0.005084863 5.2747921 0 1.9398257 5.8583024 0.30957174 0.30957174 5.9003161e-05 5.27476e-05 --0.019825613 0.00055081353 0.0029457611 0.0023322628 -21.905074 0 4.838809 2.6108303 0.30957174 0.30957174 4.5912134e-05 1.4143713e-05 -0.0042067016 0.001584621 -0.0066148983 0.005490282 15.825268 0 3.232321 4.3979158 0.30957174 0.30957174 2.4816513e-05 7.4013039e-05 --0.0074444338 0.0012884124 -0.0014232491 0.014059908 20.280373 0 4.0811451 3.6175935 0.30957174 0.30957174 2.1205421e-05 0.00019812474 -0.014911866 0.0030275619 -0.0040829665 0.003931864 -2.6089655 0 3.0202237 4.3241975 0.30957174 0.30957174 0.00010790817 3.2141061e-05 --7.6358962e-05 0.0012613666 -0.00072764301 -0.0064374548 13.986284 0 3.5225384 0.26083558 0.30957174 0.30957174 1.4494075e-05 4.1639519e-05 -0.022642129 -0.00071603075 0.00059992586 0.0093985251 11.472116 0 1.6646173 3.4516293 0.30957174 0.30957174 6.0949312e-05 8.7980877e-05 -0.0031697173 -0.0018478167 -0.0024953457 -0.0071372924 -14.429944 0 0.56043042 0.035425984 0.30957174 0.30957174 3.2206239e-05 5.6806551e-05 -0.0054497034 0.0021288184 -0.0058939564 -0.0017001897 17.407132 0 3.2419336 5.3653739 0.30957174 0.30957174 4.4542787e-05 3.7889177e-05 --0.00087957153 0.00091165721 0.0018027905 0.0012389614 -21.723377 0 3.6214129 2.5434276 0.30957174 0.30957174 7.6559033e-06 4.7991605e-06 -0.015126221 -0.0012703711 -6.3341184e-05 0.001188039 15.043646 0 1.292034 3.5695916 0.30957174 0.30957174 3.981836e-05 1.4040689e-06 -0.011265829 0.0025299856 0.00024544661 0.001369163 -8.8664153 0 3.0612225 3.337094 0.30957174 0.30957174 7.2240319e-05 1.9201847e-06 -0.0063072507 -0.00096044459 -0.0067189099 0.0021425772 20.181534 0 0.99892026 4.7803379 0.30957174 0.30957174 1.2770063e-05 5.0065271e-05 -0.022236975 -0.00055270726 -0.0025872291 0.00050584317 1.8377036 0 1.7224343 4.8951326 0.30957174 0.30957174 5.7065647e-05 7.0021286e-06 -0.00035841097 -0.00097616644 -0.0080722139 -0.00030150803 -4.3609526 0 0.41458438 5.1237216 0.30957174 0.30957174 8.6944352e-06 6.5781984e-05 -0.022228332 -0.0013566394 0.001667207 -0.011754589 11.533873 0 1.4376865 0.51632827 0.30957174 0.30957174 7.1006214e-05 0.00013985538 --0.002122615 -0.002005309 0.00056986014 -0.0025899357 0.23261991 0 0.25862036 0.59258809 0.30957174 0.30957174 3.7125812e-05 6.9809165e-06 --0.02440572 -0.00021999319 0.00068703118 -0.0046331397 17.016267 0 5.1686174 0.5226964 0.30957174 0.30957174 6.5828344e-05 2.1768272e-05 -0.0039811503 0.0010831252 -0.0075108236 0.0019383674 -7.4559939 0 3.1323748 4.8360811 0.30957174 0.30957174 1.2426674e-05 6.0599221e-05 -0.032740622 -0.00084573248 0.0041777186 -0.00031355946 8.8518676 0 1.7139938 1.8707854 0.30957174 0.30957174 0.00012419087 1.7693133e-05 --0.016651041 0.00067700181 0.0036295238 0.0083997125 -16.201883 0 4.7319829 3.1050587 0.30957174 0.30957174 3.4611572e-05 8.3265499e-05 --0.012081093 0.0012491644 0.006243816 -0.0006748833 -24.781233 0 4.3312045 1.8382903 0.30957174 0.30957174 3.023664e-05 3.9754822e-05 -0.0097740524 0.00046503888 0.0069925501 0.0033370627 7.7803663 0 2.3540726 2.3872161 0.30957174 0.30957174 1.2457231e-05 6.0340288e-05 --0.00082736593 -0.0029749129 -0.0034661243 0.0054457437 -3.8854712 0 0.34377919 4.0863911 0.30957174 0.30957174 8.0694101e-05 4.1528282e-05 -0.025444326 0.0015276995 0.0027528292 -0.0031138032 6.6562154 0 2.4455835 1.1022766 0.30957174 0.30957174 9.2331195e-05 1.7257215e-05 --0.039727154 0.0030822894 -0.00016905926 -0.0027370081 21.62329 0 4.4714379 0.31210915 0.30957174 0.30957174 0.0002597989 7.4594545e-06 --0.049489773 0.00049604964 -0.0066763429 -0.0019285539 17.803714 0 4.9956359 5.3657411 0.30957174 0.30957174 0.00027111145 4.8626155e-05 --0.0086015678 0.0033350386 0.010097428 -0.0059752276 5.8729685 0 3.791803 1.4143112 0.30957174 0.30957174 0.00010944095 0.00013820385 --0.0059688266 -0.0031263288 -0.0055361742 -0.0059780542 -15.479853 0 0.16770306 5.9063968 0.30957174 0.30957174 9.2945441e-05 6.6347237e-05 --0.016473099 0.0012659134 0.002709949 0.0089473449 5.2594129 0 4.4759424 3.2195384 0.30957174 0.30957174 4.4387526e-05 8.6811356e-05 --0.030541131 -0.00098331281 -0.010897514 0.0023121515 23.732212 0 5.3719775 4.8792596 0.30957174 0.30957174 0.00011120356 0.00012502671 -0.015880334 -0.0021348507 -0.004600705 -0.0017626971 1.0744873 0 1.0590749 5.4498697 0.30957174 0.30957174 6.9200895e-05 2.4421008e-05 -0.016108369 0.0002330567 0.0089984245 0.0059220464 6.4764303 0 2.0761363 2.5234369 0.30957174 0.30957174 2.8979666e-05 0.00011641876 -0.0228387 -0.001012971 0.0046642511 0.00098853502 -15.456911 0 1.5611204 2.1523042 0.30957174 0.30957174 6.6607589e-05 2.2901882e-05 --0.0023523678 -0.0015810027 0.0022466508 -0.0010320656 -5.4450762 0 0.21239323 1.5175415 0.30957174 0.30957174 2.3376985e-05 6.1451321e-06 --0.015100828 -0.001651048 0.0032020279 -0.01308491 -13.499512 0 5.8700699 0.61617662 0.30957174 0.30957174 4.9864792e-05 0.00018016701 -0.0013642044 -0.00036325611 -0.00072683846 -0.003357861 -18.856213 0 0.76533614 0.15944528 0.30957174 0.30957174 1.4063287e-06 1.1716661e-05 --0.0180509 -0.00089920926 -0.0042880923 0.0010174787 -15.284197 0 5.5126867 4.8555348 0.30957174 0.30957174 4.3134821e-05 1.9564521e-05 --0.00065280837 -0.00094738965 0.0076077618 -0.0029909051 19.967972 0 0.29880111 1.5732754 0.30957174 0.30957174 8.2228775e-06 6.722303e-05 --0.0029350808 0.00015981882 -0.0045549867 -0.0083194962 17.406011 0 4.6262332 6.1531306 0.30957174 0.30957174 1.178368e-06 8.9571398e-05 -0.0062144555 0.0029928721 -0.0057629175 0.0019524464 -17.402513 0 3.2917791 4.7624909 0.30957174 0.30957174 8.5834799e-05 3.7263172e-05 -0.012848074 0.00037921034 0.0026422958 -0.0027542336 13.645057 0 2.2077483 1.1430154 0.30957174 0.30957174 1.943115e-05 1.4563106e-05 --0.0081893317 0.001390069 0.00044890477 -0.0049224384 -14.474225 0 4.0899664 0.46598155 0.30957174 0.30957174 2.4964184e-05 2.4237634e-05 -0.033639605 0.00058856775 -0.0017093665 0.0080372857 9.7115315 0 2.1031474 3.7271082 0.30957174 0.30957174 0.00012738177 6.7021384e-05 -0.012232686 -0.0013324751 0.0040179398 -0.004498779 -21.601166 0 1.1635829 1.1073354 0.30957174 0.30957174 3.2600482e-05 3.6350804e-05 --0.020526173 -4.8863996e-05 0.00014654839 -0.0026615173 -24.556111 0 5.1083714 0.42975418 0.30957174 0.30957174 4.6273409e-05 7.0480481e-06 --0.014338251 -0.0031876036 0.0058383212 -0.0023225819 -12.045433 0 6.1988175 1.569254 0.30957174 0.30957174 0.00011512726 3.9714624e-05 -0.010426164 -0.00022851404 0.0089000961 -0.0042897945 14.015648 0 1.7480342 1.4991246 0.30957174 0.30957174 1.2408977e-05 9.8110964e-05 --0.0036955787 -0.0028064277 0.0029547571 0.0033925165 3.264942 0 0.23073749 2.7953307 0.30957174 0.30957174 7.3245043e-05 2.0217866e-05 --0.000411532 -0.00064945683 -0.0045396946 -0.0043420066 15.754604 0 0.30485132 5.8457786 0.30957174 0.30957174 3.8608737e-06 3.9477404e-05 -0.019287123 0.0026628263 -0.00054175391 -0.0063583257 19.844159 0 2.844131 0.28861218 0.30957174 0.30957174 0.00010542763 4.0397298e-05 -0.0042021817 0.0011641837 -0.0074332494 -0.0060288533 3.0984373 0 3.1386271 5.7641726 0.30957174 0.30957174 1.4284633e-05 9.1756783e-05 -0.0083340606 -0.0020200828 -0.0021047312 -0.00067742197 -6.052448 0 0.7995602 5.3957156 0.30957174 0.30957174 4.479768e-05 4.9211949e-06 -0.012579159 0.0013295127 0.0016057687 -0.0079220118 23.114622 0 2.711537 0.57587446 0.30957174 0.30957174 3.3472362e-05 6.4850328e-05 -0.01105727 0.0028882372 -0.0023888739 0.0027043877 10.036924 0 3.1180371 4.2434531 0.30957174 0.30957174 8.9411328e-05 1.3007813e-05 -0.00033863336 0.0014865522 0.0022553177 0.0025340751 -8.235097 0 3.4908912 2.7845984 0.30957174 0.30957174 2.0142831e-05 1.1497535e-05 --0.0029720398 0.0023413292 0.0010050488 0.0019664503 -11.586984 0 3.6543502 3.0401086 0.30957174 0.30957174 5.0905648e-05 4.8540167e-06 -0.017467188 0.0026367507 -0.00085760817 0.0061186538 10.33822 0 2.8871317 3.656269 0.30957174 0.30957174 9.6825781e-05 3.7876693e-05 --0.0043901876 0.00038220428 -0.0036255227 0.00069991431 -18.52989 0 4.4161999 4.8974887 0.30957174 0.30957174 3.4465128e-06 1.3737484e-05 --0.0056333914 0.0030337917 0.0051756498 0.0021471101 -21.709091 0 3.7169808 2.3354722 0.30957174 0.30957174 8.7325504e-05 3.1578521e-05 -0.00095833663 -0.00067484128 -0.0082831159 0.0058876105 11.722018 0 0.52894891 4.4725826 0.30957174 0.30957174 4.2493283e-06 0.00010355297 --0.001917999 0.0012270252 0.0043385876 -0.0092369494 19.80463 0 3.6858335 0.81654696 0.30957174 0.30957174 1.4118832e-05 0.00010360812 --0.020761101 0.0004800092 0.00044874401 0.00045994775 -20.058663 0 4.8791088 2.7387652 0.30957174 0.30957174 4.9415327e-05 4.1285407e-07 --0.016700527 0.0019710576 -0.00089908358 0.0046923042 -9.5884472 0 4.2651056 3.7067127 0.30957174 0.30957174 6.600819e-05 2.2654627e-05 --0.012032597 4.1041188e-05 0.0043915581 0.00039423736 -19.068775 0 5.0556287 2.0339081 0.30957174 0.30957174 1.5909228e-05 1.9597162e-05 --0.013668132 -0.001950586 -0.0085555773 0.00097394557 -17.202501 0 6.0017913 4.9742485 0.30957174 0.30957174 5.5167525e-05 7.4735496e-05 -0.0027515513 0.0011394606 -0.0065215063 -0.0021014034 8.8819286 0 3.2567652 5.3960486 0.30957174 0.30957174 1.2658471e-05 4.725693e-05 -0.022817782 -0.0024745268 0.0028173076 -0.0036096953 6.3137476 0 1.1657916 1.0409688 0.30957174 0.30957174 0.00011293481 2.0926467e-05 -0.019022849 -0.0023440219 -0.01194964 -0.0053060218 -3.961257 0 1.1020607 5.501566 0.30957174 0.30957174 8.977578e-05 0.00017188415 -0.020262478 0.00041787238 0.00010505385 0.0023839569 6.8154255 0 2.1307946 3.4714959 0.30957174 0.30957174 4.6661578e-05 5.6484228e-06 -0.021006356 -0.00075597438 -0.00017433093 -0.00082748768 8.152388 0 1.6283097 0.16501789 0.30957174 0.30957174 5.364695e-05 7.0983819e-07 -0.01570957 -0.00072475391 0.0010360973 0.0094715112 20.900389 0 1.5472502 3.4060541 0.30957174 0.30957174 3.1876795e-05 9.0066393e-05 -0.0073379056 0.00014875277 0.0001719824 -0.0039421528 11.920892 0 2.1277032 0.41825409 0.30957174 0.30957174 6.1124935e-06 1.5444729e-05 --0.015858786 0.00068593633 -0.010851157 -0.0014912669 23.012699 0 4.711361 5.2221722 0.30957174 0.30957174 3.1895073e-05 0.00012091337 --0.0035092158 -0.00095336198 0.0044065796 -0.0037848055 21.283911 0 6.2734699 1.2394694 0.30957174 0.30957174 9.6313633e-06 3.3785159e-05 --0.0099761402 0.0004719425 -0.0014268859 0.0010367709 -16.842443 0 4.6797995 4.462191 0.30957174 0.30957174 1.2954306e-05 3.118803e-06 --0.027316809 0.0031849204 -0.0016580754 -0.0025049833 -16.992545 0 4.2711946 6.0690401 0.30957174 0.30957174 0.00017431943 8.995828e-06 -0.011124429 -0.001483738 -0.0020886173 -0.00066734332 0.23933184 0 1.0629453 5.3936057 0.30957174 0.30957174 3.3639321e-05 4.8396288e-06 --0.0049776745 -5.7561215e-05 -0.0015903252 0.0067408356 12.571434 0 5.1916419 3.7494014 0.30957174 0.30957174 2.7501533e-06 4.7621203e-05 -0.030931291 -0.002264415 -0.0020046194 -0.0032626269 16.516373 0 1.3569474 6.1029035 0.30957174 0.30957174 0.00015173758 1.4609919e-05 --0.0092227214 -0.0013851639 -0.0055402214 0.0005602456 6.192371 0 6.0263086 4.986718 0.30957174 0.30957174 2.6815446e-05 3.1255602e-05 -0.0027460137 -0.0014705699 0.019132086 -0.00085696215 14.139848 0 0.57648732 1.9006961 0.30957174 0.30957174 2.05275e-05 0.000369749 --0.0059791811 -0.00054467231 0.00037289861 -0.0018866142 24.800702 0 5.7793486 0.57099013 0.30957174 0.30957174 6.6270541e-06 3.6707199e-06 --0.0037627512 0.0011418069 0.0002012096 -0.00046351564 15.814592 0 3.8630084 0.78682247 0.30957174 0.30957174 1.343036e-05 2.5392486e-07 --0.015529428 0.002579803 -0.0037590836 -0.0090681746 12.692821 0 4.0998338 6.2616312 0.30957174 0.30957174 8.710056e-05 9.5812775e-05 -0.027292605 0.00040529317 0.00022208855 -0.0017507135 23.139631 0 2.079554 0.5014999 0.30957174 0.30957174 8.3267705e-05 3.0899401e-06 -0.020176372 -0.0010487361 0.0051162247 -0.010011449 -18.670932 0 1.5028801 0.85003637 0.30957174 0.30957174 5.4707603e-05 0.0001258078 -0.02829857 0.0022668613 -0.0020559103 0.0051774278 24.768327 0 2.5754839 3.8966821 0.30957174 0.30957174 0.0001347204 3.0850233e-05 -0.016729181 0.0029002277 -0.0028963763 0.0066355542 -4.0669781 0 2.9514052 3.9304431 0.30957174 0.30957174 0.00010734469 5.2131935e-05 --0.019606761 0.0012097127 -0.0031323155 -0.0051600728 -17.033653 0 4.5746514 6.1083055 0.30957174 0.30957174 5.5531738e-05 3.6302435e-05 -0.00019232054 -6.9403241e-05 0.01224024 0.0039274959 -9.1907592 0 0.66960456 2.2532322 0.30957174 0.30957174 4.7938479e-08 0.0001663453 --0.0055129021 -0.00029067492 0.001337045 -0.004744149 -17.356766 0 5.534456 0.65113251 0.30957174 0.30957174 4.1060209e-06 2.4127224e-05 -0.0073431823 -0.00023809599 -0.010859817 -0.0072882412 -23.280744 0 1.6578991 5.6740178 0.30957174 0.30957174 6.4358387e-06 0.00017158597 -0.0090863392 -0.00030779549 0.0056273639 0.0035818237 -12.205946 0 1.6457907 2.5082524 0.30957174 0.30957174 9.9263647e-06 4.4651093e-05 --0.014125061 0.00054024082 -0.0013413492 0.0016635295 6.8547967 0 4.7514351 4.1984505 0.30957174 0.30957174 2.456108e-05 4.5588385e-06 -0.0082468013 0.0025691523 0.0020868928 0.0026960594 -2.4841006 0 3.1771025 2.853241 0.30957174 0.30957174 6.759274e-05 1.1600586e-05 -0.0038389863 2.8757476e-05 -0.0065432803 -0.0050182664 23.670476 0 2.0132284 5.7370242 0.30957174 0.30957174 1.6254065e-06 6.8142903e-05 -0.00097579896 -0.00072198975 -0.00067472693 -0.001111243 13.977168 0 0.52159389 6.1081934 0.30957174 0.30957174 4.8529654e-06 1.6838437e-06 -0.022967961 -0.00068804521 -0.0051802919 0.0053153723 -14.227687 0 1.6786957 4.2924801 0.30957174 0.30957174 6.2222792e-05 5.5078912e-05 --0.021885124 -0.00089749894 -0.0051789322 -0.0081992584 -0.060073625 0 5.4442068 6.0904578 0.30957174 0.30957174 5.9916283e-05 9.3724224e-05 --0.0024529239 -0.00085080393 0.0035981219 -0.0039424322 -12.69214 0 0.067780591 1.1181129 0.30957174 0.30957174 7.2544903e-06 2.8469113e-05 -0.015674909 0.00016631008 0.0021853202 -0.0030881013 8.9812777 0 2.0414474 0.99398084 0.30957174 0.30957174 2.722447e-05 1.4273814e-05 -0.0020726395 0.00056788776 0.00039707597 -0.0069696469 -13.726175 0 3.1348204 0.43167384 0.30957174 0.30957174 3.409326e-06 4.8342153e-05 -0.014431054 0.0022808513 0.0065689444 -0.0075230972 -14.285925 0 2.9088244 1.0961175 0.30957174 0.30957174 7.0251194e-05 9.9642144e-05 --0.014185429 -0.0016897521 -0.0042542625 0.0048761719 13.149525 0 5.9128775 4.2373063 0.30957174 0.30957174 4.8099688e-05 4.183108e-05 -0.0037649989 0.0045959045 0.00054017632 -0.0030462881 -9.6845742 0 3.4262041 0.5511999 0.30957174 0.30957174 0.00019396745 9.4990044e-06 --0.029790087 -0.0020906045 0.0056606741 -0.0025224599 1.1156155 0 5.655489 1.5289086 0.30957174 0.30957174 0.00013723521 3.8615796e-05 -0.011605885 0.0017177927 0.0033129951 -0.00037717936 -9.6378663 0 2.8777354 1.8326451 0.30957174 0.30957174 4.1666638e-05 1.1206524e-05 -0.0076996286 -0.00020466465 -0.0029767978 -0.016853412 -18.707008 0 1.7075317 0.19807871 0.30957174 0.30957174 6.8896202e-06 0.00029067436 --0.027919582 0.0015766599 0.0043495547 0.001566554 -18.877502 0 4.6115724 2.2882173 0.30957174 0.30957174 0.0001082161 2.1507095e-05 --0.023100538 6.5032204e-05 0.0022043393 0.0070215833 4.7365334 0 5.0610503 3.209371 0.30957174 0.30957174 5.8619354e-05 5.3802699e-05 -0.0062694217 -0.00044587343 -0.0012717282 0.0051067669 10.78391 0 1.3702361 3.7618672 0.30957174 0.30957174 6.1258284e-06 2.7498673e-05 -0.0010147052 -0.0020999608 -0.0013758131 0.0044819667 19.269651 0 0.42729506 3.8160138 0.30957174 0.30957174 4.0283882e-05 2.1833888e-05 --0.0029278794 -7.683276e-05 0.0065854952 0.0022917806 -18.552317 0 5.3213322 2.2774803 0.30957174 0.30957174 9.94836e-07 4.8932068e-05 --0.0017791271 0.0018202266 -0.00018883031 -0.0013722578 15.72254 0 3.6227823 0.23645278 0.30957174 0.30957174 3.0528889e-05 1.9038126e-06 -0.012386947 -0.001786346 -0.0037167893 0.0035128401 9.9531685 0 1.0249434 4.3335457 0.30957174 0.30957174 4.5912105e-05 2.6167401e-05 -0.0073318188 0.0013635586 0.00022932542 0.001168841 -9.2693303 0 2.98266 3.3206152 0.30957174 0.30957174 2.2838117e-05 1.4081613e-06 -0.0017038364 0.0035084063 0.0045152202 0.0060609481 17.186619 0 3.4626308 2.8717252 0.30957174 0.30957174 0.00011244523 5.6991463e-05 -0.011688523 0.00089107896 0.0090642175 -0.004517904 0.47616402 0 2.5520926 1.4859369 0.30957174 0.30957174 2.2230948e-05 0.0001030762 --0.0046125653 -0.0010678877 -0.0054941794 -0.0015749974 -3.1642927 0 6.2147198 5.3637258 0.30957174 0.30957174 1.2723777e-05 3.2892636e-05 --0.013421326 -0.00084266504 0.0050179179 -0.0061799802 -11.939313 0 5.6062186 1.0602697 0.30957174 0.30957174 2.6242774e-05 6.3268097e-05 --0.00032052973 0.0012249329 0.0062713058 0.0023540982 5.0972001 0 3.5446105 2.3015339 0.30957174 0.30957174 1.3679539e-05 4.5146849e-05 --0.0064259989 0.0011433042 -0.0058821904 -0.0027594077 -17.309319 0 4.0687239 5.5222093 0.30957174 0.30957174 1.6440344e-05 4.2434979e-05 -0.011347709 0.00021661997 -0.0075084449 0.0081207903 12.175855 0 2.1172667 4.2661798 0.30957174 0.30957174 1.4563489e-05 0.00012225031 --0.02127305 -0.00021689519 -0.013813863 -0.0067659665 -20.184462 0 5.1793007 5.5389407 0.30957174 0.30957174 5.0107311e-05 0.00023778651 -0.019280394 0.00053325207 -0.0015786556 -0.0015564274 -18.428714 0 2.1919048 5.8609387 0.30957174 0.30957174 4.3398118e-05 4.9153474e-06 --0.0045922081 -0.0024281522 -0.0045521931 0.0027406842 2.554049 0 0.16959422 4.5483386 0.30957174 0.30957174 5.6023202e-05 2.8342001e-05 --0.023901148 -0.0015640855 -0.0029596602 -0.0079586628 18.495932 0 5.6242476 0.015608014 0.30957174 0.30957174 8.4996589e-05 7.1659146e-05 --0.011271293 -0.00071820266 0.0028613492 -0.0048103912 24.338967 0 5.6126068 0.91448122 0.30957174 0.30957174 1.8645048e-05 3.1206818e-05 -0.027634652 -6.7815472e-05 0.0090874093 -0.0036267568 -20.397222 0 1.9227459 1.5681558 0.30957174 0.30957174 8.3875729e-05 9.6301199e-05 --0.025426961 -0.00050876193 0.0090999012 -0.011880345 -2.7071905 0 5.2669775 1.0318628 0.30957174 0.30957174 7.3332016e-05 0.00022348459 --0.014235002 -0.0002403111 -0.0023666487 0.004686478 -21.580017 0 5.2392757 3.9868033 0.30957174 0.30957174 2.2770752e-05 2.743217e-05 -0.0020519723 0.00060943364 0.0026954098 0.0043835957 5.4752461 0 3.1618466 2.9609709 0.30957174 0.30957174 3.8455338e-06 2.6384993e-05 -0.018746679 0.00044481557 0.00025813189 -0.0061936244 -12.797397 0 2.1579665 0.41629235 0.30957174 0.30957174 4.0382192e-05 3.8117976e-05 --0.033284619 -0.0028453344 0.00020871305 0.0036750602 -17.701335 0 5.7483159 3.4587007 0.30957174 0.30957174 0.00019536704 1.3440775e-05 --0.0043120005 -0.0012241064 0.0073412487 -0.0046108963 -13.824648 0 0.0053141941 1.3879353 0.30957174 0.30957174 1.5690944e-05 7.5421721e-05 --0.0024865904 -0.00075216334 -0.009567166 -0.0053437559 0.82151246 0 0.026167637 5.5926252 0.30957174 0.30957174 5.8323927e-06 0.00012060163 --0.026831503 -0.0014598774 -0.0046199413 -0.0003250591 5.0786651 0 5.546837 5.1563674 0.30957174 0.30957174 9.8445991e-05 2.1622657e-05 --0.010648695 -0.0022330685 -0.0095898826 -0.0025662268 -12.165878 0 6.1752256 5.34614 0.30957174 0.30957174 5.7872902e-05 9.9247804e-05 -0.015595682 0.0004615971 -0.0017237815 0.0012149578 24.153463 0 2.2084515 4.4765527 0.30957174 0.30957174 2.8641493e-05 4.4598318e-06 -0.0032631826 -0.0016396867 0.0014710733 0.0027694946 8.260138 0 0.58939076 3.02425 0.30957174 0.30957174 2.5660164e-05 9.7897786e-06 -0.007955172 0.00051383888 0.0069700734 0.0044280789 -8.1333796 0 2.4769364 2.5073992 0.30957174 0.30957174 9.3523633e-06 6.8427288e-05 --0.011272527 -0.0023899478 0.0099107543 -0.0065087146 17.472055 0 6.1797164 1.3677222 0.30957174 0.30957174 6.5980743e-05 0.00014104456 --0.0065010086 -0.0011055768 0.0070395836 -0.010040248 18.033761 0 6.084273 0.98961008 0.30957174 0.30957174 1.5773909e-05 0.00014995117 --0.018618081 -0.0017256019 -0.0006180249 -0.0016422038 -23.689797 0 5.7878621 0.011671914 0.30957174 0.30957174 6.5177328e-05 3.0600954e-06 --0.0023916322 0.00034905251 0.0011155421 -0.0042500066 -24.101351 0 4.1607802 0.63299067 0.30957174 0.30957174 1.737779e-06 1.9171083e-05 --0.0049364953 0.0003507495 -0.013692109 0.0010221507 20.301321 0 4.512255 5.0127752 0.30957174 0.30957174 3.795837e-06 0.00019003844 -0.0081189301 0.002856358 -0.0070871418 0.0016943868 16.585691 0 3.2134355 4.8538447 0.30957174 0.30957174 8.1557581e-05 5.3484756e-05 -0.0098040797 -0.0017993214 -0.00010878873 -0.00056253574 -12.101801 0 0.91335767 0.18174938 0.30957174 0.30957174 4.0043893e-05 3.2581917e-07 --0.015339077 -0.0011393606 -0.00048723975 0.0032604616 12.547761 0 5.6815572 3.6654254 0.30957174 0.30957174 3.7654402e-05 1.078399e-05 --0.020812735 0.0025369845 -0.0034331206 0.0019305582 9.7840066 0 4.2490288 4.5778877 0.30957174 0.30957174 0.00010618269 1.5579315e-05 -0.038754113 -0.0018135134 0.001363876 0.0037120599 1.9995831 0 1.542145 3.1611501 0.30957174 0.30957174 0.00019483121 1.5543292e-05 -0.014529984 -0.00045937634 0.0038468723 -0.0010571577 0.58959236 0 1.6646852 1.6789746 0.30957174 0.30957174 2.5098487e-05 1.6027606e-05 --0.012648694 -0.0022357869 -0.00018142731 -0.0065160011 20.340123 0 6.1017317 0.34623731 0.30957174 0.30957174 6.3098594e-05 4.2148142e-05 -0.013789585 0.00046947351 -0.0023471891 -0.0066461407 -15.451172 0 2.245824 0.032250641 0.30957174 0.30957174 2.2882141e-05 4.9368231e-05 -0.0030843209 -0.00038221073 -0.0051211832 0.00080784379 -13.753743 0 1.0992514 4.9314777 0.30957174 0.30957174 2.3750562e-06 2.7087645e-05 --0.0044259279 -8.7363125e-05 0.0039494887 0.0043732161 -16.956808 0 5.2645976 2.7773231 0.30957174 0.30957174 2.2199294e-06 3.4695993e-05 -0.0015815533 -0.0014233561 0.0038366689 -0.0065110929 11.691327 0 0.49567869 0.91033667 0.30957174 0.30957174 1.8729661e-05 5.6891559e-05 --0.023109255 0.00074962754 0.0021249195 0.0031484989 9.7661992 0 4.7993718 2.9184422 0.30957174 0.30957174 6.3743988e-05 1.438498e-05 --0.026546317 -0.0011411533 0.00031766833 0.0035523792 13.395379 0 5.4599222 3.4259829 0.30957174 0.30957174 8.9223119e-05 1.2619095e-05 -0.011556483 -0.00085629206 0.0075129651 -0.0063185984 11.104556 0 1.3513671 1.249832 0.30957174 0.30957174 2.1340294e-05 9.650663e-05 -0.011671209 0.001469818 0.0018291337 -0.0023761765 17.737836 0 2.7989389 1.0342693 0.30957174 0.30957174 3.4633086e-05 8.9735638e-06 --0.018045764 -0.00083076938 -0.0059289415 -0.0089702306 -1.6514537 0 5.4837787 6.0697053 0.30957174 0.30957174 4.2035924e-05 0.00011525331 --0.032103972 -0.00061863949 -0.0023775142 -0.00020455677 -8.8348264 0 5.2604555 5.1718253 0.30957174 0.30957174 0.0001166296 5.7401577e-06 -0.014337988 0.00016110568 -0.0047729181 0.0048934772 2.2582351 0 2.0470969 4.2928782 0.30957174 0.30957174 2.2804159e-05 4.6718944e-05 --0.014021768 0.0012445071 -0.0015587167 0.0076563169 -11.584013 0 4.4067832 3.7183269 0.30957174 0.30957174 3.5691838e-05 6.0594604e-05 --0.0071932013 -0.00095886086 -0.0036146595 0.0015686965 8.8462094 0 5.9685625 4.6801923 0.30957174 0.30957174 1.4055387e-05 1.5613183e-05 --0.024944217 -0.0028539611 0.0028361387 0.0014228597 14.748665 0 5.8927666 2.4068484 0.30957174 0.30957174 0.00014250151 1.0117413e-05 --0.0087521418 0.0023043979 0.0021804785 -0.0030395165 -9.5319055 0 3.9109125 1.0004438 0.30957174 0.30957174 5.6781982e-05 1.3957202e-05 -0.027469409 0.00064838747 0.00017306057 0.0029805438 -5.7466694 0 2.1568896 3.4574229 0.30957174 0.30957174 8.6663897e-05 8.8420036e-06 --0.012862142 -0.00078306897 -0.0042023344 -0.004313265 20.573754 0 5.5930529 5.8810551 0.30957174 0.30957174 2.3746767e-05 3.6257395e-05 -0.025096027 -0.00022953263 -0.00058078713 -0.0046527013 5.8774863 0 1.8619726 0.24911286 0.30957174 0.30957174 6.9618642e-05 2.1812653e-05 --0.008108942 7.2281137e-05 0.0035782314 -0.0076858363 18.145002 0 5.0056682 0.81313429 0.30957174 0.30957174 7.2659722e-06 7.1502544e-05 --0.015529194 -0.0012626703 -0.001615766 0.0028312547 -0.064907541 0 5.7241978 4.0379836 0.30957174 0.30957174 4.0996776e-05 1.0583168e-05 --0.0051761898 0.002456773 -0.0030573504 -0.0010685224 20.644358 0 3.743186 5.4203917 0.30957174 0.30957174 5.7923019e-05 1.0556097e-05 --0.016175947 0.0023143476 -0.0036732098 -0.0066561012 9.8789552 0 4.1703603 6.1497766 0.30957174 0.30957174 7.7516076e-05 5.7547907e-05 -0.0058819564 0.0010101713 0.0011406087 -0.00065126783 -0.5468739 0 2.9471461 1.4297753 0.30957174 0.30957174 1.3093628e-05 1.7323137e-06 --0.023284021 0.0035027769 0.00081171231 -0.014723494 10.383781 0 4.1462887 0.42982297 0.30957174 0.30957174 0.00017128213 0.00021569265 --0.015152836 -0.0032193054 -0.0010626904 -0.0063799754 24.99281 0 6.1805631 0.20792816 0.30957174 0.30957174 0.00011961464 4.1513475e-05 -0.022640893 0.00012951797 -0.004116691 0.0040613181 -22.39464 0 1.99716 4.3121207 0.30957174 0.30957174 5.64256e-05 3.3446228e-05 -0.0020090986 0.00114086 0.0022390894 -0.0015287053 16.820385 0 3.3249271 1.349827 0.30957174 0.30957174 1.2299527e-05 7.3724339e-06 --0.016764561 -0.0017053164 0.007832549 -0.0064949468 9.165865 0 5.8340181 1.2567739 0.30957174 0.30957174 5.7343895e-05 0.00010369216 -0.010693708 0.00026715709 0.004306073 -0.0065808435 -14.373944 0 2.1688618 0.95744233 0.30957174 0.30957174 1.3203755e-05 6.1650739e-05 --0.0076693694 -0.0038102397 0.00059654393 -0.0016120361 2.5899828 0 0.15683203 0.73138028 0.30957174 0.30957174 0.00013870626 2.9364135e-06 -0.022664757 7.0264346e-05 0.0017277967 -0.0010167616 -5.81207 0 1.9733296 1.4167377 0.30957174 0.30957174 5.6436453e-05 4.0350619e-06 -0.0098608156 0.00067886763 0.007325378 -0.0024592581 -15.328248 0 2.5052296 1.6236434 0.30957174 0.30957174 1.48724e-05 6.0097644e-05 --0.0024344159 -0.00036182919 0.001258657 -0.0004725272 22.300479 0 6.021328 1.5886195 0.30957174 0.30957174 1.8431832e-06 1.8186082e-06 --0.01224851 0.0010423076 -0.0061538471 0.0054893739 14.570429 0 4.4272681 4.3623299 0.30957174 0.30957174 2.6365875e-05 6.8068114e-05 --0.0023241743 0.00089232823 -0.0059442488 -0.0097553063 -24.793361 0 3.7943894 6.1066162 0.30957174 0.30957174 7.8463301e-06 0.00013001863 --0.011753524 -0.001823576 0.0027248459 0.001593172 -24.494375 0 6.0417122 2.4706472 0.30957174 0.30957174 4.5457769e-05 1.0002984e-05 -0.012931876 0.0021391438 -0.0084573261 0.007442218 4.1470246 0 2.9299883 4.3690739 0.30957174 0.30957174 6.0042309e-05 0.00012704819 -0.019784104 -0.0002241072 -0.003436099 0.0074014612 -12.625381 0 1.8422728 3.9536394 0.30957174 0.30957174 4.3425409e-05 6.6241694e-05 -0.020205316 -0.0002787924 -3.7194063e-06 -0.0087157353 10.635944 0 1.8200614 0.37387004 0.30957174 0.30957174 4.5525012e-05 7.5349821e-05 -0.011239889 0.0014467148 -0.0015040245 -0.0051874023 -10.96195 0 2.8097264 0.089921281 0.30957174 0.30957174 3.2934464e-05 2.8972088e-05 -0.0031074165 0.00051117144 -0.0017469735 0.0024354904 -15.81081 0 2.9274274 4.1419846 0.30957174 0.30957174 3.4402566e-06 8.9604463e-06 --0.017532551 -0.00012753905 0.0001185322 0.0056811887 21.6817 0 5.1528579 3.494862 0.30957174 0.30957174 3.3892562e-05 3.202909e-05 --0.035398082 -0.0012328915 0.001485852 -0.0035181747 -24.959071 0 5.393917 0.77683042 0.30957174 0.30957174 0.00015139968 1.4503223e-05 --0.0021200436 -0.00073109046 -0.012921844 -0.0061841159 -12.896022 0 0.066107976 5.5298999 0.30957174 0.30957174 5.3623025e-06 0.00020626924 -0.02935586 0.0015241492 -0.0057530495 0.0060117977 -9.9985767 0 2.3868764 4.2833574 0.30957174 0.30957174 0.0001157635 6.9216857e-05 -0.011518005 -0.00014542295 -0.0055477942 0.00047188375 -10.966065 0 1.8305874 5.0025185 0.30957174 0.30957174 1.4756148e-05 3.124979e-05 -0.020227923 0.00019262648 0.0040353643 -0.0024593006 15.531006 0 2.0316268 1.4013681 0.30957174 0.30957174 4.5255332e-05 2.2416165e-05 --0.0028802686 -0.0020103734 -0.0042397232 -0.0060112501 -6.8891059 0 0.21830032 6.0393836 0.30957174 0.30957174 3.7727174e-05 5.3964726e-05 --0.004957661 0.0021704528 -0.0044579051 -0.001334204 0.42017404 0 3.7615756 5.3752715 0.30957174 0.30957174 4.5611191e-05 2.1800625e-05 -0.013232617 0.0005879007 0.00041557283 -1.5620905e-05 18.821863 0 2.3296591 1.9078289 0.30957174 0.30957174 2.2370638e-05 1.7435064e-07 -0.026895074 -0.0012826173 -0.00160131 0.0035805104 22.299092 0 1.5352716 3.9394745 0.30957174 0.30957174 9.4392542e-05 1.530149e-05 -0.00063150094 -0.001047672 -0.00031876199 0.004009165 -15.610213 0 0.44037378 3.5958784 0.30957174 0.30957174 1.0042382e-05 1.6045874e-05 -0.001330618 -0.0012251982 0.0033569917 0.0018901331 -14.000852 0 0.4929627 2.4544355 0.30957174 0.30957174 1.3868548e-05 1.4904974e-05 -0.022653587 -0.0012963378 0.0031379625 0.0033216721 -12.670508 0 1.4645714 2.754873 0.30957174 0.30957174 7.1644138e-05 2.0871368e-05 -0.0026847877 -0.003473858 0.0061702706 -0.0069039576 -16.508139 0 0.45893925 1.1076759 0.30957174 0.30957174 0.00011072041 8.5661817e-05 --0.01500596 -0.0019977067 -0.0052632605 -0.0054863653 -18.844625 0 5.9679235 5.8887826 0.30957174 0.30957174 6.1073451e-05 5.7784549e-05 --0.0019016126 -0.001136361 -0.0049448496 0.0034313605 16.039192 0 0.19262255 4.4838486 0.30957174 0.30957174 1.2160055e-05 3.6329891e-05 -0.011295335 -0.0020348403 0.0038441848 -0.0034733837 -6.1657945 0 0.92158005 1.2143647 0.30957174 0.30957174 5.172391e-05 2.6865066e-05 -0.028678927 -0.00039894122 0.013477675 -0.0089054126 -18.154016 0 1.8190514 1.3649275 0.30957174 0.30957174 9.173927e-05 0.00026179359 --0.012033885 -0.00080033783 -0.00052984841 0.0019176656 1.5594303 0 5.63139 3.7875574 0.30957174 0.30957174 2.1732214e-05 3.9307339e-06 --0.0073456029 -0.00084665205 0.0048757901 0.0075885642 -19.479097 0 5.8964462 2.941097 0.30957174 0.30957174 1.2453115e-05 8.1087796e-05 -0.013392993 0.0026308773 0.0049912545 0.007864609 -1.4937164 0 3.0062872 2.9467067 0.30957174 0.30957174 8.2741639e-05 8.6467651e-05 -0.0076942391 0.00217764 -0.0037948095 -0.0029884499 0.39352329 0 3.1458833 5.7498253 0.30957174 0.30957174 4.9696665e-05 2.3376588e-05 -0.01534735 -0.0027938908 -0.0015880317 -0.0020426135 12.579918 0 0.91694105 5.9927081 0.30957174 0.30957174 9.6963207e-05 6.6809357e-06 --0.0042322472 0.0011887885 -0.004368548 0.0030819593 15.658015 0 3.8884613 4.4761084 0.30957174 0.30957174 1.4839853e-05 2.8661451e-05 -0.00414203 0.00049234684 0.0087929895 0.0022099092 -14.320932 0 2.7702261 2.1894108 0.30957174 0.30957174 4.0915416e-06 8.2791143e-05 --0.0075110638 -0.0022364609 0.0015180071 0.0074419507 7.4421639 0 0.021080472 3.3130778 0.30957174 0.30957174 5.1756078e-05 5.7257944e-05 -0.027421408 0.0024714139 -0.0026952758 0.0013128321 -13.8074 0 2.6325133 4.636614 0.30957174 0.30957174 0.00013818405 9.0333221e-06 --0.012634826 -9.7026765e-05 0.0032906807 -0.0083748902 -3.4286288 0 5.1565292 0.7514619 0.30957174 0.30957174 1.7610427e-05 8.0488505e-05 --0.0047501402 -0.0011717897 -0.0069406367 0.0058330635 6.0987611 0 6.2387905 4.391778 0.30957174 0.30957174 1.4984994e-05 8.231464e-05 --0.032209112 -0.0025393207 0.002100548 0.00019795615 2.0086258 0 5.7095063 2.038304 0.30957174 0.30957174 0.00017262423 4.4871398e-06 -0.0086289144 0.00028325437 -0.0016314669 0.0087997574 3.3628215 0 2.2356597 3.7006713 0.30957174 0.30957174 8.9046664e-06 7.9492976e-05 --0.00086543569 0.00053830893 0.0037014884 -0.0011608926 22.739807 0 3.6905818 1.6434944 0.30957174 0.30957174 2.721904e-06 1.5149479e-05 --0.020994272 -0.0010178586 0.0028136553 -0.0043269052 4.7060584 0 5.5025752 0.95458156 0.30957174 0.30957174 5.7822891e-05 2.6551916e-05 -0.0017691934 -0.0016485354 -0.0076169968 0.00020621656 -10.633288 0 0.49157139 5.0598414 0.30957174 0.30957174 2.5099878e-05 5.8533777e-05 -0.022500235 0.0016484687 -0.0090518082 0.0062849296 -6.8153738 0 2.5336026 4.4835777 0.30957174 0.30957174 8.0330031e-05 0.0001217841 --0.034224328 0.00033868654 -0.0037623602 -0.00080440976 7.8322541 0 4.9967852 5.2956687 0.30957174 0.30957174 0.00012962722 1.4912589e-05 --0.014487408 0.0036206196 0.0056104257 0.0020631895 -24.384095 0 3.9297775 2.2948672 0.30957174 0.30957174 0.00014245433 3.59558e-05 -0.0052338613 -0.0018768517 -0.0011173998 0.0056093715 22.67469 0 0.6713699 3.7140827 0.30957174 0.30957174 3.5095593e-05 3.2469386e-05 --0.0011259644 0.00023922868 -0.0036891491 -0.0030554601 14.191959 0 3.9927964 5.7744223 0.30957174 0.30957174 6.6050775e-07 2.2981113e-05 -0.019971827 -0.0012080051 -0.00061141325 0.0062039465 2.9900896 0 1.4414976 3.6149236 0.30957174 0.30957174 5.708027e-05 3.8554609e-05 --0.0035373123 -0.0026150785 0.00091294726 -0.0046889 10.315602 0 0.22688648 0.56812706 0.30957174 0.30957174 6.3669302e-05 2.2648276e-05 --0.013729272 0.00091823506 0.0027836135 0.00073104593 6.7150426 0 4.5394966 2.1999341 0.30957174 0.30957174 2.8372809e-05 8.3417748e-06 --0.030754955 -0.002438437 0.0010387918 -0.0054587777 13.624963 0 5.7121899 0.56384597 0.30957174 0.30957174 0.00015799859 3.0645194e-05 --0.033958584 0.0017008707 0.0069478861 0.0068915934 -18.039853 0 4.6586435 2.7223682 0.30957174 0.30957174 0.0001529463 9.5776662e-05 -0.016944274 -0.00034273798 -0.0044272059 0.00076808495 5.6790296 0 1.7628817 4.9162693 0.30957174 0.30957174 3.258797e-05 2.0345112e-05 -0.0055380303 0.0006452374 0.012326552 -0.00093585347 3.6404625 0 2.7602414 1.8699306 0.30957174 0.30957174 7.1593548e-06 0.00015405124 -0.031493567 0.0014931845 -0.0077131606 -0.010270898 20.864155 0 2.3527946 6.0094596 0.30957174 0.30957174 0.00012919201 0.00016461617 --0.018543322 0.0001730128 -0.0032784536 0.0043405043 -1.7670465 0 5.0019008 4.1666967 0.30957174 0.30957174 3.8020022e-05 2.9523516e-05 --0.035013979 0.0019047075 0.0058905485 0.0071196473 17.106689 0 4.626619 2.8206966 0.30957174 0.30957174 0.00016763227 8.5260926e-05 -0.010958564 -0.00042462071 0.0047565898 0.0006500373 13.902749 0 1.6057795 2.0798307 0.30957174 0.30957174 1.4825578e-05 2.3228714e-05 --0.00085354378 -0.0022363403 -0.0036277856 -0.00014625048 23.914692 0 0.33242619 5.126656 0.30957174 0.30957174 4.5637957e-05 1.3289329e-05 --0.014926284 -0.00028587886 -0.00060431854 -0.0079941889 7.6421173 0 5.2594199 0.29823634 0.30957174 0.30957174 2.5202131e-05 6.375849e-05 --0.0065752925 -0.00042519838 -0.00298366 0.00364706 -22.29706 0 5.6190315 4.2055555 0.30957174 0.30957174 6.3930679e-06 2.2168293e-05 -0.02133985 0.0013757171 -0.0053313634 0.0049979714 -23.506502 0 2.4760918 4.3376059 0.30957174 0.30957174 6.7231639e-05 5.3432873e-05 -0.032971975 -5.7444309e-05 0.0060715542 0.0057247786 -11.847938 0 1.9292274 2.697055 0.30957174 0.30957174 0.00011937424 6.9672368e-05 --0.012551485 0.00062493683 -0.0016333066 0.0001841598 -21.33225 0 4.6608832 4.9753111 0.30957174 0.30957174 2.0851874e-05 2.7230775e-06 -0.021326076 0.0019236258 -0.0074570673 0.0033747374 -17.108792 0 2.632913 4.6647536 0.30957174 0.30957174 8.3634501e-05 6.735792e-05 --0.015388231 0.0025632222 0.0090661784 -0.005353771 -7.7765067 0 4.098599 1.4152236 0.30957174 0.30957174 8.5844524e-05 0.00011129673 -0.010374997 3.6658957e-05 0.00033617659 0.0012762068 -7.5555889 0 1.9772725 3.2563185 0.30957174 0.30957174 1.1828699e-05 1.7294702e-06 --0.0160874 0.0024337064 -0.00013683749 -0.0059850225 -0.80201285 0 4.143629 0.35125465 0.30957174 0.30957174 8.2364947e-05 3.5549732e-05 -0.026600611 -0.00033870928 -0.0021497911 -0.0068892895 3.6605452 0 1.8296217 0.069510611 0.30957174 0.30957174 7.8722442e-05 5.1737812e-05 -0.010712529 -0.0007277744 0.0011261527 -0.0061943875 21.356898 0 1.3909237 0.55557243 0.30957174 0.30957174 1.742265e-05 3.9338736e-05 -9.7161783e-05 -0.00110574 -0.0046281897 0.0060749688 -7.8212333 0 0.38394612 4.1708502 0.30957174 0.30957174 1.1138715e-05 5.8201586e-05 --0.013478143 -0.0032218574 -0.0020633249 -7.9515336e-05 -1.4730844 0 6.2269783 5.1248965 0.30957174 0.30957174 0.00011450078 4.2982859e-06 -0.014459779 0.00039048644 -0.00095964258 0.00547296 -5.2058647 0 2.1863059 3.6908573 0.30957174 0.30957174 2.4341741e-05 3.0639514e-05 -0.01283974 0.0017434711 -0.003686464 -0.0031109037 -7.7085984 0 2.8360211 5.7836161 0.30957174 0.30957174 4.5787412e-05 2.3300269e-05 -0.0026715498 0.0023950667 0.0015030657 0.0068813866 -20.898484 0 3.39405 3.2991467 0.30957174 0.30957174 5.3038021e-05 4.924821e-05 -0.0047498981 0.0015586293 -0.010860864 8.328695e-05 11.371258 0 3.1930535 5.0790829 0.30957174 0.30957174 2.4606378e-05 0.00011892681 -0.0023367744 0.0013454531 0.00072613647 0.0072536548 18.178162 0 3.3274941 3.4153112 0.30957174 0.30957174 1.7089633e-05 5.2721639e-05 -0.027906418 0.0033448381 -0.0025039111 -0.00214937 2.0391965 0 2.7743713 5.7920327 0.30957174 0.30957174 0.00018740601 1.0903115e-05 --0.0013580471 -0.0011304852 -0.0018293433 -0.0066886116 -15.256777 0 0.24318222 0.10525483 0.30957174 0.30957174 1.1844215e-05 4.774956e-05 -0.002416149 -0.00016437276 -0.0013495642 0.0072875171 -5.3349174 0 1.3903039 3.7004661 0.30957174 0.30957174 8.8697431e-07 5.4514652e-05 --0.0069571707 0.0015188924 0.0022982405 0.001610688 9.8615456 0 3.9817981 2.5525725 0.30957174 0.30957174 2.6329094e-05 7.8983051e-06 --0.00093680885 0.0011760813 -0.00133772 0.003967751 1.590269 0 3.6031141 3.8435387 0.30957174 0.30957174 1.2696132e-05 1.7419834e-05 --0.0011400412 -0.0017670691 -0.00038294967 0.00040765028 3.7512106 0 0.30359467 4.2741108 0.30957174 0.30957174 2.8587009e-05 3.1268096e-07 -0.021293372 -0.0016085628 0.002187631 -0.008614239 -24.383124 0 1.342369 0.62494182 0.30957174 0.30957174 7.3344012e-05 7.8429842e-05 -0.015388245 0.0022081475 0.0081995193 -0.0046532485 -18.836239 0 2.8628486 1.4323928 0.30957174 0.30957174 7.0411534e-05 8.9257819e-05 -0.022858741 0.0013389589 0.00519672 0.0037982279 2.4549938 0 2.4352498 2.5723914 0.30957174 0.30957174 7.3692289e-05 4.153593e-05 --0.0046249605 0.0013145574 0.0018465534 -0.0075704493 -22.886436 0 3.8844678 0.61542047 0.30957174 0.30957174 1.8089718e-05 6.0285842e-05 -0.013627019 0.00080787699 0.00084788952 0.00129542 10.679394 0 2.4402677 2.9326145 0.30957174 0.30957174 2.6330483e-05 2.3893211e-06 -0.019009386 0.00070638493 0.005831488 -0.0068912851 -22.62196 0 2.2714923 1.0805972 0.30957174 0.30957174 4.4214051e-05 8.1389277e-05 --0.020333017 0.0017008151 0.0090147141 0.00156861 19.571819 0 4.4355645 2.1160112 0.30957174 0.30957174 7.1736626e-05 8.4368168e-05 --0.043582516 -0.00029057958 0.0073030777 0.0011492223 23.719573 0 5.1473501 2.0999361 0.30957174 0.30957174 0.00020928351 5.5079751e-05 --0.013224386 -0.0024666139 -0.0076663093 -0.0041472236 18.473469 0 6.1255254 5.5791811 0.30957174 0.30957174 7.4621409e-05 7.6311789e-05 -0.00067266269 0.0018712121 0.0051617093 0.0025743253 -18.392109 0 3.4764508 2.4044971 0.30957174 0.30957174 3.194556e-05 3.3433998e-05 --0.0021054431 -0.00061905659 0.001325322 0.0032414786 11.713098 0 0.016970667 3.1249168 0.30957174 0.30957174 3.9776256e-06 1.2193021e-05 -0.014787897 -0.00091804775 0.0067348698 0.0012576881 -15.249942 0 1.4304164 2.1282534 0.30957174 0.30957174 3.1683731e-05 4.7297212e-05 --0.024886527 -0.0016791783 0.00045351299 -0.011493498 15.03016 0 5.6378044 0.41405918 0.30957174 0.30957174 9.3674361e-05 0.0001312397 -0.018746253 9.847641e-05 0.001300083 0.0010779686 -2.2564588 0 1.9929128 2.633377 0.30957174 0.30957174 3.8666392e-05 2.8566146e-06 -0.025607052 0.00030461966 0.0061051326 -0.0041959597 -7.6740749 0 2.0530399 1.3467402 0.30957174 0.30957174 7.2828379e-05 5.50402e-05 --0.0031333993 -0.00057038462 -0.0023939281 0.003349148 13.37978 0 6.1148204 4.1403202 0.30957174 0.30957174 4.0414435e-06 1.6903704e-05 --0.029332693 0.00093662738 -0.0019862517 -0.0041665371 14.693561 0 4.8036266 6.209477 0.30957174 0.30957174 0.00010244427 2.1197017e-05 --0.0093867445 0.0014935879 -0.0029224575 0.0052740287 8.5065701 0 4.1198183 4.0253449 0.30957174 0.30957174 2.9993798e-05 3.6200848e-05 -0.01783775 0.0010146964 -0.0099087819 0.002249223 5.3549766 0 2.423186 4.865225 0.30957174 0.30957174 4.4308521e-05 0.00010400243 --0.036466534 0.0020429159 -0.0081641324 0.0042394661 -10.484464 0 4.6148178 4.6110501 0.30957174 0.30957174 0.00018400037 8.5024143e-05 --0.039286099 -9.0748641e-05 -0.0025527342 0.0029097947 -17.74839 0 5.1077283 4.2400454 0.30957174 0.30957174 0.00016950457 1.4968016e-05 -0.002605347 0.0014018644 0.00032318885 0.0044903383 -20.13987 0 3.3146358 3.4434589 0.30957174 0.30957174 1.8647111e-05 2.0105404e-05 --0.0042130908 -0.002034364 -0.00046083526 0.0040049124 17.811332 0 0.1507559 3.6313822 0.30957174 0.30957174 3.9648958e-05 1.6123732e-05 -0.02728678 -0.00073371295 0.0023796035 0.007421922 -0.79071618 0 1.7048844 3.2032611 0.30957174 0.30957174 8.6640373e-05 6.0348188e-05 --0.0071551791 0.0046489017 -0.0010743221 -0.0018066738 -16.374244 0 3.6832712 6.1174425 0.30957174 0.30957174 0.00020249467 4.4012539e-06 -0.020989965 -0.0026192105 -2.8500766e-05 -0.00016429533 4.6604053 0 1.0958066 0.20116436 0.30957174 0.30957174 0.00011085812 2.7593611e-08 -0.0043869763 0.0013523686 -0.0020069452 0.0012872287 -11.841318 0 3.1737872 4.5200759 0.30957174 0.30957174 1.8772866e-05 5.7042228e-06 --0.0056342604 0.00030298835 0.0095444749 0.0024882387 8.6364683 0 4.6311813 2.1981448 0.30957174 0.30957174 4.321117e-06 9.7980874e-05 -0.0089377446 -0.00048574363 -0.0012470828 0.0026365725 -10.35786 0 1.4853996 3.9608494 0.30957174 0.30957174 1.0918675e-05 8.4631988e-06 -0.011241051 0.00052048662 -0.0002729474 0.0021840918 22.429661 0 2.3442411 3.641222 0.30957174 0.30957174 1.6339344e-05 4.8067928e-06 -0.015646642 0.0016379455 0.0051873787 0.00092868749 -12.931325 0 2.706749 2.1208452 0.30957174 0.30957174 5.1314553e-05 2.798374e-05 --0.0037509496 -0.0010005004 -0.00014836085 0.0021723634 -22.056205 0 6.2670518 3.5846358 0.30957174 0.30957174 1.0663016e-05 4.7031945e-06 --0.0013010728 -2.0138694e-05 -0.00098993258 0.0029174219 7.882167 0 5.2267656 3.845498 0.30957174 0.30957174 1.8952391e-07 9.4304838e-06 -0.0091787967 0.0010020076 -0.00062120898 0.0045182714 -15.079567 0 2.7277017 3.6536243 0.30957174 0.30957174 1.8394736e-05 2.0638751e-05 -0.020259352 -0.0012129461 0.005385601 0.011034874 -1.5825681 0 1.4458021 3.0586406 0.30957174 0.30957174 5.8459078e-05 0.00015002497 --0.0071001679 0.0029476914 -0.00071521909 0.0010970957 12.21381 0 3.7743987 4.0973373 0.30957174 0.30957174 8.4684443e-05 1.709595e-06 --0.0060657486 -0.0011389116 0.0027488238 -0.0013260706 21.433612 0 6.1284195 1.4987858 0.30957174 0.30957174 1.5855009e-05 9.3618719e-06 --0.0048040233 -0.0013208484 0.00044563564 -0.0037912709 24.326537 0 6.2776112 0.49225095 0.30957174 0.30957174 1.8426091e-05 1.4457721e-05 -0.0071177252 -0.00120085 0.0069877735 -0.0020156044 3.0624776 0 0.95114952 1.6664265 0.30957174 0.30957174 1.8697615e-05 5.3256833e-05 -0.0025185412 0.0030263734 0.00072183484 0.0042769926 3.5824953 0 3.4247896 3.3473595 0.30957174 0.30957174 8.4128516e-05 1.8670047e-05 -0.0019102519 -0.00045126493 -0.00082014571 0.0023353428 24.081788 0 0.80930925 3.8561724 0.30957174 0.30957174 2.2556169e-06 6.0878495e-06 -0.032833724 -0.00065866695 -0.00049821523 0.0032188119 -16.445604 0 1.7643506 3.6706887 0.30957174 0.30957174 0.0001222975 1.0527216e-05 -0.0057325922 -0.00019239446 0.0017352374 -0.0052755785 11.353311 0 1.6483963 0.69449016 0.30957174 0.30957174 3.9447482e-06 3.0642279e-05 -0.024211761 0.0010545912 -0.0049076339 -0.0072570044 -16.769608 0 2.3228214 6.0590966 0.30957174 0.30957174 7.4483413e-05 7.6519483e-05 --0.021871602 -0.00057798046 -0.0044809873 0.0035206571 -18.959009 0 5.3229196 4.4246766 0.30957174 0.30957174 5.5556782e-05 3.2537731e-05 --0.011367043 -0.00010271629 0.0023326796 0.0059791627 -2.6900636 0 5.1688194 3.1411626 0.30957174 0.30957174 1.4280357e-05 4.0947065e-05 --0.012739857 0.00099441218 0.0036342345 -0.0014072254 6.8039924 0 4.468596 1.5783869 0.30957174 0.30957174 2.6825098e-05 1.5279598e-05 -0.034953244 0.0021257732 0.0019614487 -0.0072551365 16.56231 0 2.4510138 0.6403938 0.30957174 0.30957174 0.00017528223 5.6090033e-05 -0.016214422 -9.3444979e-05 -0.0011236811 0.0019061125 -13.098614 0 1.8926467 4.0521256 0.30957174 0.30957174 2.8940735e-05 4.876839e-06 -0.0023550259 0.00071417948 -0.0012215957 0.00074203656 -14.834172 0 3.1685745 4.5444184 0.30957174 0.30957174 5.2550982e-06 2.050627e-06 --0.029470525 -0.001525798 0.00032370617 0.0013623854 10.687095 0 5.5273812 3.2807835 0.30957174 0.30957174 0.00011654979 1.9467258e-06 --0.0079786171 0.00098096619 0.0032964965 -7.1179262e-05 15.55135 0 4.244751 1.9236821 0.30957174 0.30957174 1.5754125e-05 1.0960499e-05 -0.0098677479 -3.1578587e-05 0.0072456661 0.0024594303 -22.662318 0 1.9159532 2.2698651 0.30957174 0.30957174 1.0698339e-05 5.8927531e-05 -0.025289953 -0.0011033247 0.0090436594 -0.0015957087 15.593878 0 1.5668209 1.7718332 0.30957174 0.30957174 8.1300439e-05 8.4980189e-05 --0.0039702062 -0.00010208599 -0.0068584128 0.0037460136 7.6004248 0 5.316771 4.5901819 0.30957174 0.30957174 1.8252978e-06 6.1340421e-05 -0.017155873 -0.0020103336 4.7121972e-05 0.0049632425 -19.630356 0 1.1270894 3.5063216 0.30957174 0.30957174 6.9125012e-05 2.4436829e-05 --0.01841533 0.00093369862 0.0040474151 -0.0048442191 -20.029835 0 4.6540116 1.0743219 0.30957174 0.30957174 4.5169547e-05 3.979182e-05 -0.0052544966 -0.00089073952 0.0036705427 0.0076634111 -10.304087 0 0.94897059 3.0660395 0.30957174 0.30957174 1.0258447e-05 7.1835715e-05 -0.0088762496 -0.00028023864 -0.0017251458 0.0063908838 -16.97112 0 1.6650555 3.7815974 0.30957174 0.30957174 9.3644818e-06 4.3513531e-05 -0.013807662 0.00032523897 0.0054031821 0.0032188081 15.349896 0 2.1564627 2.4788037 0.30957174 0.30957174 2.1892747e-05 3.9709314e-05 --0.037230381 0.0017401276 -0.0011181326 -0.0026580368 5.8969492 0 4.6841689 6.2563858 0.30957174 0.30957174 0.00017974563 8.2684436e-06 --0.0078303997 0.0014077373 -0.0064686923 0.0056228603 3.1138752 0 4.0640873 4.3751471 0.30957174 0.30957174 2.4783268e-05 7.3545995e-05 --0.012383044 -0.0013096739 0.0067241086 -0.00057649238 1.4417226 0 5.8534689 1.8602588 0.30957174 0.30957174 3.2457999e-05 4.5911865e-05 --0.0014513278 -8.2819355e-05 -0.0080978191 0.0057009663 -20.875483 0 5.5660687 4.4770917 0.30957174 0.30957174 2.9371068e-07 9.8347443e-05 -0.015283191 0.0011249041 0.001540188 0.0048848772 8.1035344 0 2.5357391 3.2081257 0.30957174 0.30957174 3.7168353e-05 2.6060596e-05 --0.023517002 -0.0012639883 -0.0024144457 -0.0029058868 4.7645576 0 5.5419899 5.9602028 0.30957174 0.30957174 7.5265843e-05 1.4252969e-05 -0.016013545 0.00030985298 -0.012113946 -0.0012950778 8.804857 0 2.1195658 5.192338 0.30957174 0.30957174 2.9025092e-05 0.0001496076 -0.025464976 -0.00019458809 -0.001404412 -0.0031681345 -5.2217578 0 1.8756003 6.237207 0.30957174 0.30957174 7.1531462e-05 1.1944369e-05 --0.035200183 0.0008365089 -0.0030168857 0.0002017401 -8.563374 0 4.8735006 5.0204567 0.30957174 0.30957174 0.00014239376 9.2161636e-06 -0.028195612 -0.00065194831 -0.0010538769 -0.00048180835 6.1261969 0 1.7375011 5.5124337 0.30957174 0.30957174 9.1143708e-05 1.3499726e-06 --0.0062569204 0.0020604587 0.0060720116 0.0049481697 10.572295 0 3.8376637 2.6248932 0.30957174 0.30957174 4.2971434e-05 6.1456281e-05 --0.015583813 0.00073490064 -0.0017878647 0.012462095 22.15158 0 4.6809461 3.6595306 0.30957174 0.30957174 3.15797e-05 0.00015727057 -0.0041688218 0.00027649829 -0.0026295234 0.00068594459 -14.824679 0 2.4885854 4.8334892 0.30957174 0.30957174 2.6042464e-06 7.4374731e-06 --0.0021428674 0.00042526166 0.0054543207 0.0086359552 6.6759463 0 4.0211587 2.948902 0.30957174 0.30957174 2.1514907e-06 0.00010396881 --0.013502175 0.0037384788 0.0073174259 -0.001559783 -18.915426 0 3.8933602 1.736729 0.30957174 0.30957174 0.00014732799 5.6394458e-05 -0.0017613117 8.0180792e-05 0.0047130546 -0.012234233 7.1352542 0 2.3382016 0.7447454 0.30957174 0.30957174 3.9911608e-07 0.00017086015 --0.011284586 -0.0015046755 -0.0060216637 -0.0047350254 10.963165 0 5.9687024 5.7490991 0.30957174 0.30957174 3.4603279e-05 5.8795198e-05 -0.014271095 -0.00018739514 -0.0012386135 0.003309964 -23.007814 0 1.8260461 3.8766417 0.30957174 0.30957174 2.2677531e-05 1.2413943e-05 -0.0013682441 -0.0007094407 -0.0084832454 0.0038992503 -23.334327 0 0.58293781 4.6589192 0.30957174 0.30957174 4.7903176e-06 8.7633313e-05 -0.0015108797 -0.0013693354 0.0021077665 -0.0047622646 -6.166828 0 0.49483742 0.79399418 0.30957174 0.30957174 1.7331399e-05 2.6974678e-05 --0.013457886 0.0016048625 0.0020137634 0.0097887685 -0.77365236 0 4.2599497 3.3113933 0.30957174 0.30957174 4.334419e-05 9.9133502e-05 -0.01238455 0.00042714624 -0.004587901 -0.0080648406 7.5287166 0 2.2495155 6.1367686 0.30957174 0.30957174 1.8499317e-05 8.5736158e-05 --0.0015010067 0.0040948092 -0.001738796 -0.004425102 -3.8416252 0 3.5561114 6.2803092 0.30957174 0.30957174 0.00015298846 2.2471251e-05 -0.001004869 -0.00020555366 0.011244888 -0.0017492616 1.2561917 0 0.86684048 1.7920012 0.30957174 0.30957174 4.9574081e-07 0.00013051346 -0.0090979762 0.0029928363 -0.0021441856 -0.0074282392 -0.31389923 0 3.1938007 0.09111485 0.30957174 0.30957174 9.0679907e-05 5.9367579e-05 -2.4477011e-05 0.0025133125 0.0027248806 0.0057879033 9.2969096 0 3.5148238 3.0727492 0.30957174 0.30957174 5.7541629e-05 4.071445e-05 -0.0071297603 -0.00079993767 -0.0084782596 -0.0078965573 9.9781627 0 1.1487967 5.8325302 0.30957174 0.30957174 1.1409439e-05 0.00013431826 -0.0030667126 -0.00070803946 -0.0034958762 -0.00084979659 -6.9671456 0 0.81813544 5.3232928 0.30957174 0.30957174 5.5991343e-06 1.3037089e-05 --0.018885988 -0.0004448571 -0.0063961112 -0.0072715879 -20.867131 0 5.2980546 5.9320262 0.30957174 0.30957174 4.0958043e-05 9.3692172e-05 -0.012370334 -0.0039038758 -0.00060426141 -0.0022218872 -9.1805531 0 0.70906185 0.10670067 0.30957174 0.30957174 0.00015562779 5.2649727e-06 -0.0083616499 0.00071006287 0.0033464779 -0.0033315418 18.416989 0 2.6035058 1.1659942 0.30957174 0.30957174 1.2268149e-05 2.2299629e-05 -0.013636642 0.0018580239 0.0035892242 0.0008456233 8.5697831 0 2.8376926 2.174672 0.30957174 0.30957174 5.186178e-05 1.3696843e-05 -0.0013918237 -0.00017630239 0.0052534049 -0.0032306255 12.345059 0 1.0883742 1.3973668 0.30957174 0.30957174 4.9579956e-07 3.8175788e-05 --0.012349908 -0.0016042729 0.0042060484 -0.0025708394 -11.698206 0 5.9558559 1.4000707 0.30957174 0.30957174 4.0187938e-05 2.4390829e-05 --0.011744646 -0.0017335361 -0.007929449 -0.0054556894 -4.7894509 0 6.018006 5.6855499 0.30957174 0.30957174 4.2517298e-05 9.2912589e-05 --0.0050587075 -0.0020389667 0.0010123699 0.0035420426 8.9804465 0 0.10839159 3.2353473 0.30957174 0.30957174 4.068044e-05 1.3477867e-05 -0.0084688584 0.00034933445 -0.00893289 -0.0003240462 -3.6991625 0 2.3045294 5.122656 0.30957174 0.30957174 8.9850364e-06 8.0551165e-05 -0.011767565 0.0016166536 0.0049018751 0.013891281 24.741365 0 2.8417237 3.1741041 0.30957174 0.30957174 3.9009416e-05 0.00021563164 -0.01162474 9.3573134e-05 0.00069313566 -0.0032328654 22.156832 0 2.0182914 0.58717598 0.30957174 0.30957174 1.491443e-05 1.0851264e-05 --0.017193866 0.00054491304 -0.0052686644 0.006342781 -22.634409 0 4.8056341 4.213042 0.30957174 0.30957174 3.5158116e-05 6.7890678e-05 -0.01290707 0.00022604246 0.0060554094 -0.0011230733 3.4576672 0 2.1032967 1.7631643 0.30957174 0.30957174 1.8753464e-05 3.8217988e-05 -0.0074396144 -0.00021421599 -0.00019163048 -0.002458397 -13.089348 0 1.68858 0.29587665 0.30957174 0.30957174 6.4939376e-06 6.0318687e-06 --0.010530158 0.0001801455 -0.0036582177 -2.6486871e-06 -5.4779554 0 4.9320934 5.0874074 0.30957174 0.30957174 1.2468157e-05 1.3491656e-05 -0.01153541 -0.0027869009 0.011225085 0.0040976904 -19.858421 0 0.80079379 2.2925064 0.30957174 0.30957174 8.5358406e-05 0.00014368497 --0.0047169043 -0.00030409428 0.0075124865 0.00072342574 -8.5386853 0 5.6176979 2.0403255 0.30957174 0.30957174 3.2848232e-06 5.7416633e-05 --0.014788817 -0.0017188646 0.0028304922 0.0040664592 -15.415511 0 5.9006204 2.9040053 0.30957174 0.30957174 5.0922841e-05 2.4479377e-05 -0.0030860445 -0.00098468247 -0.00061432708 -0.0045280409 17.530797 0 0.70566161 0.23836609 0.30957174 0.30957174 9.8779277e-06 2.0717843e-05 -0.00014645993 -0.0012125922 0.002568005 -0.004116767 -19.62696 0 0.38755863 0.93568246 0.30957174 0.30957174 1.3396599e-05 2.3459141e-05 --0.010676766 0.0038650347 -0.0038902747 -0.0036103476 20.61015 0 3.8103267 5.8307374 0.30957174 0.30957174 0.00014859421 2.8186822e-05 -0.018207157 0.00056821378 -0.0050070732 0.0049622782 19.977662 0 2.222077 4.3098433 0.30957174 0.30957174 3.9332252e-05 4.970025e-05 --0.025842719 0.0017895983 0.0040854616 0.0060768877 -15.405269 0 4.5239151 2.920239 0.30957174 0.30957174 0.0001024884 5.3457022e-05 -0.018484001 -0.0013454741 -0.0082203516 -0.00039339504 22.786876 0 1.359579 5.1341229 0.30957174 0.30957174 5.399693e-05 6.8278539e-05 -0.0025788244 0.0039399296 -0.00049510026 0.0015241554 17.729181 0 3.4441632 3.8323697 0.30957174 0.30957174 0.00014213532 2.5513884e-06 --0.0015810198 -0.0014187721 0.0009391008 -0.0025292947 -1.7682753 0 0.25257422 0.73247137 0.30957174 0.30957174 1.8610797e-05 7.2347031e-06 --0.021046567 -0.0021511418 -0.0016286117 -0.0053125874 -19.118721 0 5.8364006 0.074555928 0.30957174 0.30957174 9.0779429e-05 3.066937e-05 --0.012851431 -0.0007422653 -0.0012089224 -0.0054504257 7.1836196 0 5.5710248 0.15430791 0.30957174 0.30957174 2.3149571e-05 3.094034e-05 -0.010452548 -0.001089566 -0.0085197998 -0.00061134474 21.347311 0 1.1855679 5.157745 0.30957174 0.30957174 2.2808002e-05 7.3549422e-05 -0.0050707534 -0.0012939826 0.0053585438 -0.0027158338 -12.215635 0 0.78055456 1.4792714 0.30957174 0.30957174 1.8075303e-05 3.6264176e-05 --0.025672776 -0.00087491463 -0.0026212119 -0.0063063852 -7.3947615 0 5.3876988 6.2606804 0.30957174 0.30957174 7.9326082e-05 4.6375675e-05 -0.0027601923 0.00067624987 0.0066147806 0.0011123545 -10.003464 0 3.0946472 2.1103772 0.30957174 0.30957174 5.0021982e-06 4.5339334e-05 -0.017214708 -0.00064095949 0.0059024447 0.0067112173 4.0915634 0 1.6181008 2.7904977 0.30957174 0.30957174 3.6274388e-05 7.9799099e-05 --0.0091108211 0.00035198345 0.0046407087 -0.0031069508 -6.6776177 0 4.7482982 1.3588829 0.30957174 0.30957174 1.0240848e-05 3.1286824e-05 -0.012709992 -0.0010412132 -0.0023175499 -9.4766706e-05 -5.9704595 0 1.3040012 5.1272273 0.30957174 0.30957174 2.7609507e-05 5.4237293e-06 -0.0091150315 0.00029080564 -0.00041389637 0.0015562684 -23.153471 0 2.2279307 3.7778539 0.30957174 0.30957174 9.8910508e-06 2.5750943e-06 -0.013868303 -0.0022391275 -0.0017111584 0.0011176605 16.094299 0 0.97142011 4.5118067 0.30957174 0.30957174 6.6784998e-05 4.1909966e-06 --0.011540197 0.001615573 0.0072483357 0.00043310206 15.869831 0 4.1808929 2.0042961 0.30957174 0.30957174 3.8395845e-05 5.3152712e-05 -0.0064506613 -0.00029964431 0.0011665496 0.0050134162 -12.106465 0 1.5447972 3.2854768 0.30957174 0.30957174 5.385835e-06 2.6303041e-05 --0.001133988 -0.001922689 0.0038975814 -0.0039752064 -13.349494 0 0.30964484 1.1538977 0.30957174 0.30957174 3.3816099e-05 3.0989466e-05 --0.0023965421 0.00079463942 0.0063277396 0.0030559347 21.073713 0 3.8356095 2.391834 0.30957174 0.30957174 6.3826271e-06 4.9629914e-05 -0.0061861358 0.0011231216 -0.0031356845 -0.0074239705 18.184098 0 2.9720614 6.2549239 0.30957174 0.30957174 1.5691563e-05 6.4582353e-05 --0.013395025 0.0033130127 -0.0042317962 -0.00038953619 16.448663 0 3.9336169 5.1777423 0.30957174 0.30957174 0.00011968193 1.8204594e-05 --0.013250636 0.00071315053 -0.0028980328 0.00079231787 -14.192335 0 4.6308579 4.8218706 0.30957174 0.30957174 2.3907455e-05 9.0897491e-06 --0.015132346 0.00096286675 0.0044037866 -0.002625451 -15.902652 0 4.5613846 1.4110545 0.30957174 0.30957174 3.3583018e-05 2.6388684e-05 -0.004991469 0.00079654258 -0.0031357703 -0.0031703778 -22.534493 0 2.9133282 5.873516 0.30957174 0.30957174 8.5147859e-06 1.9883234e-05 -0.015945187 0.0011579975 -0.0016010172 -0.004944036 -12.446491 0 2.5295527 0.058741407 0.30957174 0.30957174 4.0125984e-05 2.6829996e-05 --0.010497805 0.0018731168 0.015866296 0.010310399 -13.270657 0 4.0674434 2.5176492 0.30957174 0.30957174 4.405871e-05 0.00035923622 --0.011902925 -1.8475564e-05 -0.0013130379 0.0061725962 23.739064 0 5.1008278 3.7271477 0.30957174 0.30957174 1.5556273e-05 3.9530987e-05 -8.6969726e-05 0.001316022 -0.014227237 0.0066351287 3.6128438 0 3.5086384 4.6534091 0.30957174 0.30957174 1.5777487e-05 0.00024773326 --0.0078710561 -0.0022206632 -0.0039441244 0.0031242558 20.400752 0 0.0032252853 4.420714 0.30957174 0.30957174 5.172255e-05 2.5364976e-05 --0.0085462767 0.0017373164 -0.0043757103 -0.0023348169 23.948556 0 4.0110412 5.5734788 0.30957174 0.30957174 3.5512527e-05 2.4710213e-05 --0.017575034 -0.0016621248 -0.0042113866 -0.0053377094 -20.505359 0 5.7978228 5.985544 0.30957174 0.30957174 5.9074219e-05 4.6141121e-05 -0.0053669835 -1.2251461e-05 -0.0036611177 -0.00058033787 -18.368521 0 1.9243052 5.2426446 0.30957174 0.30957174 3.1634401e-06 1.3847116e-05 -0.0058223018 -0.0035050892 0.0063986485 0.0073179351 -21.700686 0 0.55466901 2.7933896 0.30957174 0.30957174 0.00011563597 9.4395617e-05 --0.0061358485 0.00037221452 -0.0033462563 0.011462912 11.720994 0 4.5818555 3.8021121 0.30957174 0.30957174 5.3950005e-06 0.00014162459 -0.0027798716 -0.00011858513 -0.0024903073 0.0064514985 0.50540561 0 1.574463 3.887012 0.30957174 0.30957174 9.7642215e-07 4.753747e-05 --0.0064007327 0.0021901296 0.002885934 -0.00064914435 -1.3581958 0 3.8263461 1.7255769 0.30957174 0.30957174 4.8192149e-05 8.8144889e-06 -0.011063322 0.0031030012 -0.0054137244 0.0089664141 11.877907 0 3.1428269 4.0626849 0.30957174 0.30957174 0.00010114708 0.00010929383 -0.0093172646 -0.0013440706 -0.0013125537 0.0050469718 -21.558625 0 1.0247966 3.7723089 0.30957174 0.30957174 2.598622e-05 2.7002802e-05 --0.00037145215 -0.00073069 -0.0051943677 0.0039717335 11.776066 0 0.31855207 4.4378081 0.30957174 0.30957174 4.8787147e-06 4.2848518e-05 -0.0069566103 -0.0015778194 -0.0026587654 0.0082641003 1.0324054 0 0.8250719 3.8295344 0.30957174 0.30957174 2.7990515e-05 7.4869785e-05 --0.0021677062 0.00042273426 0.018075871 -0.0064465982 -19.571238 0 4.0285991 1.6050784 0.30957174 0.30957174 2.143721e-06 0.00037062319 -0.016485626 -0.0029901248 0.0010184352 -0.012995914 7.8925251 0 0.91856363 0.45314112 0.30957174 0.30957174 0.00011128027 0.0001685738 -0.0025622592 -0.0015082856 -0.003726175 -0.0013349332 -5.1702915 0 0.55867038 5.4281324 0.30957174 0.30957174 2.1443857e-05 1.57652e-05 -0.010081323 -0.00018976287 0.01066979 -0.010739598 -19.352562 0 1.7752803 1.1604972 0.30957174 0.30957174 1.1485001e-05 0.00022917881 --0.018411212 0.0011426445 -0.0019885344 0.011310303 19.722824 0 4.5721374 3.6913203 0.30957174 0.30957174 4.9104941e-05 0.00013087509 --0.028600285 -0.00010540008 0.0029407046 -0.001675557 11.885374 0 5.1202473 1.4306785 0.30957174 0.30957174 8.9896178e-05 1.1503028e-05 -0.0051122228 -0.0020941868 0.005147899 -0.0022803159 0.12052382 0 0.63613031 1.5311103 0.30957174 0.30957174 4.2819253e-05 3.1874689e-05 -0.031723623 -0.00051266035 -0.01042609 -0.0044201196 -19.590873 0 1.7989369 5.4847592 0.30957174 0.30957174 0.00011287241 0.00012896895 -0.03156169 -0.00071885492 0.00054380077 -0.0063258282 15.611413 0 1.7405222 0.46075018 0.30957174 0.30957174 0.00011406057 3.9990667e-05 --0.0060296969 -3.2528248e-05 0.0015811844 -2.1573355e-05 1.3884741 0 5.1357919 1.931564 0.30957174 0.30957174 4.0008276e-06 2.5209865e-06 --0.012607289 -0.00020017198 0.0017225054 0.0014865457 -23.041777 0 5.2303271 2.6530841 0.30957174 0.30957174 1.7813368e-05 5.1831613e-06 --0.024776662 0.005355356 -0.0031288905 0.00046388242 -8.9469527 0 3.985829 4.9406768 0.30957174 0.30957174 0.00032864568 1.0083208e-05 --0.015909354 0.0029909323 -0.0065347131 -0.0013561243 5.0898636 0 4.0444089 5.2897017 0.30957174 0.30957174 0.00010927492 4.487478e-05 --0.0066314944 0.0021964072 0.00029489759 0.0089781333 -9.507375 0 3.8359419 3.4827911 0.30957174 0.30957174 4.8773129e-05 8.0042774e-05 -0.0027586513 0.00083778712 -0.011238666 0.0022938714 17.248822 0 3.169035 4.8869343 0.30957174 0.30957174 7.2291757e-06 0.00013255655 --0.0012323767 -0.00059646084 -0.0050347759 -0.0065696525 23.592115 0 0.1512584 5.9996667 0.30957174 0.30957174 3.4075264e-06 6.8366953e-05 -0.013597312 -0.0013385145 -0.0051431999 -0.0022479933 -21.85574 0 1.2140945 5.4957765 0.30957174 0.30957174 3.6616881e-05 3.1680752e-05 -0.0052694802 0.0021613999 -0.0027561373 -0.0079002521 19.984508 0 3.2543861 0.036102078 0.30957174 0.30957174 4.5604039e-05 6.9567528e-05 -0.0011717153 0.0015006851 -0.0067115739 0.0054472392 -13.321326 0 3.4303895 4.4088729 0.30957174 0.30957174 2.0665539e-05 7.484491e-05 --0.0094230938 0.0010079608 0.005066192 -0.0038287068 9.6454454 0 4.3142546 1.301835 0.30957174 0.30957174 1.9002605e-05 4.0415992e-05 --0.018826026 0.00024358969 -0.0039453005 -0.0031492127 20.475953 0 4.9693645 5.7563883 0.30957174 0.30957174 3.9447595e-05 2.5529631e-05 -0.010602861 -0.0011207423 -0.0016072265 0.0049677814 13.915117 0 1.1786081 3.8311803 0.30957174 0.30957174 2.3783156e-05 2.7083536e-05 --0.013003673 0.0023645467 0.0029277976 0.00015694181 10.40832 0 4.059037 1.9982172 0.30957174 0.30957174 6.9494063e-05 8.6663075e-06 -0.011388007 -0.00029646772 0.0027402944 0.0086289498 8.9480728 0 1.7122506 3.2060461 0.30957174 0.30957174 1.5037268e-05 8.1427138e-05 --0.0079288251 0.0014298171 -0.0039501044 0.011008111 8.9685179 0 4.0627222 3.8630065 0.30957174 0.30957174 2.5524268e-05 0.0001359292 -0.0083753594 0.0015082098 0.011314123 -0.0078121573 -10.266843 0 2.9684362 1.3445801 0.30957174 0.30957174 2.8421559e-05 0.00018958922 -0.023057312 -0.0017202113 -0.0015832262 0.0026879051 24.758518 0 1.3481845 4.0517561 0.30957174 0.30957174 8.5317604e-05 9.6934535e-06 -0.0027387518 0.0019919403 -0.011363489 -0.0068256997 -24.815348 0 3.3660894 5.624024 0.30957174 0.30957174 3.6967834e-05 0.00017639496 -0.022413022 0.00031637823 0.006515279 -0.0033569447 11.942175 0 2.0729812 1.4726277 0.30957174 0.30957174 5.6057573e-05 5.3972852e-05 --0.010919355 0.0041450719 -0.0029158519 0.00048008833 -22.792045 0 3.7973987 4.9248021 0.30957174 0.30957174 0.00016960282 8.8001214e-06 -0.0019157398 0.00030133437 -0.00029068488 -0.002124664 4.7528218 0 2.9065713 0.2372353 0.30957174 0.30957174 1.2300413e-06 4.5628824e-06 --0.0029754198 0.0017937076 0.0035380987 3.0875996e-05 15.541296 0 3.6960184 1.9537525 0.30957174 0.30957174 3.0280259e-05 1.2621133e-05 -0.0049700346 3.3315262e-06 0.00065196263 0.00058966758 -4.9032446 0 1.9512027 2.6763275 0.30957174 0.30957174 2.7117295e-06 7.7341656e-07 --0.027621888 -0.0021190714 -0.002999143 0.0077369712 -11.617054 0 5.6966397 3.8884413 0.30957174 0.30957174 0.00012466174 6.8444879e-05 --0.0032906488 -0.003388785 0.0063790987 0.00048318096 -15.456779 0 0.26810335 2.0200876 0.30957174 0.30957174 0.00010579955 4.1256196e-05 --0.014972869 0.0017851426 0.0013015844 0.0072318273 24.338238 0 4.2600565 3.3363986 0.30957174 0.30957174 5.3639718e-05 5.3584372e-05 -0.021192248 0.0004801602 -0.0085387371 0.0015761126 -19.255885 0 2.1486329 4.9056037 0.30957174 0.30957174 5.1402297e-05 7.5968422e-05 --0.016043318 0.0017796499 -0.00021175173 0.0019498575 -5.0989056 0 4.2960769 3.6249424 0.30957174 0.30957174 5.7106084e-05 3.8164066e-06 --0.010469049 -3.9146715e-05 -0.0067861311 0.00024870934 -13.091355 0 5.1207386 5.0503519 0.30957174 0.30957174 1.2045628e-05 4.6488333e-05 -0.0021066517 -0.0034411423 0.00033671237 0.0016330024 21.24799 0 0.44140435 3.3109387 0.30957174 0.30957174 0.00010835551 2.7594336e-06 -0.0046369716 0.0018873329 0.00033572843 0.0017971098 -13.510377 0 3.2524513 3.3297349 0.30957174 0.30957174 3.4808202e-05 3.3171218e-06 -0.022672096 -0.00059776664 0.0057423182 -0.00036935229 -7.2428173 0 1.7093857 1.8813819 0.30957174 0.30957174 5.9683012e-05 3.3378335e-05 -0.004742904 0.001301794 0.0090909634 0.0047641087 -8.5354985 0 3.1354235 2.4244674 0.30957174 0.30957174 1.7906814e-05 0.00010583253 --0.0001543887 -0.0018017436 0.0082433409 -0.0017444636 -18.90555 0 0.36489392 1.7381908 0.30957174 0.30957174 2.9574203e-05 7.1525151e-05 -0.0046610291 -0.00057149597 -0.0015329016 -0.0039215882 5.1192834 0 1.1045256 6.2820979 0.30957174 0.30957174 5.3601183e-06 1.7623445e-05 -0.020126593 -0.00096124555 -0.0019593248 -0.0024471149 13.823437 0 1.534733 5.9783733 0.30957174 0.30957174 5.2885438e-05 9.8101979e-06 -0.007736798 -0.00097157903 0.010287236 0.0078897908 7.5189796 0 1.0926583 2.5954411 0.30957174 0.30957174 1.5169976e-05 0.00016843537 -0.0034075217 -0.003768227 0.0034225316 -0.0056636527 -6.8471585 0 0.47324494 0.9214743 0.30957174 0.30957174 0.00013062355 4.3626802e-05 --0.014671165 0.0017783963 0.0059380331 -0.0018660666 -20.502457 0 4.2518059 1.6429265 0.30957174 0.30957174 5.2438906e-05 3.9001719e-05 -0.00098328443 -0.00034825182 0.00041831976 0.0043084535 -4.5163095 0 0.67486388 3.4183195 0.30957174 0.30957174 1.2109168e-06 1.8589093e-05 -0.020593657 0.0026041674 -0.0048333577 -0.0042477082 9.2585316 0 2.8009772 5.8036617 0.30957174 0.30957174 0.00010833323 4.1448915e-05 -0.0044112432 0.00025861092 -0.0015138049 -0.0044462624 -14.866502 0 2.4356046 0.043658353 0.30957174 0.30957174 2.7453894e-06 2.1919684e-05 -0.0049247567 -0.00061752221 -0.00065687865 -0.0035217312 -16.315056 0 1.093399 0.18842878 0.30957174 0.30957174 6.1361588e-06 1.2737312e-05 --0.009578274 -0.0006690243 9.6005015e-05 0.0097842376 -1.6223199 0 5.6533537 3.506001 0.30957174 0.30957174 1.4148605e-05 9.4966527e-05 --0.011096875 0.0019758842 0.0020624531 -0.0034560268 -23.596959 0 4.0683745 0.91592093 0.30957174 0.30957174 4.9082092e-05 1.6135931e-05 -0.011855505 0.00050239775 0.00032205242 0.0043131694 8.6433887 0 2.3134985 3.4407587 0.30957174 0.30957174 1.7728723e-05 1.8557568e-05 --0.0035506018 0.00046528071 -0.00048465941 0.0010098783 -7.8622786 0 4.2132138 3.9665217 0.30957174 0.30957174 3.3559875e-06 1.2484173e-06 -0.005861193 0.00066509006 -0.0082616559 -0.0047490996 17.516224 0 2.7470509 5.6048998 0.30957174 0.30957174 7.8007185e-06 9.1182936e-05 --0.00093337825 -0.0012471209 0.0034813919 -0.0043041902 -18.8596 0 0.29232439 1.05838 0.30957174 0.30957174 1.4263546e-05 3.0595143e-05 -0.016920362 0.0012282895 0.00057087233 -0.0019860605 6.1155417 0 2.5293547 0.65635722 0.30957174 0.30957174 4.5172277e-05 4.2410941e-06 --0.020546669 0.00078818057 0.0041086576 -5.8597125e-05 14.70257 0 4.7505132 1.930951 0.30957174 0.30957174 5.2003078e-05 1.7022084e-05 -0.005545677 0.0021370973 -0.0010749673 0.00049689998 11.722064 0 3.2383771 4.6567819 0.30957174 0.30957174 4.4980348e-05 1.4098877e-06 --0.012114996 -0.002074438 0.010063366 0.0024125755 5.5384817 0 6.0873837 2.1785603 0.30957174 0.30957174 5.531263e-05 0.00010787033 --0.011114422 0.00070594123 -0.0071780895 -0.00030095409 5.5318385 0 4.5621618 5.1282531 0.30957174 0.30957174 1.8100478e-05 5.2034831e-05 -0.022684891 0.0021969554 0.0025187084 0.0005920706 -22.781087 0 2.667997 2.1741721 0.30957174 0.30957174 0.00010045915 6.7433191e-06 --0.0033289174 -0.00041731901 -0.002356611 -0.00578976 -19.035524 0 5.9382697 6.2680897 0.30957174 0.30957174 2.8029597e-06 3.8849159e-05 --0.0016325315 -0.0027857292 0.0035610556 -0.0073850166 -19.605704 0 0.31005577 0.82679115 0.30957174 0.30957174 7.098395e-05 6.688197e-05 -0.010443281 0.0010076535 -0.0017709921 -0.011365734 9.0432052 0 2.6661579 0.21848488 0.30957174 0.30957174 2.1221859e-05 0.00013129735 -0.010012037 0.0034501865 -0.00052345212 0.0068447809 7.4848134 0 3.2074968 3.5928387 0.30957174 0.30957174 0.00011944022 4.674843e-05 -0.013649525 0.0013257316 -0.00082379162 0.002065795 -24.091118 0 2.6694291 3.8981462 0.30957174 0.30957174 3.6462816e-05 4.9171673e-06 -0.015659358 -3.0982025e-05 0.009204063 -6.8389999e-06 3.5283707 0 1.9270757 1.9443596 0.30957174 0.30957174 2.6927765e-05 8.5405398e-05 -0.018877434 0.0016914758 0.0025441209 0.0071720496 -20.846373 0 2.6296546 3.1724469 0.30957174 0.30957174 6.5182607e-05 5.7547686e-05 --0.014508612 -0.0027752549 0.0071811844 0.00016436519 -0.82402158 0 6.1364803 1.9677959 0.30957174 0.30957174 9.3268821e-05 5.201659e-05 -0.0096894874 -0.0024337048 -0.00013632711 -0.00029249799 18.996434 0 0.78634403 6.2182245 0.30957174 0.30957174 6.4260642e-05 1.0359987e-07 --0.015451029 0.00036056533 0.0045637427 -0.0012712292 -16.36408 0 4.8772307 1.6755246 0.30957174 0.30957174 2.7391821e-05 2.2600487e-05 -0.00050046958 0.0010596535 -0.0083548602 0.0061938216 -11.542594 0 3.4640921 4.4526308 0.30957174 0.30957174 1.02561e-05 0.00010842594 -0.013221382 -0.00024748216 -0.0018000464 -0.0025318588 -1.4615141 0 1.7762086 6.0356036 0.30957174 0.30957174 1.9747488e-05 9.6250565e-06 --0.030057076 0.0027311983 0.0093466448 8.2116314e-05 -2.7503719 0 4.3952597 1.953811 0.30957174 0.30957174 0.00016712648 8.8078596e-05 -0.00085899976 -0.001272629 -0.0063675467 -0.011379566 9.6196103 0 0.44826244 6.1438655 0.30957174 0.30957174 1.4834409e-05 0.00016932362 --0.010763329 0.0014313443 0.00025640644 0.00027266919 -5.5176665 0 4.2059867 2.7571705 0.30957174 0.30957174 3.1380386e-05 1.4002751e-07 -0.018400016 -0.00047897291 -0.0099792952 0.013308006 -3.93669 0 1.7122697 4.163213 0.30957174 0.30957174 3.9255992e-05 0.00027606914 --0.030180684 -0.0011532213 -0.0016296692 -0.0046647492 18.016537 0 5.4216477 0.035661301 0.30957174 0.30957174 0.00011210771 2.4261409e-05 --0.013465225 -0.002067858 0.00015344428 -0.0063185935 8.8937316 0 6.0368742 0.39877791 0.30957174 0.30957174 5.8855947e-05 3.9625535e-05 --0.026874842 -8.0892055e-05 -0.00093153797 -0.00069366315 -21.952573 0 5.1141012 5.7228685 0.30957174 0.30957174 7.9346824e-05 1.3521147e-06 --0.0096566869 -0.00067629236 -0.0027108527 0.0011125157 -1.4903892 0 5.6545555 4.7000988 0.30957174 0.30957174 1.4403249e-05 8.6363108e-06 -0.0001747055 0.0018214933 -0.0053960004 -0.0048740855 -19.52563 0 3.5053642 5.8172754 0.30957174 0.30957174 3.0226787e-05 5.291879e-05 -0.013679163 0.0010955953 -0.0045450598 0.0047694625 -19.678278 0 2.5754073 4.2812595 0.30957174 0.30957174 3.1475665e-05 4.3389802e-05 --0.014830629 0.0029185423 0.0017366165 8.7757708e-05 -3.3618261 0 4.0247307 1.9951798 0.30957174 0.30957174 0.00010173785 3.0480605e-06 --0.0076557146 -7.5240802e-05 0.010295225 0.00055042198 8.227224 0 5.1759787 1.9980785 0.30957174 0.30957174 6.4855957e-06 0.0001071562 -0.0042059163 -0.0019688183 -0.0026063373 0.0042757499 -4.9716488 0 0.60465036 4.066929 0.30957174 0.30957174 3.7252106e-05 2.498258e-05 -0.011183851 0.0013669188 0.0063019485 -0.0017122731 0.68303435 0 2.7840882 1.681843 0.30957174 0.30957174 3.0751314e-05 4.2946471e-05 --0.016987015 0.0008051465 7.9062659e-05 -0.0010346019 17.472527 0 4.6791034 0.45118977 0.30957174 0.30957174 3.7582358e-05 1.0680479e-06 -0.0043929811 -0.001347521 0.00010528997 0.0057155249 -24.057345 0 0.71797615 3.4973231 0.30957174 0.30957174 1.865943e-05 3.2414258e-05 --0.0082018589 0.00054971053 3.1705217e-05 -0.0075534612 -14.249503 0 4.5385596 0.3785319 0.30957174 0.30957174 1.0137439e-05 5.6594452e-05 -0.0074151701 0.0012507853 0.0037613316 0.0039385167 -23.248718 0 2.9389533 2.7494464 0.30957174 0.30957174 2.0287351e-05 2.964943e-05 --0.029466992 -0.00055511791 -0.00024787201 -0.0088839964 -7.0644569 0 5.256642 0.34617928 0.30957174 0.30957174 9.812687e-05 7.8349153e-05 --0.0064959259 -0.00072558013 0.0010542613 0.0087184166 22.223437 0 5.8807596 3.3945823 0.30957174 0.30957174 9.4280476e-06 7.6516703e-05 -0.012755437 -4.2128957e-05 0.0010744476 -0.0047865241 23.86078 0 1.915019 0.59685488 0.30957174 0.30957174 1.7877013e-05 2.3889407e-05 -0.0020469657 0.00023494436 0.00020917808 0.0064817461 6.0109222 0 2.752757 3.4833695 0.30957174 0.30957174 9.6280025e-07 4.1717433e-05 --0.030722086 -0.00039924752 -0.0032904606 0.00090212615 9.2237425 0 5.2045214 4.8211634 0.30957174 0.30957174 0.00010506466 1.1722642e-05 -0.023014322 -0.0004316054 -0.0016534144 0.00048957277 14.093844 0 1.7758948 4.8010187 0.30957174 0.30957174 5.9841301e-05 2.9938079e-06 -0.014104119 0.0027288473 -0.0071668665 0.0070195553 -24.402832 0 2.9998001 4.3157328 0.30957174 0.30957174 8.9671472e-05 0.00010065842 --0.001890466 -0.00099570068 0.0075170936 0.0062214959 -9.5048507 0 0.16881629 2.6324846 0.30957174 0.30957174 9.4235446e-06 9.5361358e-05 -0.00017786964 -0.00090298488 0.0046619091 0.011857113 12.266157 0 0.39592073 3.1385119 0.30957174 0.30957174 7.4310921e-06 0.0001613649 --0.0045207068 0.0026672221 -0.0008626431 -0.0067169658 -18.116368 0 3.6998517 0.24554216 0.30957174 0.30957174 6.7048265e-05 4.5503034e-05 --0.0015601167 0.0017936869 -0.004630289 0.001832484 5.4981323 0 3.6110864 4.712613 0.30957174 0.30957174 2.9574908e-05 2.4945192e-05 --0.012935902 0.0022929354 0.0063592936 -0.0049327128 -18.740223 0 4.0703985 1.2892959 0.30957174 0.30957174 6.6262844e-05 6.490519e-05 --0.0038972256 -0.0037377334 0.007667729 0.0037820474 -18.944216 0 0.26033497 2.4001104 0.30957174 0.30957174 0.00012893126 7.3461568e-05 -0.02977161 0.0015119586 -0.0035982236 -0.0051162728 -20.675905 0 2.3783972 6.0407295 0.30957174 0.30957174 0.00011812491 3.9017346e-05 --0.0074683932 -0.0006930155 -0.0069181548 0.0068784161 7.442097 0 5.7884411 4.3082306 0.30957174 0.30957174 1.0497985e-05 9.5181061e-05 -0.011229673 0.0013366372 -0.0010557439 -0.0028205967 19.495463 0 2.7709015 0.013471569 0.30957174 0.30957174 3.0118294e-05 9.0151176e-06 --0.012831356 0.00061825268 0.010225523 -0.0037215642 -24.242497 0 4.6730903 1.598651 0.30957174 0.30957174 2.1556026e-05 0.00011915172 -0.0054799568 0.00061737987 0.0034351641 -0.00066585129 15.099378 0 2.7434615 1.7551479 0.30957174 0.30957174 6.768706e-06 1.2336319e-05 -0.014473623 -0.0028212727 -0.0063519164 -0.0002943866 9.9539991 0 0.8872025 5.1326283 0.30957174 0.30957174 9.5503527e-05 4.0761703e-05 -0.0088208967 -0.0040904653 -0.00088296512 -0.0029336547 -1.3175969 0 0.60675006 0.079698413 0.30957174 0.30957174 0.00016095879 9.3227231e-06 --0.014038476 -0.00068201579 -0.0020041694 -0.0082674443 6.4074006 0 5.5033312 0.13460554 0.30957174 0.30957174 2.5871906e-05 7.1847399e-05 --0.020032935 -0.0011237973 -0.0069319191 -0.0028800473 -8.9744453 0 5.5591085 5.4775972 0.30957174 0.30957174 5.5559954e-05 5.667081e-05 -0.018192272 0.0012528695 0.0031371571 -0.0028882611 2.6654073 0 2.5053816 1.2050268 0.30957174 0.30957174 5.0630482e-05 1.8196582e-05 --0.008881003 0.002438668 -0.0014186975 0.0015179607 12.635718 0 3.8962093 4.2715537 0.30957174 0.30957174 6.2832744e-05 4.314683e-06 -0.0078454599 0.0024086251 0.00016930876 0.00020095807 6.1274235 0 3.1724906 2.8117613 0.30957174 0.30957174 5.9604732e-05 6.8956738e-08 -0.024535653 0.00085473453 0.00064201397 -0.0030318056 18.070181 0 2.2523831 0.58462871 0.30957174 0.30957174 7.2740609e-05 9.5330631e-06 --0.0096800389 -0.0013185691 0.0037815519 -0.0013669402 -13.918795 0 5.9791525 1.6008225 0.30957174 0.30957174 2.6124235e-05 1.6270123e-05 -0.0080963994 0.00037477713 0.0043209485 0.002101848 -24.84901 0 2.3441409 2.3946455 0.30957174 0.30957174 8.4755507e-06 2.3204838e-05 -0.0027637646 -0.00250276 -0.0059293265 0.0017422976 -1.5420951 0 0.4949369 4.8030781 0.30957174 0.30957174 5.7897903e-05 3.845456e-05 -0.033983486 0.000999937 -0.0074485542 -0.0047550781 -14.542599 0 2.2069771 5.6511831 0.30957174 0.30957174 0.00013588719 7.8361168e-05 -0.0061131205 0.00096053729 -0.0026074888 -0.0078947125 -22.599439 0 2.9060731 0.052871948 0.30957174 0.30957174 1.2506994e-05 6.8676943e-05 -0.033263155 -0.00052627095 -0.0037180043 -0.0025658909 18.12899 0 1.8019588 5.6869677 0.30957174 0.30957174 0.00012398433 2.0466803e-05 --0.020751727 0.00013522897 0.0020425782 -0.00012759627 -10.139799 0 5.0273974 1.8832126 0.30957174 0.30957174 4.7440307e-05 4.2222852e-06 -0.019704938 0.00012683697 0.0014850207 -0.0028942497 -19.961541 0 2.0036649 0.85167307 0.30957174 0.30957174 4.2771263e-05 1.0532212e-05 -0.0015151296 -0.0017213838 0.0059662074 0.0078321086 5.4293457 0 0.47062489 2.8609884 0.30957174 0.30957174 2.7244567e-05 9.6731721e-05 -0.02078293 0.00097627553 0.0014880885 0.0052435064 22.879339 0 2.349431 3.2372276 0.30957174 0.30957174 5.609827e-05 2.9504502e-05 -0.00049831972 0.00019457784 0.00025134091 0.016761168 -9.8323986 0 3.2418254 3.5007764 0.30957174 0.30957174 3.7214599e-07 0.00027872883 --0.00031007087 -0.0038788013 -0.000324193 0.0092054071 14.316603 0 0.36552494 3.5513828 0.30957174 0.30957174 0.00013706203 8.4160286e-05 --0.0015707735 0.0012379839 -0.0057171705 0.0058623287 8.544998 0 3.6542893 4.2928144 0.30957174 0.30957174 1.4231925e-05 6.7041499e-05 -0.0059326087 0.00093702381 -0.0030566154 -0.00078472603 -3.4227225 0 2.9085072 5.3360438 0.30957174 0.30957174 1.1861851e-05 1.0029875e-05 --0.010027026 -0.00046001101 -0.0015594422 -0.008426517 5.3207621 0 5.4825409 0.18984869 0.30957174 0.30957174 1.2964754e-05 7.2883726e-05 --0.0048508391 0.003603588 -0.00012105842 0.0051980711 -19.003183 0 3.6626035 3.5393676 0.30957174 0.30957174 0.00012087609 2.6816238e-05 --0.0068168188 0.0015068118 -0.0024802121 0.0028607857 20.304473 0 3.9768419 4.2341768 0.30957174 0.30957174 2.5783902e-05 1.4319517e-05 -0.0031618592 0.00032781605 -0.00074081326 -0.0033703201 13.626721 0 2.701931 0.15622738 0.30957174 0.30957174 2.0764037e-06 1.1820488e-05 --0.019298343 -0.0022100216 -0.0023249926 -0.0010823873 7.7749753 0 5.8932248 5.5192962 0.30957174 0.30957174 8.5375789e-05 6.6117449e-06 --0.0017658436 -0.0030919313 0.0037105776 -0.0058415131 -2.3517969 0 0.3116871 0.94388752 0.30957174 0.30957174 8.7428304e-05 4.7727982e-05 --0.0068129564 -0.0017245983 -0.0013011255 -0.00066000371 2.7078467 0 6.2482947 5.5528572 0.30957174 0.30957174 3.2188918e-05 2.1388106e-06 -0.0074359528 4.9367074e-05 0.00439398 0.0047141415 -21.269361 0 2.0054999 2.761581 0.30957174 0.30957174 6.0921432e-06 4.1507884e-05 -0.0038989886 0.0021228719 -0.0041399677 0.0039809642 5.7833054 0 3.3169375 4.3249236 0.30957174 0.30957174 4.2721022e-05 3.2998979e-05 --0.016416178 -0.0013364356 0.0028210115 -0.0011807293 14.722133 0 5.7247871 1.5515866 0.30957174 0.30957174 4.5853796e-05 9.4058276e-06 -0.015727667 -0.00021325875 -0.0019926645 -0.0025404978 -15.166397 0 1.8222008 5.988408 0.30957174 0.30957174 2.756867e-05 1.0405022e-05 -0.013695724 -0.00086358136 -0.0014286905 -0.0046646608 0.76765425 0 1.4237208 0.074811364 0.30957174 0.30957174 2.7384709e-05 2.3640915e-05 -0.0045961142 0.0022611992 -0.0053431342 0.004579232 -24.407164 0 3.2963565 4.3821364 0.30957174 0.30957174 4.8895402e-05 4.958162e-05 --0.01113503 0.0018621212 0.0047671909 -0.0043317444 -1.9726698 0 4.0967818 1.211558 0.30957174 0.30957174 4.5197852e-05 4.1523653e-05 -0.0030249619 9.761092e-06 0.0020537215 0.0030047713 -3.7004649 0 1.9744827 2.9125481 0.30957174 0.30957174 1.0053708e-06 1.3207801e-05 -0.0038742984 -0.0039569284 -0.00021525829 -0.00063804442 -4.2723663 0 0.48137379 0.046452284 0.30957174 0.30957174 0.00014427586 4.5052277e-07 -0.0017783308 -0.0010592078 -0.0031064877 0.0036615546 -5.7898457 0 0.55656225 4.223469 0.30957174 0.30957174 1.0567168e-05 2.3027508e-05 -0.011079048 0.00051856662 0.0047192857 -0.00078415779 -13.290145 0 2.3481305 1.7817484 0.30957174 0.30957174 1.5924225e-05 2.3063143e-05 -0.0029099963 -0.00037849096 0.0020771214 0.0064537022 -23.208947 0 1.0753073 3.2021375 0.30957174 0.30957174 2.2345677e-06 4.5663097e-05 -0.016539009 -0.00061393202 -0.0077888226 -0.0021174437 -4.2482495 0 1.6190243 5.3500828 0.30957174 0.30957174 3.3461708e-05 6.5607606e-05 --0.01220846 0.00040695624 0.00038872971 0.0077486989 -16.165659 0 4.7918858 3.4653599 0.30957174 0.30957174 1.787051e-05 5.9709182e-05 --0.0087447856 0.0010076487 -0.0038857657 -0.003468825 10.887099 0 4.2770674 5.8114254 0.30957174 0.30957174 1.7644046e-05 2.7157712e-05 --0.014735648 -0.001313507 -0.01339024 0.0028721507 -3.2705512 0 5.7686998 4.8770537 0.30957174 0.30957174 3.9553316e-05 0.00018894267 --0.0039089176 0.0016215425 0.0052004133 -0.00089860571 12.505805 0 3.7745931 1.7753482 0.30957174 0.30957174 2.5629549e-05 2.806572e-05 --0.024106516 -0.0031834454 0.0032972013 0.012869736 -22.661557 0 5.9639591 3.2631305 0.30957174 0.30957174 0.00015611144 0.000175251 -0.026305453 -0.00063918133 0.0045032579 -0.005819479 -1.5148791 0 1.7272651 1.0368092 0.30957174 0.30957174 7.9684801e-05 5.4037141e-05 -0.013210845 0.0042997266 -0.0044999779 -0.0057788114 -15.039573 0 3.1905873 5.9919267 0.30957174 0.30957174 0.00018756994 5.3539509e-05 --0.029303143 -0.00031198659 0.0075177832 -0.00014489575 -6.8566823 0 5.1833732 1.925981 0.30957174 0.30957174 9.5149342e-05 5.6998604e-05 --0.0086145113 -0.0016152959 -0.0044491874 0.0033575488 12.693721 0 6.1278332 4.4441224 0.30957174 0.30957174 3.1914539e-05 3.1138616e-05 --0.0080488095 0.0018448703 -0.0027684558 -0.0040682748 15.012498 0 3.9625475 6.0561862 0.30957174 0.30957174 3.8115907e-05 2.4143858e-05 --0.00510894 -0.0018140404 0.003972621 0.0018671263 21.498511 0 0.074453414 2.381339 0.30957174 0.30957174 3.2841933e-05 1.9368338e-05 --0.0040493003 0.0018202971 -0.0015116323 0.00035263266 -24.413975 0 3.7554072 4.8592981 0.30957174 0.30957174 3.1983747e-05 2.4270036e-06 -0.010775911 0.00091808612 -0.0010286928 -0.0011332195 -0.87659524 0 2.605094 5.916357 0.30957174 0.30957174 2.0425463e-05 2.340638e-06 --0.0091456504 0.0018375332 0.0096518643 0.00028137443 7.9486321 0 4.0159487 1.9740052 0.30957174 0.30957174 3.9940135e-05 9.3996423e-05 -0.0082249834 -0.00064636021 -0.00720049 -0.003841879 -19.659401 0 1.3238053 5.5734572 0.30957174 0.30957174 1.1232182e-05 6.6910388e-05 -0.020355543 0.0010496006 -0.0068310828 -0.0049377491 4.5535968 0 2.3842202 5.7087276 0.30957174 0.30957174 5.5521342e-05 7.1228306e-05 -0.0087246546 0.0021978771 -0.0047476342 0.0004045837 20.885308 0 3.1049364 5.0023608 0.30957174 0.30957174 5.2360515e-05 2.2886136e-05 --0.0083055857 0.0023149294 -0.00081209113 0.0052523295 6.1190404 0 3.8910966 3.6705244 0.30957174 0.30957174 5.6388941e-05 2.8028769e-05 -0.030655973 -0.00020808503 -0.00065666124 0.0011242832 -16.652791 0 1.8833431 4.0480604 0.30957174 0.30957174 0.00010356161 1.6885111e-06 --0.0046841832 -0.0012791707 0.0020565631 -0.0064672621 -12.262366 0 6.2752637 0.68453666 0.30957174 0.30957174 1.731415e-05 4.5751213e-05 -0.014646053 0.0019815772 0.0018545751 0.0013760848 15.072064 0 2.8342551 2.5795741 0.30957174 0.30957174 5.9317238e-05 5.3457844e-06 -0.018290566 0.0022711678 0.00034125116 0.0045906262 -4.7021318 0 2.791946 3.4410903 0.30957174 0.30957174 8.3713339e-05 2.102085e-05 --0.022867942 -0.00087831002 0.0020483036 0.00074894513 -16.841314 0 5.4232502 2.2930272 0.30957174 0.30957174 6.4434321e-05 4.786132e-06 -0.008006346 0.0041133255 0.0014357358 -0.0068312255 -13.14043 0 3.3053841 0.58309792 0.30957174 0.30957174 0.00016116249 4.8366451e-05 -0.002308123 0.0017523067 -0.0020621263 -0.0023530853 0.29306015 0 3.3722909 5.9338651 0.30957174 0.30957174 2.8555888e-05 9.7792679e-06 -0.010180525 0.0018714043 -0.0033341825 0.0046969284 -3.9483234 0 2.9775408 4.1370459 0.30957174 0.30957174 4.3280068e-05 3.3090147e-05 --0.020601691 0.00052073742 -0.0038081158 0.0071911042 11.819317 0 4.860381 4.0062727 0.30957174 0.30957174 4.9062782e-05 6.5913805e-05 --0.016343065 0.00054548394 0.00045790422 0.0035230051 -14.975193 0 4.7915261 3.3856003 0.30957174 0.30957174 3.2031492e-05 1.2522592e-05 --0.016947771 -0.0017831353 -0.00091810769 -0.003434862 -12.971744 0 5.8508644 0.11108259 0.30957174 0.30957174 6.0494823e-05 1.2552671e-05 -0.0078751497 0.0010160864 -0.00064441053 0.0060502963 -6.5739689 0 2.8109209 3.6228602 0.30957174 0.30957174 1.6212956e-05 3.6728744e-05 --0.017932278 -0.00019150878 0.0010158865 0.0037112307 7.0113953 0 5.1836682 3.2466303 0.30957174 0.30957174 3.5634708e-05 1.4702303e-05 -0.026110029 0.0013425371 -0.0015327452 8.5490194e-05 15.531467 0 2.383138 5.0314207 0.30957174 0.30957174 9.1257462e-05 2.3757082e-06 -0.021152889 6.405605e-05 -0.0051634102 0.0044742336 8.1783716 0 1.972675 4.3766941 0.30957174 0.30957174 4.9156513e-05 4.6735035e-05 --0.017419832 -0.00030470559 0.0048956889 0.0067364912 7.5743931 0 5.244701 2.8835782 0.30957174 0.30957174 3.4157652e-05 6.9176525e-05 --4.0502484e-05 -0.0012411402 -0.0097575397 -0.00071412615 -18.252122 0 0.3707179 5.1591575 0.30957174 0.30957174 1.4032528e-05 9.6491561e-05 --0.0075561136 0.0020974894 -0.01169105 0.0021965235 -8.2282676 0 3.8924853 4.9024413 0.30957174 0.30957174 4.6344057e-05 0.00014258055 --0.00097197003 -0.0004962232 0.0016461792 -0.0056481732 8.3789897 0 0.16250107 0.66008625 0.30957174 0.30957174 2.346779e-06 3.4375903e-05 --0.007286453 -0.0012108266 -0.00039664841 0.0019181727 6.3278703 0 6.0736874 3.7214195 0.30957174 0.30957174 1.9183591e-05 3.8082481e-06 --0.0070801171 0.00054540496 0.0071885247 -0.0012401308 -19.172831 0 4.4748061 1.7756177 0.30957174 0.30957174 8.2126426e-06 5.3621618e-05 -0.0067899383 0.00034486173 -0.0065596744 -1.8457551e-05 15.173307 0 2.3784337 5.0894803 0.30957174 0.30957174 6.1444521e-06 4.3380431e-05 -0.013436045 0.00057321812 0.0036393374 -0.0012018837 -17.821725 0 2.3157636 1.6285351 0.30957174 0.30957174 2.2810896e-05 1.4785589e-05 -0.01120813 0.00024490072 -0.0066506409 0.0044034925 -4.0034182 0 2.1415712 4.5055753 0.30957174 0.30957174 1.4336773e-05 6.3825542e-05 --0.011287149 -0.0020027917 -0.00096690199 -0.0033126898 20.668496 0 6.1034503 0.088120075 0.30957174 0.30957174 5.052486e-05 1.1827701e-05 -0.014353696 0.0022513757 -0.0025593182 -0.0073165398 -16.355648 0 2.9052437 0.035266187 0.30957174 0.30957174 6.8789828e-05 5.9702408e-05 --0.029265708 -0.00053097448 -0.0039802712 0.01135453 -5.1051321 0 5.2504821 3.8555956 0.30957174 0.30957174 9.6590225e-05 0.00014385457 -0.0099800173 -0.00092073861 0.0023144036 0.0029492923 2.6955912 0 1.2461936 2.8465847 0.30957174 0.30957174 1.8656432e-05 1.4028121e-05 -0.012279602 0.00020209984 -0.0011673708 -0.0039819339 6.2283779 0 2.0939119 0.086924937 0.30957174 0.30957174 1.692519e-05 1.7101453e-05 --0.010908118 0.00098874379 0.00090248285 -0.0011618487 23.700323 0 4.3964725 1.0386489 0.30957174 0.30957174 2.1967496e-05 2.160092e-06 --0.015070598 -0.00088021168 0.0012530596 -0.0030379866 3.8578093 0 5.5756401 0.768375 0.30957174 0.30957174 3.1990569e-05 1.0737693e-05 -0.0052871865 -0.00016435433 0.0040601601 0.0009692364 -13.091519 0 1.669152 2.1776028 0.30957174 0.30957174 3.3148091e-06 1.7551104e-05 --0.013180987 0.0012800748 0.002895644 0.0066393478 4.8965602 0 4.3624146 3.1016466 0.30957174 0.30957174 3.3999027e-05 5.2177611e-05 -0.013009965 -0.00098554667 0.00071790404 -0.0018383726 -2.600623 0 1.3410699 0.74935863 0.30957174 0.30957174 2.7428724e-05 3.8718743e-06 -0.0039309082 -0.0016820711 -0.003694317 -0.001393085 24.68762 0 0.62542735 5.4446176 0.30957174 0.30957174 2.7470014e-05 1.5684227e-05 --0.0082678796 0.0020296017 0.0044501249 -0.0001756805 10.675629 0 3.9364098 1.9059581 0.30957174 0.30957174 4.502822e-05 1.9995661e-05 -0.018765749 0.0025563889 0.0027174987 -0.0076748162 14.40552 0 2.8375994 0.71716766 0.30957174 0.30957174 9.8189242e-05 6.5871521e-05 -0.031129586 0.0024181731 0.0019615775 0.0019902246 -19.419857 0 2.5609212 2.7336846 0.30957174 0.30957174 0.00015964716 7.8081184e-06 -0.0075555992 -0.00047906426 -0.0052274961 -0.001269069 -6.3979619 0 1.4213242 5.3229953 0.30957174 0.30957174 8.3574733e-06 2.914699e-05 -0.0011733726 0.00011949805 -0.010286796 8.5166225e-05 7.7317292 0 2.6930133 5.0784772 0.30957174 0.30957174 2.8122125e-07 0.00010668798 -0.026026636 0.0038670261 0.0039735791 0.001798558 4.3083739 0 2.8795705 2.3670931 0.30957174 0.30957174 0.000210582 1.9126697e-05 -0.013675669 -0.00040712291 -0.004801979 0.00033463287 11.724684 0 1.6802806 5.017676 0.30957174 0.30957174 2.2040795e-05 2.3358048e-05 --0.0051075906 -0.0030841995 -0.0052282466 0.0057223749 -17.685636 0 0.19446798 4.2602427 0.30957174 0.30957174 8.9514806e-05 6.0038186e-05 -0.017876059 0.00031294498 0.0034769492 -0.0081793085 1.3153606 0 2.1032371 0.7791791 0.30957174 0.30957174 3.5971745e-05 7.8547858e-05 --0.016639975 0.0023264433 0.0010526767 0.012822974 -15.629672 0 4.1815343 3.4333189 0.30957174 0.30957174 7.969905e-05 0.00016421627 -0.0049677581 -0.00018767736 -0.0090848687 -0.0087235966 14.158822 0 1.6136483 5.8477483 0.30957174 0.30957174 3.0300025e-06 0.00015869344 -0.015945226 -0.00040063924 0.00574355 0.0056031748 21.790341 0 1.7200904 2.7140663 0.30957174 0.30957174 2.937299e-05 6.4398989e-05 --0.016178311 0.0014947485 0.0053438353 0.0021863004 -21.845532 0 4.3870718 2.330608 0.30957174 0.30957174 4.9085619e-05 3.3530623e-05 -0.00055975805 -0.00092639082 0.0016099122 -0.00030516941 -18.534874 0 0.44053438 1.7592427 0.30957174 0.30957174 7.8520631e-06 2.7053206e-06 -0.010313193 -0.0027853186 -0.0065287535 -0.00076705874 -17.226344 0 0.76037264 5.2027052 0.30957174 0.30957174 8.2346639e-05 4.355571e-05 --0.014860774 0.0017182151 0.0025818373 -0.0008391525 -6.6050694 0 4.2753701 1.6332241 0.30957174 0.30957174 5.1136714e-05 7.4187058e-06 -0.0056116318 -0.00164147 0.0064691771 0.00012676001 24.038778 0 0.73332559 1.9645302 0.30957174 0.30957174 2.8001443e-05 4.2207345e-05 -0.018133829 0.0030673271 -0.0014574365 0.003008823 17.321073 0 2.9402251 3.970166 0.30957174 0.30957174 0.00012180413 1.1121251e-05 --0.00038878607 0.0019997566 -0.00013902407 -0.0074087705 13.835241 0 3.5372322 0.35538476 0.30957174 0.30957174 3.6445232e-05 5.4465534e-05 --0.01736112 0.0029681705 -0.0043803707 0.0015995967 -16.581612 0 4.0866919 4.7391688 0.30957174 0.30957174 0.00011334166 2.1882081e-05 -0.010148456 -0.0023803269 0.0038257499 -0.0086160014 -5.7613752 0 0.81204725 0.79519663 0.30957174 0.30957174 6.2919389e-05 8.8390896e-05 -0.032011814 0.0010075697 -0.00058335004 -0.0092789855 -14.125836 0 2.2243231 0.31100458 0.30957174 0.30957174 0.00012174247 8.5746453e-05 --0.014662201 -0.0024504637 0.00049134621 -0.005821574 1.3024343 0 6.0763141 0.45918474 0.30957174 0.30957174 7.8299609e-05 3.3860077e-05 -0.016236454 -0.00048773855 0.0049895657 -0.0025378281 -23.03642 0 1.6779923 1.477844 0.30957174 0.30957174 3.1106698e-05 3.1487205e-05 -0.013355995 0.00093966971 -0.0086175074 0.00019196849 -20.367594 0 2.5150452 5.0645964 0.30957174 0.30957174 2.7625697e-05 7.490335e-05 --0.005051982 0.0019617609 0.0061394009 -0.0050260619 -21.96687 0 3.7914043 1.2630589 0.30957174 0.30957174 3.7859276e-05 6.305654e-05 --0.011338519 8.8629098e-05 0.0065907345 0.0071271685 24.585346 0 5.0156045 2.7655313 0.30957174 0.30957174 1.4184707e-05 9.4177673e-05 -0.010624493 0.0020304671 0.0002907469 0.0043763452 -15.936482 0 2.9945006 3.4490152 0.30957174 0.30957174 4.9947719e-05 1.9082756e-05 -0.0073874562 -0.001514844 -0.000721463 0.0032831008 -9.2852229 0 0.86582687 3.7339134 0.30957174 0.30957174 2.6894789e-05 1.1216347e-05 --0.00071379995 0.00024767949 -0.0010473122 0.0075557749 1.9713452 0 3.8223013 3.6547346 0.30957174 0.30957174 6.1474842e-07 5.7733918e-05 --0.0068484759 -0.0022885866 0.0087875058 0.00069288067 -1.7765085 0 0.056904267 2.0231485 0.30957174 0.30957174 5.2860252e-05 7.8325943e-05 -0.032258825 -0.002586966 -0.00073994241 -0.0035211884 -18.923177 0 1.3141811 0.16553402 0.30957174 0.30957174 0.00017520096 1.2850491e-05 --0.0085047747 0.00057679178 0.0013448287 -0.006663036 4.3409794 0 4.5332873 0.57503929 0.30957174 0.30957174 1.0970888e-05 4.5860376e-05 --0.0017733666 0.00032478743 -0.0046746282 -0.0016553371 -11.348704 0 4.055865 5.4244751 0.30957174 0.30957174 1.3061496e-06 2.4748267e-05 -0.017527842 -0.0035210607 0.0032901865 0.0022935353 -8.0103273 0 0.87442923 2.5500593 0.30957174 0.30957174 0.00014666312 1.6131343e-05 --0.0010318261 0.0002912897 0.0038810076 0.0080252558 -1.0502227 0 3.8867587 3.0622617 0.30957174 0.30957174 8.8980352e-07 7.9068966e-05 --0.013200859 -0.0011929557 0.0024026017 -0.00059820355 -11.479757 0 5.7754235 1.7029733 0.30957174 0.30957174 3.2093981e-05 6.1745051e-06 -0.01798209 0.0011822288 -0.00026430279 -0.010762865 -21.56561 0 2.4847025 0.34954822 0.30957174 0.30957174 4.8228859e-05 0.00011497302 --0.019975923 0.0011585065 -0.0037820977 -0.0032420771 -9.1974368 0 4.6006591 5.7913489 0.30957174 0.30957174 5.6031173e-05 2.4846941e-05 --0.032329825 -1.6826921e-05 -0.00067488656 0.001967956 10.629479 0 5.0914304 3.8487617 0.30957174 0.30957174 0.00011474342 4.3007201e-06 --0.0079583721 -0.0014396883 0.00073675272 0.0027671097 17.723378 0 6.1120591 3.2536506 0.30957174 0.30957174 2.5833828e-05 8.142213e-06 --0.0087737054 -0.00017297966 0.00099171155 -0.00011701446 -17.546286 0 5.2643924 1.8285883 0.30957174 0.30957174 8.7229737e-06 1.0050907e-06 --0.01195305 0.0016324435 0.0036694811 -0.0050527446 8.4813707 0 4.1929511 1.0062826 0.30957174 0.30957174 3.9959753e-05 3.8898649e-05 -0.016377923 0.00026003543 -0.0027382655 -0.0046300482 6.9093265 0 2.0887319 6.1198406 0.30957174 0.30957174 3.0062142e-05 2.8823228e-05 -0.019749478 -0.0015322487 0.0026781523 -0.00027754812 -14.22085 0 1.3298586 1.8426602 0.30957174 0.30957174 6.4204495e-05 7.3073786e-06 --0.019081614 0.0018948513 -0.0082028461 -0.00023508981 2.5683466 0 4.3513476 5.1151094 0.30957174 0.30957174 7.2677544e-05 6.7890011e-05 --0.01525286 0.00058601813 0.010251415 -0.0045009285 17.809001 0 4.7500285 1.5343625 0.30957174 0.30957174 2.8667905e-05 0.00012604275 --0.010328768 0.00048155465 -0.0019338109 -0.010367737 8.6472696 0 4.6850698 0.18842832 0.30957174 0.30957174 1.3823805e-05 0.00011039092 -0.0010003703 -0.0017348318 8.5616152e-05 0.0047230758 0.31355932 0 0.43751753 3.49762 0.30957174 0.30957174 2.7525815e-05 2.213446e-05 -0.0020227003 0.0018853849 0.0073100117 -0.0016760965 -16.611032 0 3.3986607 1.7214668 0.30957174 0.30957174 3.2830016e-05 5.6658456e-05 -0.0075973246 0.00088068586 -0.0019990735 0.0013150118 -7.8877484 0 2.7577082 4.5085644 0.30957174 0.30957174 1.3401558e-05 5.7441453e-06 --0.018598239 0.0026825012 -0.0044767486 0.0017176057 -13.481307 0 4.166462 4.723044 0.30957174 0.30957174 0.00010352063 2.3130965e-05 --0.027469391 -0.0030970497 -0.00020568391 0.0053759135 -16.956274 0 5.8854268 3.554446 0.30957174 0.30957174 0.00017020871 2.8709412e-05 -0.00019889308 0.00077142574 -0.00096539151 -0.0049064347 -7.6350061 0 3.4875972 0.17847805 0.30957174 0.30957174 5.4253115e-06 2.4818028e-05 -0.0028976872 -0.00047581676 0.0045952104 -0.00096481282 8.416167 0 0.96359411 1.7397688 0.30957174 0.30957174 2.9841299e-06 2.2211429e-05 -0.025607381 -0.00038861056 0.0010236974 0.0031801284 -2.4646959 0 1.8077259 3.2020875 0.30957174 0.30957174 7.3360623e-05 1.1087942e-05 -0.011134902 -0.00047928662 -0.0091415577 0.0015808619 -9.6583925 0 1.5714185 4.9168095 0.30957174 0.30957174 1.5703381e-05 8.6728223e-05 --0.0011816872 0.0022595289 -0.0020367288 0.005202607 18.336307 0 3.5732411 3.8917992 0.30957174 0.30957174 4.6660947e-05 3.1030338e-05 --0.019876906 0.00076389064 0.0029189893 -0.001667039 -15.683389 0 4.7499405 1.4296862 0.30957174 0.30957174 4.8687532e-05 1.1346504e-05 -0.0024773094 0.001183156 0.0051230636 0.0052541342 8.5913675 0 3.2899645 2.7390663 0.30957174 0.30957174 1.3425542e-05 5.3842438e-05 --0.022597213 0.0017025608 -0.0063315989 0.0036540419 9.7630956 0 4.4851931 4.5667768 0.30957174 0.30957174 8.2461344e-05 5.3660002e-05 -0.0057376779 0.0019020921 -0.008720756 -0.00198413 10.983115 0 3.1961147 5.3086493 0.30957174 0.30957174 3.6571272e-05 8.0576482e-05 --0.01938172 -0.0018401996 -0.0040366159 -0.0095037035 19.239761 0 5.7997649 6.2529045 0.30957174 0.30957174 7.2085242e-05 0.00010601716 -0.0014007197 0.0014311223 -0.001395103 0.0048437812 17.877527 0 3.4088586 3.7984891 0.30957174 0.30957174 1.8872399e-05 2.5234682e-05 --0.013815433 -0.00099671721 -0.0060718529 -9.4701257e-05 -17.124644 0 5.6681078 5.1021587 0.30957174 0.30957174 3.0002383e-05 3.7176829e-05 --0.02944318 -0.00056079652 0.0018608009 -0.0059373517 -7.3466159 0 5.2584829 0.68033482 0.30957174 0.30957174 9.8030603e-05 3.8457907e-05 --0.0087708547 -0.00076915391 -0.000307771 -0.00041909069 10.666201 0 5.7607227 6.0201797 0.30957174 0.30957174 1.3833999e-05 2.6971197e-07 --0.00095764312 0.002162019 -0.0034807572 0.0018297454 22.845896 0 3.5644792 4.6060497 0.30957174 0.30957174 4.2680871e-05 1.5535332e-05 --0.011725449 0.0023828666 0.0012547573 0.0036162036 14.843058 0 4.011168 3.179387 0.30957174 0.30957174 6.6816341e-05 1.455844e-05 --0.018132988 0.0017880755 -0.0026035034 0.0015877099 -9.981299 0 4.3548328 4.542671 0.30957174 0.30957174 6.5219878e-05 9.3339241e-06 -0.007040559 0.0016504483 -0.0064730613 -0.0056212678 10.536644 0 3.0779321 5.7977574 0.30957174 0.30957174 3.0255344e-05 7.3585236e-05 -0.0090787329 -0.0014898546 -0.0051894423 0.006480814 3.798454 0 0.96388094 4.1950491 0.30957174 0.30957174 2.9267974e-05 6.8811176e-05 --0.0012036271 0.00068129111 -0.00042523183 -0.0062186121 7.570634 0 3.7074562 0.30547124 0.30957174 0.30957174 4.3872221e-06 3.8540743e-05 --0.0020904881 -0.0016693274 -0.0015485178 -0.0077333107 -22.292671 0 0.23768357 0.1751051 0.30957174 0.30957174 2.5864422e-05 6.1737981e-05 --0.0084480443 -0.0020221201 -0.0030193443 -0.0061031508 21.523599 0 6.2274798 6.194837 0.30957174 0.30957174 4.5082689e-05 4.6138019e-05 --0.013502149 0.003092325 -0.0015265226 -0.002538153 18.303869 0 3.9628633 6.1124223 0.30957174 0.30957174 0.00010712141 8.739397e-06 --0.017611955 0.0012011758 -0.00049363817 0.0055205855 24.575821 0 4.5307691 3.6057966 0.30957174 0.30957174 4.7193954e-05 3.0476097e-05 --0.011077512 -0.00078398221 0.00064773362 -0.0059765172 5.1303002 0 5.6593243 0.48313182 0.30957174 0.30957174 1.9069753e-05 3.5852919e-05 --0.018991915 -0.0018397049 -0.00014007862 -0.0010193795 -1.5226103 0 5.809698 0.23664071 0.30957174 0.30957174 7.0426587e-05 1.0505142e-06 --0.003737201 0.00096408025 0.0014305075 0.0010144227 -22.84968 0 3.9182244 2.5581014 0.30957174 0.30957174 9.9999361e-06 3.0837657e-06 --0.0110015 0.00059667542 0.0037372277 0.0050863106 -22.473381 0 4.6278093 2.8783371 0.30957174 0.30957174 1.6529773e-05 3.9742096e-05 -0.031505547 0.00041119254 -0.0013619876 -0.0098596035 -18.753708 0 2.0634316 0.23592601 0.30957174 0.30957174 0.0001105048 9.8295871e-05 --0.0072905346 0.00091316507 0.0008381239 0.002919158 -11.537348 0 4.235537 3.2341411 0.30957174 0.30957174 1.3430895e-05 9.1607575e-06 -0.0095032737 0.00098548654 -0.0025883129 -0.00079945512 -20.515852 0 2.7020342 5.3839831 0.30957174 0.30957174 1.8761082e-05 7.387936e-06 --0.0088872457 0.0018115582 0.00046854613 0.0013353495 16.085527 0 4.0099031 3.1758908 0.30957174 0.30957174 3.8565164e-05 1.9900651e-06 -0.063191685 0.00075646939 -0.0017093506 5.33133e-05 21.751499 0 2.053716 5.0557621 0.30957174 0.30957174 0.00044357309 2.9485172e-06 --0.020494956 -0.0011574115 0.0010580142 0.0074051369 5.0131763 0 5.5618171 3.3728365 0.30957174 0.30957174 5.8314018e-05 5.5521175e-05 --0.011688761 -0.0011280307 -0.0026249571 0.002529553 -12.120374 0 5.8078399 4.3238538 0.30957174 0.30957174 2.6589774e-05 1.3293468e-05 --0.016944959 0.00073506265 -0.0063292931 0.0080306406 23.103922 0 4.7103626 4.1873127 0.30957174 0.30957174 3.6442401e-05 0.00010435623 --0.018513699 -0.00082546847 0.00046546819 0.0067795171 -12.331035 0 5.4724937 3.4467854 0.30957174 0.30957174 4.383395e-05 4.5808638e-05 -0.013967964 -0.0024833141 -0.0047360462 0.0008710277 24.714346 0 0.92746327 4.9062461 0.30957174 0.30957174 7.7594081e-05 2.3365534e-05 --0.010930156 -0.0029094542 -0.0004147401 0.0023625643 -11.037302 0 6.2663294 3.6910568 0.30957174 0.30957174 9.0225049e-05 5.7099887e-06 -0.011463079 -0.002541879 0.0048040968 -0.0038220702 -5.3721196 0 0.83398799 1.277005 0.30957174 0.30957174 7.3281976e-05 3.7757584e-05 --0.016892657 0.00059789423 -0.0080695398 0.0022209776 -16.373693 0 4.7747973 4.8201794 0.30957174 0.30957174 3.4582564e-05 7.0541152e-05 -0.039018538 0.0013931998 0.0034836103 0.00500507 -5.954089 0 2.2595639 2.9040336 0.30957174 0.30957174 0.00018481093 3.7082636e-05 -0.016640455 -0.0010725234 -0.0053820336 -0.00015024134 -7.5742876 0 1.4141981 5.1143718 0.30957174 0.30957174 4.0876344e-05 2.9224802e-05 --0.0022480469 -0.0023035361 0.0021975749 -0.0028330487 -7.4599433 0 0.26757473 1.0379787 0.30957174 0.30957174 4.889167e-05 1.282997e-05 -0.0064965424 -0.00079268726 -0.00073641122 -0.010523526 23.239656 0 1.1069428 0.30386891 0.30957174 0.30957174 1.035705e-05 0.00011039586 -0.018758267 -0.0014180979 -0.0030911727 -0.0011169732 6.826455 0 1.3420249 5.4308464 0.30957174 0.30957174 5.6946488e-05 1.0870783e-05 -0.0024748976 -0.0027612915 0.0012618947 -0.0044643251 -17.33977 0 0.47237581 0.65190808 0.30957174 0.30957174 7.012894e-05 2.1374405e-05 -0.016843515 0.001529859 -0.00051382225 0.0027375176 -24.923304 0 2.6363138 3.7029082 0.30957174 0.30957174 5.246438e-05 7.6995728e-06 -0.0013535363 -0.00018874492 -0.005224361 0.012364001 -22.899937 0 1.0412108 3.9186024 0.30957174 0.30957174 5.2563643e-07 0.00017914888 --0.0059087176 0.00048963306 0.001306395 0.00083028925 23.56362 0 4.4400853 2.5075829 0.30957174 0.30957174 6.0165249e-06 2.4043863e-06 -0.015264459 0.00045236826 -0.0018350228 0.0022575146 16.297763 0 2.2087711 4.2023978 0.30957174 0.30957174 2.7442561e-05 8.449922e-06 -0.0057209346 0.00097887211 0.011063092 0.0015046699 -10.204697 0 2.945458 2.0791953 0.30957174 0.30957174 1.2321421e-05 0.00012563545 --0.015115786 -0.00094522464 0.0040608648 -0.0029733824 -3.2519434 0 5.6044786 1.3169475 0.30957174 0.30957174 3.3221383e-05 2.5394567e-05 -0.025087769 0.00037345518 -0.0011800502 0.0047513029 16.165972 0 2.0798762 3.7612368 0.30957174 0.30957174 7.0363691e-05 2.3796212e-05 -0.0094499315 0.0015925146 0.0010777171 0.0046949225 18.888822 0 2.9385249 3.2884756 0.30957174 0.30957174 3.2905533e-05 2.3035008e-05 --0.01582266 0.0013641023 0.00073038067 0.0016854366 -3.741795 0 4.4209533 3.1040025 0.30957174 0.30957174 4.4433893e-05 3.3555315e-06 -0.024707627 0.00080654431 0.004978017 -0.0068112034 -12.952054 0 2.2341317 1.0093094 0.30957174 0.30957174 7.294099e-05 7.1000027e-05 -0.00036739133 -0.0015323128 -0.001830389 2.1991108e-05 14.80124 0 0.40061461 5.0747725 0.30957174 0.30957174 2.1403473e-05 3.3781148e-06 -0.0055433815 -0.00045494979 0.0010264037 0.00064329301 9.5870432 0 1.3031243 2.5013027 0.30957174 0.30957174 5.2587984e-06 1.4725721e-06 --0.0091994223 -0.0017243999 0.0098552666 -0.0027118729 -13.076811 0 6.1276886 1.678642 0.30957174 0.30957174 3.637759e-05 0.00010521282 --0.020799672 0.00046298835 0.0020229402 0.0032480121 12.271223 0 4.8866323 2.95521 0.30957174 0.30957174 4.9445091e-05 1.4589927e-05 --0.011442109 -0.00011449497 -0.0026369127 -0.0036995405 15.999021 0 5.1775906 6.0343997 0.30957174 0.30957174 1.4491624e-05 2.0585922e-05 --0.0066997484 0.0013703871 -0.0043417023 -0.0088166889 11.379171 0 4.0084629 6.1966775 0.30957174 0.30957174 2.2034572e-05 9.6109499e-05 --0.0030777406 0.00018403816 0.0047141393 0.0058422788 -6.1717189 0 4.5879173 2.8329873 0.30957174 0.30957174 1.3483962e-06 5.62605e-05 -0.013187365 -0.002326822 -0.002993645 0.0021294668 -2.6892695 0 0.930859 4.4722299 0.30957174 0.30957174 6.8410025e-05 1.3532928e-05 -0.0087261956 -0.0027032924 0.0033917939 -0.0044052539 14.465774 0 0.71485294 1.0343717 0.30957174 0.30957174 7.4928545e-05 3.0847391e-05 --0.012846884 0.0017417508 0.007957276 0.0023116445 -22.133949 0 4.1965194 2.2256541 0.30957174 0.30957174 4.5752941e-05 6.913489e-05 --0.0050749311 0.0011824957 0.0028545202 -0.0014156318 -21.841812 0 3.95618 1.4879368 0.30957174 0.30957174 1.5564904e-05 1.0202518e-05 --0.012965525 -0.0018316476 0.00153201 -0.0060044475 0.20109122 0 5.9968842 0.626068 0.30957174 0.30957174 4.9015392e-05 3.8128054e-05 --0.014228489 -0.0012090766 0.00070780749 -0.0017387391 -15.460589 0 5.7454219 0.76373933 0.30957174 0.30957174 3.5541032e-05 3.5038437e-06 --0.019471876 -0.0032374926 0.0060205072 -0.0026812155 -0.67442523 0 6.0739364 1.5291278 0.30957174 0.30957174 0.00013710102 4.3672768e-05 From 2cd54f9048bb9d51bb111fb1bbf03bd46e5b307b Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 19 Sep 2025 13:58:03 -0400 Subject: [PATCH 37/40] Update tests --- examples/Diagnostics/Tunes/test_tune_4d.py | 14 +++----------- .../Diagnostics/Tunes/test_tune_4d_uncoupled.py | 14 +++----------- 2 files changed, 6 insertions(+), 22 deletions(-) diff --git a/examples/Diagnostics/Tunes/test_tune_4d.py b/examples/Diagnostics/Tunes/test_tune_4d.py index 36e260c6..bb5bafd0 100644 --- a/examples/Diagnostics/Tunes/test_tune_4d.py +++ b/examples/Diagnostics/Tunes/test_tune_4d.py @@ -166,21 +166,13 @@ def calc_norm_matrix_from_eigvecs(v1: np.ndarray, v2: np.ndarray) -> np.ndarray: # ------------------------------------------------------------------------------------ # Collect phase data from bunch -phase_data = {} -for i in range(bunch.getSize()): - data = tune_node.getData(bunch, i) - for key in data: - if key in phase_data: - phase_data[key].append(data[key]) - else: - phase_data[key] = [] - +phase_data = tune_node.getData(bunch) phase_data = pd.DataFrame(phase_data) print(phase_data) # Check average tune vs. transfer matrix -tune_1_calc = np.mean(phase_data["tune_x"]) -tune_2_calc = np.mean(phase_data["tune_y"]) +tune_1_calc = np.mean(phase_data["tune_1"]) +tune_2_calc = np.mean(phase_data["tune_2"]) tune_1_err = tune_1_calc - tune_1_true tune_2_err = tune_2_calc - tune_2_true diff --git a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py index 35ebe8f3..0549653d 100644 --- a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py +++ b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py @@ -120,15 +120,7 @@ def build_norm_matrix_from_twiss_2d(alpha: float, beta: float) -> np.ndarray: # ------------------------------------------------------------------------------------ # Collect phase data from bunch -phase_data = {} -for i in range(bunch.getSize()): - data = tune_node.getData(bunch, i) - for key in data: - if key in phase_data: - phase_data[key].append(data[key]) - else: - phase_data[key] = [] - +phase_data = tune_node.getData(bunch) phase_data = pd.DataFrame(phase_data) print(phase_data) @@ -156,8 +148,8 @@ def build_norm_matrix_from_twiss_2d(alpha: float, beta: float) -> np.ndarray: # Check average tune vs. transfer matrix tune_1_true = lattice_params["fractional tune x"] tune_2_true = lattice_params["fractional tune y"] -tune_1_calc = np.mean(phase_data["tune_x"]) -tune_2_calc = np.mean(phase_data["tune_y"]) +tune_1_calc = np.mean(phase_data["tune_1"]) +tune_2_calc = np.mean(phase_data["tune_2"]) tune_1_err = tune_1_calc - tune_1_true tune_2_err = tune_2_calc - tune_2_true From 722c0cb6b570fcfa6cf0b4f5f9cefed34ae6ee07 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 19 Sep 2025 13:59:22 -0400 Subject: [PATCH 38/40] Format --- examples/Diagnostics/Tunes/test_tune.py | 31 ++++++++++--------- examples/Diagnostics/Tunes/test_tune_4d.py | 15 ++++----- .../Tunes/test_tune_4d_uncoupled.py | 22 +++++++------ examples/Diagnostics/Tunes/utils.py | 16 +++++----- 4 files changed, 44 insertions(+), 40 deletions(-) diff --git a/examples/Diagnostics/Tunes/test_tune.py b/examples/Diagnostics/Tunes/test_tune.py index c76a5ded..9eb9e0ab 100644 --- a/examples/Diagnostics/Tunes/test_tune.py +++ b/examples/Diagnostics/Tunes/test_tune.py @@ -4,6 +4,7 @@ are estimated from the phase space coordinates before/after tracking using the `BunchTuneAnalysis` class. """ + import math import os import pathlib @@ -64,10 +65,10 @@ tune_node = TeapotTuneAnalysisNode() tune_node.assignTwiss( - betax=lattice_beta_x, - alphax=lattice_alpha_x, - etax=lattice_eta_x, - etapx=lattice_etap_x, + betax=lattice_beta_x, + alphax=lattice_alpha_x, + etax=lattice_eta_x, + etapx=lattice_etap_x, betay=lattice_beta_y, alphay=lattice_alpha_y, ) @@ -77,8 +78,8 @@ # Bunch # ------------------------------------------------------------------------------------ -# Generate a matched transverse phase space distribution. The longitudinal -# distribution will be uniform in position (z) and a delta function in energy +# Generate a matched transverse phase space distribution. The longitudinal +# distribution will be uniform in position (z) and a delta function in energy # deviation (dE). emittance_x = 25.0e-06 emittance_y = 25.0e-06 @@ -113,7 +114,7 @@ bunch.dumpBunch(filename) -# Analysis +# Analysis # ------------------------------------------------------------------------------------ # Collect phase data from bunch @@ -124,21 +125,21 @@ # Read phase data from file particles = np.loadtxt(filename, comments="%") particles = pd.DataFrame( - particles, + particles, columns=[ # https://github.com/PyORBIT-Collaboration/PyORBIT3/issues/78 - "x", - "xp", - "y", - "yp", + "x", + "xp", + "y", + "yp", "z", - "dE", + "dE", "phase_x", "phase_y", "tune_x", "tune_y", "action_x", "action_y", - ] + ], ) print(particles.iloc[:, 6:]) @@ -159,4 +160,4 @@ print("tune_y_err", tune_y_err) assert np.abs(tune_x_err) < 1.00e-08 -assert np.abs(tune_y_err) < 1.00e-08 \ No newline at end of file +assert np.abs(tune_y_err) < 1.00e-08 diff --git a/examples/Diagnostics/Tunes/test_tune_4d.py b/examples/Diagnostics/Tunes/test_tune_4d.py index bb5bafd0..b3baffc6 100644 --- a/examples/Diagnostics/Tunes/test_tune_4d.py +++ b/examples/Diagnostics/Tunes/test_tune_4d.py @@ -1,4 +1,5 @@ """Test one-turn tune estimation in coupled lattice.""" + import math import os import pathlib @@ -59,7 +60,7 @@ def calc_eigtune(eigval: float) -> float: def unit_symplectic_matrix(ndim: int) -> np.ndarray: U = np.zeros((ndim, ndim)) for i in range(0, ndim, 2): - U[i: i + 2, i: i + 2] = [[0.0, 1.0], [-1.0, 0.0]] + U[i : i + 2, i : i + 2] = [[0.0, 1.0], [-1.0, 0.0]] return U @@ -68,15 +69,15 @@ def normalize_eigvec(v: np.ndarray) -> np.ndarray: def _norm(v): return np.linalg.multi_dot([np.conj(v), U, v]) - + if _norm(v) > 0.0: v = np.conj(v) - + v *= np.sqrt(2.0 / np.abs(_norm(v))) assert np.isclose(np.imag(_norm(v)), -2.0) assert np.isclose(np.real(_norm(v)), +0.0) return v - + def calc_norm_matrix_from_eigvecs(v1: np.ndarray, v2: np.ndarray) -> np.ndarray: V = np.zeros((4, 4)) @@ -118,7 +119,7 @@ def calc_norm_matrix_from_eigvecs(v1: np.ndarray, v2: np.ndarray) -> np.ndarray: # Add tune diagnostic node # ------------------------------------------------------------------------------------ - + tune_node = TeapotTuneAnalysisNode() tune_node.setNormMatrix(V_inv) lattice.getNodes()[0].addChildNode(tune_node, 0) @@ -162,7 +163,7 @@ def calc_norm_matrix_from_eigvecs(v1: np.ndarray, v2: np.ndarray) -> np.ndarray: print("turn={} xrms={:0.3f} yrms={:0.3f}".format(turn + 1, xrms, yrms)) -# Analysis +# Analysis # ------------------------------------------------------------------------------------ # Collect phase data from bunch @@ -184,4 +185,4 @@ def calc_norm_matrix_from_eigvecs(v1: np.ndarray, v2: np.ndarray) -> np.ndarray: print("tune_2_err", tune_2_err) assert np.abs(tune_1_err) < 1.00e-08 -assert np.abs(tune_2_err) < 1.00e-08 \ No newline at end of file +assert np.abs(tune_2_err) < 1.00e-08 diff --git a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py index 0549653d..4c1aebac 100644 --- a/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py +++ b/examples/Diagnostics/Tunes/test_tune_4d_uncoupled.py @@ -5,6 +5,7 @@ in the lattice, the (eigen)tunes {nu1, nu2} should be the same as horizontal and vertical tunes {nux, nuy}. """ + import math import os import pathlib @@ -50,6 +51,7 @@ # Analyze transfer matrix # ------------------------------------------------------------------------------------ + def build_norm_matrix_from_twiss_2d(alpha: float, beta: float) -> np.ndarray: norm_matrix_inv = np.array([[beta, 0.0], [-alpha, 1.0]]) * np.sqrt(1.0 / beta) norm_matrix = np.linalg.inv(norm_matrix_inv) @@ -75,7 +77,7 @@ def build_norm_matrix_from_twiss_2d(alpha: float, beta: float) -> np.ndarray: # Add tune diagnostic node # ------------------------------------------------------------------------------------ - + tune_node = TeapotTuneAnalysisNode() tune_node.setNormMatrix(norm_matrix) lattice.getNodes()[0].addChildNode(tune_node, 0) @@ -116,7 +118,7 @@ def build_norm_matrix_from_twiss_2d(alpha: float, beta: float) -> np.ndarray: bunch.dumpBunch(filename) -# Analysis +# Analysis # ------------------------------------------------------------------------------------ # Collect phase data from bunch @@ -127,21 +129,21 @@ def build_norm_matrix_from_twiss_2d(alpha: float, beta: float) -> np.ndarray: # Read phase data from file particles = np.loadtxt(filename, comments="%") particles = pd.DataFrame( - particles, + particles, columns=[ # https://github.com/PyORBIT-Collaboration/PyORBIT3/issues/78 - "x", - "xp", - "y", - "yp", + "x", + "xp", + "y", + "yp", "z", - "dE", + "dE", "phase_1", "phase_2", "tune_1", "tune_2", "action_1", "action_2", - ] + ], ) print(particles.iloc[:, 6:]) @@ -161,4 +163,4 @@ def build_norm_matrix_from_twiss_2d(alpha: float, beta: float) -> np.ndarray: print("tune_2_err", tune_2_err) assert np.abs(tune_1_err) < 1.00e-08 -assert np.abs(tune_2_err) < 1.00e-08 \ No newline at end of file +assert np.abs(tune_2_err) < 1.00e-08 diff --git a/examples/Diagnostics/Tunes/utils.py b/examples/Diagnostics/Tunes/utils.py index 400eeb88..39836e7a 100644 --- a/examples/Diagnostics/Tunes/utils.py +++ b/examples/Diagnostics/Tunes/utils.py @@ -18,7 +18,7 @@ def make_lattice( start: str = "drift", ) -> AccLattice: """Create FODO lattice. - + Args: length: Length of lattice [m]. fill_frac: Fraction of lattice occupied by quadrupoles. @@ -38,14 +38,14 @@ def make_lattice( QuadTEAPOT("qd"), QuadTEAPOT("qf2"), ] - + drift_nodes[0].setLength(length_drift) drift_nodes[1].setLength(length_drift) - + quad_nodes[0].setLength(length_quad * 0.5) quad_nodes[1].setLength(length_quad) quad_nodes[2].setLength(length_quad * 0.5) - + quad_nodes[0].setParam("kq", +kq) quad_nodes[1].setParam("kq", -kq) quad_nodes[2].setParam("kq", +kq) @@ -69,14 +69,14 @@ def make_lattice( QuadTEAPOT("qd"), QuadTEAPOT("qf2"), ] - + drift_nodes[0].setLength(length_drift) drift_nodes[1].setLength(length_drift) - + quad_nodes[0].setLength(length_quad * 0.5) quad_nodes[1].setLength(length_quad) quad_nodes[2].setLength(length_quad * 0.5) - + quad_nodes[0].setParam("kq", +kq) quad_nodes[1].setParam("kq", -kq) quad_nodes[2].setParam("kq", +kq) @@ -91,7 +91,7 @@ def make_lattice( else: raise ValueError - + for node in lattice.getNodes(): node.setUsageFringeFieldIN(False) node.setUsageFringeFieldOUT(False) From 5cee774e18792890131b64b718334084eca7de00 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 19 Sep 2025 14:03:49 -0400 Subject: [PATCH 39/40] Change tunemap labels to use 1/2 instead of x/y xOldPhase -> phase_1 yOldPhase -> phase_2 xOldTune -> tune_1 yOldTune -> tune_2 xAction -> action_1 yAction -> action_2 --- src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc | 16 ++++++++-------- 1 file changed, 8 insertions(+), 8 deletions(-) diff --git a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc index 938317db..490191d1 100644 --- a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc +++ b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc @@ -75,12 +75,12 @@ void BunchTuneAnalysis::analyzeBunch(Bunch* bunch){ if(!bunch->hasParticleAttributes("ParticlePhaseAttributes")){ cerr<<"adding particle phase information attribute\n"; std::map tunemap; - tunemap.insert(std::make_pair("xLastPhase", 0)); - tunemap.insert(std::make_pair("yLastPhase", 0)); - tunemap.insert(std::make_pair("xLastTune", 0)); - tunemap.insert(std::make_pair("yLastTune", 0)); - tunemap.insert(std::make_pair("xAction", 0)); - tunemap.insert(std::make_pair("yAction", 0)); + tunemap.insert(std::make_pair("phase_1", 0)); + tunemap.insert(std::make_pair("phase_2", 0)); + tunemap.insert(std::make_pair("tune_1", 0)); + tunemap.insert(std::make_pair("tune_2", 0)); + tunemap.insert(std::make_pair("action_1", 0)); + tunemap.insert(std::make_pair("action_2", 0)); bunch->addParticleAttributes("ParticlePhaseAttributes", tunemap); } @@ -131,8 +131,8 @@ void BunchTuneAnalysis::analyzeBunch(Bunch* bunch){ bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 3) = yTune; // Compute actions - double xAction = xval * xval + xpval * xpval; - double yAction = yval * yval + ypval * ypval; + double xAction = (xval * xval + xpval * xpval) / 2.0; + double yAction = (yval * yval + ypval * ypval) / 2.0; bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 4) = xAction; bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 5) = yAction; From b75e967ff9cecfa092065d1499b21919e99ae7f5 Mon Sep 17 00:00:00 2001 From: austin-hoover Date: Fri, 19 Sep 2025 16:36:53 -0400 Subject: [PATCH 40/40] Change labeling from x/y to 1/2 --- py/orbit/diagnostics/TeapotDiagnosticsNode.py | 91 +++++++------------ .../BunchDiagnostics/BunchTuneAnalysis.cc | 67 +++++++------- 2 files changed, 68 insertions(+), 90 deletions(-) diff --git a/py/orbit/diagnostics/TeapotDiagnosticsNode.py b/py/orbit/diagnostics/TeapotDiagnosticsNode.py index cea9e45a..49180595 100644 --- a/py/orbit/diagnostics/TeapotDiagnosticsNode.py +++ b/py/orbit/diagnostics/TeapotDiagnosticsNode.py @@ -182,67 +182,42 @@ def resetFile(self, file): class TeapotTuneAnalysisNode(DriftTEAPOT): """One-turn tune analysis node. - This node uses the Average Phase Advance (APA) method to estimate the - tunes and actions of each particle. See Eq. (6) of [1]. We use only - a single turn rather than the average of multiple turns. - - The phase advance is computed by normalizing the particle coordinates. - In the normalized frame, the turn-by-turn coordinates should jump along - a circle of area J, where J is an invariant. (In an uncoupled lattice, - J is the Courant-Snyder (CS) invariant.). The phase is the angle below - the x axis. The (fractional) phase advance is the change in phase on - subsequent turns, modulo 2 pi. The tune is the phase advance divided - by 2 pi. - - The normalization is performed using a 6 x 6 matrix V^{-1}. In - uncoupled systems, the user can call `assignTwiss` to set the matrix - using Courant-Snyder parameters in each plane [2], as well as the - horizontal dispersion and dispersion-prime. Note that the last column - of V^{-1} multiplies by the fractional momentum offset (delta_p / p), - not the energy offset (delta_E). + This node computes the tunes and actions of each particle in the bunch. + + We use the Average Phase Advance (APA) method to estimate the tunes [1]. + We use only a single turn rather than the average of multiple turns. + + The tune and action in each mode (1, 2 -> x, y) are estimated by first + normalizing the coordinates: .. math:: + \mathbf{u} = \mathbf{V}^{-1} \mathbf{x}, - \begin{bmatrix} - u_1 \\ u_1' \\ u_2 \\ u_2' \\ u_3 \\ u_3' - \end{bmatrix} - = - \begin{bmatrix} - \frac{1}{\sqrt{\beta_x}} & 0 & 0 & 0 & 0 & 0\\ - \frac{\alpha_x}{\sqrt{\beta_x}} & \sqrt{\beta_x} & 0 & 0 & 0 & 0 \\ - 0 & 0 & \frac{1}{\sqrt{\beta_y}} & 0 & 0 & 0 \\ - 0 & 0 & \frac{\alpha_y}{\sqrt{\beta_y}} & \sqrt{\beta_y} & 0 & 0 \\ - 0 & 0 & 0 & 0 & 1 & 0 \\ - 0 & 0 & 0 & 0 & 0 & 1 \\ - \end{bmatrix} - \begin{bmatrix} - 1 & 0 & 0 & 0 & 0 & -\eta_x \\ - 0 & 1 & 0 & 0 & 0 & -\eta_x' \\ - 0 & 0 & 1 & 0 & 0 & 0 \\ - 0 & 0 & 0 & 1 & 0 & 0 \\ - 0 & 0 & 0 & 0 & 1 & 0 \\ - 0 & 0 & 0 & 0 & 0 & 1 \\ - \end{bmatrix} - \begin{bmatrix} - x \\ x' \\ y \\ y' \\ z \\ \delta p - \end{bmatrix} - - Otherwise, the user can set the matrix directly. + where :math:`\mathbf{x} = [x, x', y, y', z, \delta_p]^T` and + :math:`\mathbf{u} = [u_1, u_1', u_2, u_2', u_3, u_3']^T`. If the normalization + matrix :math:`\mathbf{V}^{-1}` is chosen correctly, the turn-by-turn coordinates + in the :math:`u_k - u_k'` phase space will trace a circle of area :math:`2 \pi J_k`, + where :math:`J_k(u_k, u_k')` is defined as the *action*: - The phase phi_k is defined by + .. math:: + J_k(u_k, u_k') = (u_k^2 + u_k'^2) / 2. + + The phase :math:`\theta_k` is defined by .. math:: - \tan(\phi_k) = u_k' / u_k + \tan{\theta_k} = u_1' / u_1. - The action J_k is defined as: + The tune :math:`\nu_k` is estimated from the phases on turns $t$ and $t + 1$: .. math:: - J_k = u_k^2 + u_k'^2 + \nu_k = - (\theta_k^{(t + 1)} - \theta_k^{(t)}). + References ---------- [1] https://cds.cern.ch/record/292773/files/p147.pdf - [2] S. Y. Lee, Accelerator Physics + [2] https://arxiv.org/pdf/1207.5526 + [3] S. Y. Lee, *Accelerator Physics* """ def __init__(self, name: str = "tuneanalysis no name") -> None: """Constructor.""" @@ -254,7 +229,7 @@ def __init__(self, name: str = "tuneanalysis no name") -> None: self.position = 0.0 self.active = True - self.keys = ["phase_1", "phase_1", "tune_1", "tune_2", "action_1", "action_2"] + self.keys = ["phase_1", "phase_2", "tune_1", "tune_2", "action_1", "action_2"] def track(self, paramsDict: dict) -> None: """Implementation of the AccNodeBunchTracker class track(probe) method.""" @@ -311,7 +286,7 @@ def assignTwiss( betay: float, alphay: float, ) -> None: - """Set the twiss parameters for the coordinate normalization. + """Set the 2D twiss parameters for the coordinate normalization. betax{y}: Beta parameter in x{y} plane. alphax{y}: Alpha parameter in x{y} plane. @@ -321,17 +296,17 @@ def assignTwiss( self.bunchtune.assignTwiss(betax, alphax, etax, etapx, betay, alphay) def getData(self, bunch: Bunch, index: int = None) -> dict[str, float] | dict[str, list[float]]: - """Return phase advances, tunes, and actions. + """Return tune and action data. Args: bunch: A Bunch object. index: Particle index. If None, return data for all particles. Returns: - data: Dictionary with keys ["phase_1", "phase_1", "tune_1", "tune_2", - "action_1", "action_2"]. (If the lattice is uncoupled, 1->x and - 2->y.) If `index` is None, each value of `data` is a list of floats; - otherwise it is a float. + data: Dictionary with keys {"phase_1", "phase_2", "tune_1", "tune_2", + "action_1", "action_2" "action_3"}. (If the lattice is uncoupled, + 1->x and 2->y.) If `index` is None, each value of `data` is a list + of floats; otherwise each value is a float. """ data = {} if index is None: @@ -363,7 +338,7 @@ def getTunes(self, bunch: Bunch, index: int = None) -> dict[str, float] | dict[s tune_2: Fractional tune (mode 2). """ data = self.getData(bunch, index) - return (data["tune_1"], data["tune_2"]) + return tuple([data[key] for key in ["tune_1", "tune_2"]]) def getActions(self, bunch: Bunch, index: int) -> dict[str, float] | dict[str, list[float]]: @@ -375,10 +350,10 @@ def getActions(self, bunch: Bunch, index: int) -> dict[str, float] | dict[str, l Returns: J_1: Action (mode 1). - J_2: Action tune (mode 2). + J_2: Action (mode 2). """ data = self.getData(bunch, index) - return (data["action_1"], data["action_2"]) + return tuple([data[key] for key in ["action_1", "action_2"]]) class TeapotBPMSignalNode(DriftTEAPOT): diff --git a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc index 490191d1..00e6757c 100644 --- a/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc +++ b/src/orbit/BunchDiagnostics/BunchTuneAnalysis.cc @@ -88,55 +88,58 @@ void BunchTuneAnalysis::analyzeBunch(Bunch* bunch){ for (int i=0; i < bunch->getSize(); i++) { // Extract phase space coordinates - double x = part_coord_arr[i][0]; + double x = part_coord_arr[i][0]; double xp = part_coord_arr[i][1]; - double y = part_coord_arr[i][2]; + double y = part_coord_arr[i][2]; double yp = part_coord_arr[i][3]; - double z = part_coord_arr[i][4]; + double z = part_coord_arr[i][4]; double Etot = syncPart->getEnergy() + syncPart->getMass(); double dpp = 1.0 / (beta * beta) * part_coord_arr[i][5] / Etot; // Normalize phase space coordinates - double xval = matrix[0][0] * x + matrix[0][1] * xp + matrix[0][2] * y + matrix[0][3] * yp + matrix[0][4] * z + matrix[0][5] * dpp; - double xpval = matrix[1][0] * x + matrix[1][1] * xp + matrix[1][2] * y + matrix[1][3] * yp + matrix[1][4] * z + matrix[1][5] * dpp; - double yval = matrix[2][0] * x + matrix[2][1] * xp + matrix[2][2] * y + matrix[2][3] * yp + matrix[2][4] * z + matrix[2][5] * dpp; - double ypval = matrix[3][0] * x + matrix[3][1] * xp + matrix[3][2] * y + matrix[3][3] * yp + matrix[3][4] * z + matrix[3][5] * dpp; - - // Compute phase advance in normalized x-x' - double angle = atan2(xpval, xval); + double u1 = matrix[0][0] * x + matrix[0][1] * xp + matrix[0][2] * y + matrix[0][3] * yp + matrix[0][4] * z + matrix[0][5] * dpp; + double u1p = matrix[1][0] * x + matrix[1][1] * xp + matrix[1][2] * y + matrix[1][3] * yp + matrix[1][4] * z + matrix[1][5] * dpp; + double u2 = matrix[2][0] * x + matrix[2][1] * xp + matrix[2][2] * y + matrix[2][3] * yp + matrix[2][4] * z + matrix[2][5] * dpp; + double u2p = matrix[3][0] * x + matrix[3][1] * xp + matrix[3][2] * y + matrix[3][3] * yp + matrix[3][4] * z + matrix[3][5] * dpp; + double u3 = matrix[4][0] * x + matrix[4][1] * xp + matrix[4][2] * y + matrix[4][3] * yp + matrix[4][4] * z + matrix[4][5] * dpp; + double u3p = matrix[5][0] * x + matrix[5][1] * xp + matrix[5][2] * y + matrix[5][3] * yp + matrix[5][4] * z + matrix[5][5] * dpp; + + // Compute phase advance (mode 1) + double angle = atan2(u1p, u1); if (angle < 0.0) { angle += (2.0 * OrbitConst::PI); } - double xPhase = angle; - double xPhaseOld = bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 0); - double xTune = (xPhaseOld - xPhase) / (2.0 * OrbitConst::PI); - if (xTune < 0.0) { - xTune += 1.0; + double phase1 = angle; + double phase1Old = bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 0); + double tune1 = (phase1Old - phase1) / (2.0 * OrbitConst::PI); + if (tune1 < 0.0) { + tune1 += 1.0; } - bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 0) = xPhase; - bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 2) = xTune; - // Compute phase advance in normalized y-y' - angle = atan2(ypval, yval); + // Compute phase advance (mode 2) + angle = atan2(u2p, u2); if (angle < 0.0) { angle += (2.0 * OrbitConst::PI); } - double yPhase = angle; - double yPhaseOld = bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 1); - double yTune = (yPhaseOld - yPhase) / (2.0 * OrbitConst::PI); - if (yTune < 0.0) { - yTune += 1.0; + double phase2 = angle; + double phase2Old = bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 1); + double tune2 = (phase2Old - phase2) / (2.0 * OrbitConst::PI); + if (tune2 < 0.0) { + tune2 += 1.0; } - bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 1) = yPhase; - bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 3) = yTune; // Compute actions - double xAction = (xval * xval + xpval * xpval) / 2.0; - double yAction = (yval * yval + ypval * ypval) / 2.0; - - bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 4) = xAction; - bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 5) = yAction; + double action1 = (u1 * u1 + u1p * u1p) / 2.0; + double action2 = (u2 * u2 + u2p * u2p) / 2.0; + + // Update ParticlePhaseAttributes + bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 0) = phase1; + bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 1) = phase2; + bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 2) = tune1; + bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 3) = tune2; + bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 4) = action1; + bunch->getParticleAttributes("ParticlePhaseAttributes")->attValue(i, 5) = action2; } } -} +} \ No newline at end of file