diff --git a/src/core/communication.cpp b/src/core/communication.cpp index e2e8917e5ff..ab135b1bc74 100644 --- a/src/core/communication.cpp +++ b/src/core/communication.cpp @@ -644,16 +644,17 @@ void mpi_send_rotational_inertia_slave(int pnode, int part) { #endif } -void mpi_rotate_particle(int pnode, int part, double axis[3], double angle) { +void mpi_rotate_particle(int pnode, int part, const Vector3d &axis, + double angle) { #ifdef ROTATION mpi_call(mpi_rotate_particle_slave, pnode, part); if (pnode == this_node) { Particle *p = local_particles[part]; - local_rotate_particle(p, axis, angle); + local_rotate_particle(*p, axis, angle); } else { - MPI_Send(axis, 3, MPI_DOUBLE, pnode, SOME_TAG, comm_cart); - MPI_Send(&angle, 1, MPI_DOUBLE, pnode, SOME_TAG, comm_cart); + comm_cart.send(pnode, SOME_TAG, axis); + comm_cart.send(pnode, SOME_TAG, angle); } on_particle_change(); @@ -664,10 +665,11 @@ void mpi_rotate_particle_slave(int pnode, int part) { #ifdef ROTATION if (pnode == this_node) { Particle *p = local_particles[part]; - double axis[3], angle; - MPI_Recv(axis, 3, MPI_DOUBLE, 0, SOME_TAG, comm_cart, MPI_STATUS_IGNORE); - MPI_Recv(&angle, 1, MPI_DOUBLE, 0, SOME_TAG, comm_cart, MPI_STATUS_IGNORE); - local_rotate_particle(p, axis, angle); + Vector3d axis; + double angle; + comm_cart.recv(0, SOME_TAG, axis); + comm_cart.recv(0, SOME_TAG, angle); + local_rotate_particle(*p, axis, angle); } on_particle_change(); @@ -815,18 +817,15 @@ void mpi_send_quat_slave(int pnode, int part) { /********************* REQ_SET_OMEGA ********/ -void mpi_send_omega(int pnode, int part, double omega[3]) { +void mpi_send_omega(int pnode, int part, const Vector3d &omega) { #ifdef ROTATION mpi_call(mpi_send_omega_slave, pnode, part); if (pnode == this_node) { Particle *p = local_particles[part]; - /* memmove(p->omega, omega, 3*sizeof(double));*/ - p->m.omega[0] = omega[0]; - p->m.omega[1] = omega[1]; - p->m.omega[2] = omega[2]; + p->m.omega = omega; } else { - MPI_Send(omega, 3, MPI_DOUBLE, pnode, SOME_TAG, comm_cart); + comm_cart.send(pnode, SOME_TAG, omega); } on_particle_change(); @@ -837,27 +836,23 @@ void mpi_send_omega_slave(int pnode, int part) { #ifdef ROTATION if (pnode == this_node) { Particle *p = local_particles[part]; - MPI_Recv(p->m.omega.data(), 3, MPI_DOUBLE, 0, SOME_TAG, comm_cart, - MPI_STATUS_IGNORE); + comm_cart.recv(0, SOME_TAG, p->m.omega); } - on_particle_change(); #endif } /********************* REQ_SET_TORQUE ********/ -void mpi_send_torque(int pnode, int part, double torque[3]) { +void mpi_send_torque(int pnode, int part, const Vector3d &torque) { #ifdef ROTATION mpi_call(mpi_send_torque_slave, pnode, part); if (pnode == this_node) { Particle *p = local_particles[part]; - p->f.torque[0] = torque[0]; - p->f.torque[1] = torque[1]; - p->f.torque[2] = torque[2]; + p->f.torque = torque; } else { - MPI_Send(torque, 3, MPI_DOUBLE, pnode, SOME_TAG, comm_cart); + comm_cart.send(pnode, SOME_TAG, torque); } on_particle_change(); @@ -868,8 +863,7 @@ void mpi_send_torque_slave(int pnode, int part) { #ifdef ROTATION if (pnode == this_node) { Particle *p = local_particles[part]; - MPI_Recv(p->f.torque.data(), 3, MPI_DOUBLE, 0, SOME_TAG, comm_cart, - MPI_STATUS_IGNORE); + comm_cart.recv(0, SOME_TAG, p->f.torque); } on_particle_change(); diff --git a/src/core/communication.hpp b/src/core/communication.hpp index 5437f64f962..8216f0d3d6a 100644 --- a/src/core/communication.hpp +++ b/src/core/communication.hpp @@ -232,7 +232,8 @@ void mpi_send_rotational_inertia(int node, int part, double rinertia[3]); \param axis rotation axis \param angle rotation angle */ -void mpi_rotate_particle(int node, int part, double axis[3], double angle); +void mpi_rotate_particle(int pnode, int part, const Vector3d &axis, + double angle); #endif #ifdef AFFINITY @@ -278,7 +279,7 @@ void mpi_send_rotation(int pnode, int part, short int rot); \param node the node it is attached to. \param omega its new angular velocity. */ -void mpi_send_omega(int node, int part, double omega[3]); +void mpi_send_omega(int node, int part, const Vector3d &omega); /** Issue REQ_SET_TORQUE: send particle torque. Also calls \ref on_particle_change. @@ -286,7 +287,7 @@ void mpi_send_omega(int node, int part, double omega[3]); \param node the node it is attached to. \param torque its new torque. */ -void mpi_send_torque(int node, int part, double torque[3]); +void mpi_send_torque(int node, int part, const Vector3d &torque); #endif #ifdef DIPOLES diff --git a/src/core/minimize_energy.cpp b/src/core/minimize_energy.cpp index 098d4ed7279..4530d8b075c 100644 --- a/src/core/minimize_energy.cpp +++ b/src/core/minimize_energy.cpp @@ -95,18 +95,11 @@ bool steepest_descent_step(void) { } #ifdef ROTATION // Rotational increment - double dq[3]; // Vector parallel to torque + Vector3d dq = params->gamma * p.f.torque; + t += p.f.torque.norm2(); - for (int j = 0; j < 3; j++) { - dq[j] = 0; - // Square of torque - t += Utils::sqr(p.f.torque[j]); - - // Rotational increment - dq[j] = params->gamma * p.f.torque[j]; - } // Normalize rotation axis and compute amount of rotation - double l = normr(dq); + double l = dq.norm(); if (l > 0.0) { for (int j = 0; j < 3; j++) dq[j] /= l; @@ -116,7 +109,7 @@ bool steepest_descent_step(void) { l = sgn(l) * params->max_displacement; // Rotate the particle around axis dq by amount l - local_rotate_particle(&(p), dq, l); + local_rotate_particle(p, dq, l); } #endif diff --git a/src/core/observables/ParticleAngularVelocities.hpp b/src/core/observables/ParticleAngularVelocities.hpp index c78da252217..0dbaca63ed8 100644 --- a/src/core/observables/ParticleAngularVelocities.hpp +++ b/src/core/observables/ParticleAngularVelocities.hpp @@ -33,20 +33,8 @@ class ParticleAngularVelocities : public PidObservable { std::vector res(n_values()); for (int i = 0; i < ids().size(); i++) { #ifdef ROTATION - - double RMat[9]; - double omega[3]; - define_rotation_matrix(partCfg[ids()[i]], RMat); - omega[0] = RMat[0 + 3 * 0] * partCfg[ids()[i]].m.omega[0] + - RMat[1 + 3 * 0] * partCfg[ids()[i]].m.omega[1] + - RMat[2 + 3 * 0] * partCfg[ids()[i]].m.omega[2]; - omega[1] = RMat[0 + 3 * 1] * partCfg[ids()[i]].m.omega[0] + - RMat[1 + 3 * 1] * partCfg[ids()[i]].m.omega[1] + - RMat[2 + 3 * 1] * partCfg[ids()[i]].m.omega[2]; - omega[2] = RMat[0 + 3 * 2] * partCfg[ids()[i]].m.omega[0] + - RMat[1 + 3 * 2] * partCfg[ids()[i]].m.omega[1] + - RMat[2 + 3 * 2] * partCfg[ids()[i]].m.omega[2]; - + const Vector3d omega = + convert_vector_body_to_space(partCfg[i], partCfg[i].m.omega); res[3 * i + 0] = omega[0]; res[3 * i + 1] = omega[1]; res[3 * i + 2] = omega[2]; diff --git a/src/core/observables/ParticleBodyVelocities.hpp b/src/core/observables/ParticleBodyVelocities.hpp index c1db8556312..6437ef67614 100644 --- a/src/core/observables/ParticleBodyVelocities.hpp +++ b/src/core/observables/ParticleBodyVelocities.hpp @@ -35,20 +35,8 @@ class ParticleBodyVelocities : public PidObservable { #ifdef ROTATION double RMat[9]; - double vel_lab[3]; - double vel_body[3]; - - vel_lab[0] = partCfg[ids()[i]].m.v[0]; - vel_lab[1] = partCfg[ids()[i]].m.v[1]; - vel_lab[2] = partCfg[ids()[i]].m.v[2]; - define_rotation_matrix(partCfg[ids()[i]], RMat); - - vel_body[0] = RMat[0 + 3 * 0] * vel_lab[0] + - RMat[0 + 3 * 1] * vel_lab[1] + RMat[0 + 3 * 2] * vel_lab[2]; - vel_body[1] = RMat[1 + 3 * 0] * vel_lab[0] + - RMat[1 + 3 * 1] * vel_lab[1] + RMat[1 + 3 * 2] * vel_lab[2]; - vel_body[2] = RMat[2 + 3 * 0] * vel_lab[0] + - RMat[2 + 3 * 1] * vel_lab[1] + RMat[2 + 3 * 2] * vel_lab[2]; + const Vector3d vel_body = + convert_vector_space_to_body(partCfg[i], partCfg[i].m.v); res[3 * i + 0] = vel_body[0]; res[3 * i + 1] = vel_body[1]; diff --git a/src/core/particle_data.cpp b/src/core/particle_data.cpp index 2cc3b184c3c..c0016b96d1c 100644 --- a/src/core/particle_data.cpp +++ b/src/core/particle_data.cpp @@ -530,7 +530,7 @@ int set_particle_rotation(int part, int rot) { } #endif #ifdef ROTATION -int rotate_particle(int part, double axis[3], double angle) { +int rotate_particle(int part, const Vector3d &axis, double angle) { auto const pnode = get_particle_node(part); mpi_rotate_particle(pnode, part, axis, angle); @@ -664,59 +664,31 @@ int set_particle_quat(int part, double quat[4]) { return ES_OK; } -int set_particle_omega_lab(int part, double omega_lab[3]) { +int set_particle_omega_lab(int part, const Vector3d &omega_lab) { auto const &particle = get_particle_data(part); - /* Internal functions require the body coordinates - so we need to convert to these from the lab frame */ - - double A[9]; - double omega[3]; - - define_rotation_matrix(particle, A); - - omega[0] = A[0 + 3 * 0] * omega_lab[0] + A[0 + 3 * 1] * omega_lab[1] + - A[0 + 3 * 2] * omega_lab[2]; - omega[1] = A[1 + 3 * 0] * omega_lab[0] + A[1 + 3 * 1] * omega_lab[1] + - A[1 + 3 * 2] * omega_lab[2]; - omega[2] = A[2 + 3 * 0] * omega_lab[0] + A[2 + 3 * 1] * omega_lab[1] + - A[2 + 3 * 2] * omega_lab[2]; - auto const pnode = get_particle_node(part); - mpi_send_omega(pnode, part, omega); + mpi_send_omega(pnode, part, + convert_vector_space_to_body(particle, omega_lab)); return ES_OK; } -int set_particle_omega_body(int part, double omega[3]) { +int set_particle_omega_body(int part, const Vector3d &omega) { auto const pnode = get_particle_node(part); mpi_send_omega(pnode, part, omega); return ES_OK; } -int set_particle_torque_lab(int part, double torque_lab[3]) { +int set_particle_torque_lab(int part, const Vector3d &torque_lab) { auto const &particle = get_particle_data(part); - /* Internal functions require the body coordinates - so we need to convert to these from the lab frame */ - - double A[9]; - double torque[3]; - - define_rotation_matrix(particle, A); - - torque[0] = A[0 + 3 * 0] * torque_lab[0] + A[0 + 3 * 1] * torque_lab[1] + - A[0 + 3 * 2] * torque_lab[2]; - torque[1] = A[1 + 3 * 0] * torque_lab[0] + A[1 + 3 * 1] * torque_lab[1] + - A[1 + 3 * 2] * torque_lab[2]; - torque[2] = A[2 + 3 * 0] * torque_lab[0] + A[2 + 3 * 1] * torque_lab[1] + - A[2 + 3 * 2] * torque_lab[2]; - auto const pnode = get_particle_node(part); - mpi_send_torque(pnode, part, torque); + mpi_send_torque(pnode, part, + convert_vector_space_to_body(particle, torque_lab)); return ES_OK; } -int set_particle_torque_body(int part, double torque[3]) { +int set_particle_torque_body(int part, const Vector3d &torque) { auto const pnode = get_particle_node(part); /* Nothing to be done but pass, since the coordinates @@ -1243,10 +1215,6 @@ void pointer_to_omega_body(Particle const *p, double const *&res) { res = p->m.omega.data(); } -void pointer_to_torque_lab(Particle const *p, double const *&res) { - res = p->f.torque.data(); -} - void pointer_to_quat(Particle const *p, double const *&res) { res = p->r.quat.data(); } diff --git a/src/core/particle_data.hpp b/src/core/particle_data.hpp index 93d8e392866..fcf5b9b1bc1 100644 --- a/src/core/particle_data.hpp +++ b/src/core/particle_data.hpp @@ -672,7 +672,7 @@ int set_particle_rotation(int part, int rot); @param axis rotation axis @param angle rotation angle */ -int rotate_particle(int part, double axis[3], double angle); +int rotate_particle(int part, const Vector3d &axis, double angle); #ifdef AFFINITY /** Call only on the master node: set particle affinity. @@ -736,28 +736,28 @@ int set_particle_quat(int part, double quat[4]); @param omega its new angular velocity. @return ES_OK if particle existed */ -int set_particle_omega_lab(int part, double omega[3]); +int set_particle_omega_lab(int part, const Vector3d &omega); /** Call only on the master node: set particle angular velocity in body frame. @param part the particle. @param omega its new angular velocity. @return ES_OK if particle existed */ -int set_particle_omega_body(int part, double omega[3]); +int set_particle_omega_body(int part, const Vector3d &omega); /** Call only on the master node: set particle torque from lab frame. @param part the particle. @param torque its new torque. @return ES_OK if particle existed */ -int set_particle_torque_lab(int part, double torque[3]); +int set_particle_torque_lab(int part, const Vector3d &torque); /** Call only on the master node: set particle torque in body frame. @param part the particle. @param torque its new torque. @return ES_OK if particle existed */ -int set_particle_torque_body(int part, double torque[3]); +int set_particle_torque_body(int part, const Vector3d &torque); #endif #ifdef DIPOLES @@ -995,7 +995,7 @@ int number_of_particles_with_type(int type); #ifdef ROTATION void pointer_to_omega_body(Particle const *p, double const *&res); -void pointer_to_torque_lab(Particle const *p, double const *&res); +inline Vector3d get_torque_body(const Particle &p) { return p.f.torque; } void pointer_to_quat(Particle const *p, double const *&res); diff --git a/src/core/rotate_system.cpp b/src/core/rotate_system.cpp index 1d61627d14f..2e71399403a 100644 --- a/src/core/rotate_system.cpp +++ b/src/core/rotate_system.cpp @@ -48,7 +48,7 @@ void local_rotate_system(double phi, double theta, double alpha) { mpi::all_reduce(comm_cart, local_com, std::plus()) / total_mass; // Rotation axis in Cartesian coordinates - double axis[3]; + Vector3d axis; axis[0] = sin(theta) * cos(phi); axis[1] = sin(theta) * sin(phi); axis[2] = cos(theta); @@ -67,7 +67,7 @@ void local_rotate_system(double phi, double theta, double alpha) { p.r.p[j] = com[j] + res[j]; } #ifdef ROTATION - local_rotate_particle(&p, axis, alpha); + local_rotate_particle(p, axis, alpha); #endif } diff --git a/src/core/rotation.cpp b/src/core/rotation.cpp index fa2dcace8ad..824174a41f6 100644 --- a/src/core/rotation.cpp +++ b/src/core/rotation.cpp @@ -254,21 +254,42 @@ void propagate_omega_quat_particle(Particle *p) { p->r.quat[3] += time_step * (Qd[3] + time_step_half * Qdd[3]) - lambda * p->r.quat[3]; // Update the director -#ifdef DIPOLES - // When dipoles are enabled, update dipole moment -#endif ONEPART_TRACE(if (p->p.identity == check_id) fprintf(stderr, "%d: OPT: PPOS p = (%.3f,%.3f,%.3f)\n", this_node, p->r.p[0], p->r.p[1], p->r.p[2])); } +inline void convert_torque_to_body_frame_apply_fix_and_thermostat(Particle &p) { + auto const t = convert_vector_space_to_body(p, p.f.torque); + p.f.torque = Vector3d{{0, 0, 0}}; + + if (thermo_switch & THERMO_LANGEVIN) { +#if defined(VIRTUAL_SITES) && defined(THERMOSTAT_IGNORE_NON_VIRTUAL) + if (!p.p.is_virtual) +#endif + { + friction_thermo_langevin_rotation(&p); + + p.f.torque += t; + } + } else { + p.f.torque = t; + } + + if (!(p.p.rotation & ROTATION_X)) + p.f.torque[0] = 0; + + if (!(p.p.rotation & ROTATION_Y)) + p.f.torque[1] = 0; + + if (!(p.p.rotation & ROTATION_Z)) + p.f.torque[2] = 0; +} + /** convert the torques to the body-fixed frames and propagate angular * velocities */ void convert_torques_propagate_omega() { - double tx, ty, tz; - double omega_0[3] = {0.0, 0.0, 0.0}; - INTEG_TRACE( fprintf(stderr, "%d: convert_torques_propagate_omega:\n", this_node)); @@ -283,85 +304,27 @@ void convert_torques_propagate_omega() { if (!p.p.rotation) continue; - double A[9]; - define_rotation_matrix(p, A); - - tx = A[0 + 3 * 0] * p.f.torque[0] + A[0 + 3 * 1] * p.f.torque[1] + - A[0 + 3 * 2] * p.f.torque[2]; - ty = A[1 + 3 * 0] * p.f.torque[0] + A[1 + 3 * 1] * p.f.torque[1] + - A[1 + 3 * 2] * p.f.torque[2]; - tz = A[2 + 3 * 0] * p.f.torque[0] + A[2 + 3 * 1] * p.f.torque[1] + - A[2 + 3 * 2] * p.f.torque[2]; - - if (thermo_switch & THERMO_LANGEVIN) { -#if defined(VIRTUAL_SITES) && defined(THERMOSTAT_IGNORE_NON_VIRTUAL) - if (!p.p.is_virtual) -#endif - { - friction_thermo_langevin_rotation(&p); - - p.f.torque[0] += tx; - p.f.torque[1] += ty; - p.f.torque[2] += tz; - } - } else { - p.f.torque[0] = tx; - p.f.torque[1] = ty; - p.f.torque[2] = tz; - } - - if (!(p.p.rotation & ROTATION_X)) - p.f.torque[0] = 0; - - if (!(p.p.rotation & ROTATION_Y)) - p.f.torque[1] = 0; - - if (!(p.p.rotation & ROTATION_Z)) - p.f.torque[2] = 0; + convert_torque_to_body_frame_apply_fix_and_thermostat(p); #if defined(ENGINE) && (defined(LB) || defined(LB_GPU)) - double omega_swim[3] = {0, 0, 0}; - double omega_swim_body[3] = {0, 0, 0}; if (p.swim.swimming && lattice_switch != 0) { - double diff[3]; - double cross[3]; - double l_diff, l_cross; auto const dip = p.swim.dipole_length * p.r.calc_director(); - diff[0] = (p.swim.v_center[0] - p.swim.v_source[0]); - diff[1] = (p.swim.v_center[1] - p.swim.v_source[1]); - diff[2] = (p.swim.v_center[2] - p.swim.v_source[2]); - - cross[0] = diff[1] * dip[2] - diff[2] * dip[1]; - cross[1] = diff[0] * dip[2] - diff[2] * dip[0]; - cross[2] = diff[0] * dip[1] - diff[1] * dip[0]; + auto const diff = p.swim.v_center - p.swim.v_source; - l_diff = sqrt(diff[0] * diff[0] + diff[1] * diff[1] + diff[2] * diff[2]); - l_cross = - sqrt(cross[0] * cross[0] + cross[1] * cross[1] + cross[2] * cross[2]); + const Vector3d cross = Vector3d::cross(diff, dip); + const double l_diff = diff.norm(); + const double l_cross = cross.norm(); if (l_cross > 0 && p.swim.dipole_length > 0) { - omega_swim[0] = l_diff * cross[0] / (l_cross * p.swim.dipole_length); - omega_swim[1] = l_diff * cross[1] / (l_cross * p.swim.dipole_length); - omega_swim[2] = l_diff * cross[2] / (l_cross * p.swim.dipole_length); - - omega_swim_body[0] = A[0 + 3 * 0] * omega_swim[0] + - A[0 + 3 * 1] * omega_swim[1] + - A[0 + 3 * 2] * omega_swim[2]; - omega_swim_body[1] = A[1 + 3 * 0] * omega_swim[0] + - A[1 + 3 * 1] * omega_swim[1] + - A[1 + 3 * 2] * omega_swim[2]; - omega_swim_body[2] = A[2 + 3 * 0] * omega_swim[0] + - A[2 + 3 * 1] * omega_swim[1] + - A[2 + 3 * 2] * omega_swim[2]; - - p.f.torque[0] += - p.swim.rotational_friction * (omega_swim_body[0] - p.m.omega[0]); - p.f.torque[1] += - p.swim.rotational_friction * (omega_swim_body[1] - p.m.omega[1]); - p.f.torque[2] += - p.swim.rotational_friction * (omega_swim_body[2] - p.m.omega[2]); + auto const omega_swim = + l_diff / (l_cross * p.swim.dipole_length) * cross; + + auto const omega_swim_body = + convert_vector_space_to_body(p, omega_swim); + p.f.torque += + p.swim.rotational_friction * (omega_swim_body - p.m.omega); } } #endif @@ -370,36 +333,31 @@ void convert_torques_propagate_omega() { stderr, "%d: OPT: SCAL f = (%.3e,%.3e,%.3e) v_old = (%.3e,%.3e,%.3e)\n", this_node, p.f.f[0], p.f.f[1], p.f.f[2], p.m.v[0], p.m.v[1], p.m.v[2])); + // Propagation of angular velocities p.m.omega[0] += time_step_half * p.f.torque[0] / p.p.rinertia[0]; p.m.omega[1] += time_step_half * p.f.torque[1] / p.p.rinertia[1]; p.m.omega[2] += time_step_half * p.f.torque[2] / p.p.rinertia[2]; // zeroth estimate of omega - for (int j = 0; j < 3; j++) - omega_0[j] = p.m.omega[j]; + Vector3d omega_0 = p.m.omega; /* if the tensor of inertia is isotropic, the following refinement is not needed. Otherwise repeat this loop 2-3 times depending on the required accuracy */ + + const double rinertia_diff_01 = p.p.rinertia[0] - p.p.rinertia[1]; + const double rinertia_diff_12 = p.p.rinertia[1] - p.p.rinertia[2]; + const double rinertia_diff_20 = p.p.rinertia[2] - p.p.rinertia[0]; for (int times = 0; times <= 5; times++) { - double Wd[3]; - - Wd[0] = - (p.m.omega[1] * p.m.omega[2] * (p.p.rinertia[1] - p.p.rinertia[2])) / - p.p.rinertia[0]; - Wd[1] = - (p.m.omega[2] * p.m.omega[0] * (p.p.rinertia[2] - p.p.rinertia[0])) / - p.p.rinertia[1]; - Wd[2] = - (p.m.omega[0] * p.m.omega[1] * (p.p.rinertia[0] - p.p.rinertia[1])) / - p.p.rinertia[2]; - - p.m.omega[0] = omega_0[0] + time_step_half * Wd[0]; - p.m.omega[1] = omega_0[1] + time_step_half * Wd[1]; - p.m.omega[2] = omega_0[2] + time_step_half * Wd[2]; - } + Vector3d Wd; + + Wd[0] = p.m.omega[1] * p.m.omega[2] * rinertia_diff_12 / p.p.rinertia[0]; + Wd[1] = p.m.omega[2] * p.m.omega[0] * rinertia_diff_20 / p.p.rinertia[1]; + Wd[2] = p.m.omega[0] * p.m.omega[1] * rinertia_diff_01 / p.p.rinertia[2]; + p.m.omega = omega_0 + time_step_half * Wd; + } ONEPART_TRACE(if (p.p.identity == check_id) fprintf( stderr, "%d: OPT: PV_2 v_new = (%.3e,%.3e,%.3e)\n", this_node, p.m.v[0], p.m.v[1], p.m.v[2])); @@ -408,62 +366,15 @@ void convert_torques_propagate_omega() { /** convert the torques to the body-fixed frames before the integration loop */ void convert_initial_torques() { - double tx, ty, tz; INTEG_TRACE(fprintf(stderr, "%d: convert_initial_torques:\n", this_node)); for (auto &p : local_cells.particles()) { if (!p.p.rotation) continue; - double A[9]; - define_rotation_matrix(p, A); - - tx = A[0 + 3 * 0] * p.f.torque[0] + A[0 + 3 * 1] * p.f.torque[1] + - A[0 + 3 * 2] * p.f.torque[2]; - ty = A[1 + 3 * 0] * p.f.torque[0] + A[1 + 3 * 1] * p.f.torque[1] + - A[1 + 3 * 2] * p.f.torque[2]; - tz = A[2 + 3 * 0] * p.f.torque[0] + A[2 + 3 * 1] * p.f.torque[1] + - A[2 + 3 * 2] * p.f.torque[2]; - - if (thermo_switch & THERMO_LANGEVIN) { - - friction_thermo_langevin_rotation(&p); - p.f.torque[0] += tx; - p.f.torque[1] += ty; - p.f.torque[2] += tz; - } else { - p.f.torque[0] = tx; - p.f.torque[1] = ty; - p.f.torque[2] = tz; - } - - if (!(p.p.rotation & ROTATION_X)) - p.f.torque[0] = 0; - - if (!(p.p.rotation & ROTATION_Y)) - p.f.torque[1] = 0; - - if (!(p.p.rotation & ROTATION_Z)) - p.f.torque[2] = 0; - - ONEPART_TRACE(if (p.p.identity == check_id) fprintf( - stderr, "%d: OPT: SCAL f = (%.3e,%.3e,%.3e) v_old = (%.3e,%.3e,%.3e)\n", - this_node, p.f.f[0], p.f.f[1], p.f.f[2], p.m.v[0], p.m.v[1], p.m.v[2])); + convert_torque_to_body_frame_apply_fix_and_thermostat(p); } } - -/** convert from the body-fixed frames to space-fixed coordinates */ - -void convert_omega_body_to_space(const Particle *p, double *omega) { - double A[9]; - define_rotation_matrix(*p, A); - - omega[0] = A[0 + 3 * 0] * p->m.omega[0] + A[1 + 3 * 0] * p->m.omega[1] + - A[2 + 3 * 0] * p->m.omega[2]; - omega[1] = A[0 + 3 * 1] * p->m.omega[0] + A[1 + 3 * 1] * p->m.omega[1] + - A[2 + 3 * 1] * p->m.omega[2]; - omega[2] = A[0 + 3 * 2] * p->m.omega[0] + A[1 + 3 * 2] * p->m.omega[1] + - A[2 + 3 * 2] * p->m.omega[2]; -} +// Frame conversion routines Vector3d convert_vector_body_to_space(const Particle &p, const Vector3d &vec) { Vector3d res = {0, 0, 0}; @@ -490,82 +401,48 @@ Vector3d convert_vector_space_to_body(const Particle &p, const Vector3d &v) { return res; } -void convert_torques_body_to_space(const Particle *p, double *torque) { - double A[9]; - define_rotation_matrix(*p, A); - - torque[0] = A[0 + 3 * 0] * p->f.torque[0] + A[1 + 3 * 0] * p->f.torque[1] + - A[2 + 3 * 0] * p->f.torque[2]; - torque[1] = A[0 + 3 * 1] * p->f.torque[0] + A[1 + 3 * 1] * p->f.torque[1] + - A[2 + 3 * 1] * p->f.torque[2]; - torque[2] = A[0 + 3 * 2] * p->f.torque[0] + A[1 + 3 * 2] * p->f.torque[1] + - A[2 + 3 * 2] * p->f.torque[2]; -} - -void convert_vel_space_to_body(const Particle *p, double *vel_body) { - double A[9]; - define_rotation_matrix(*p, A); - - vel_body[0] = A[0 + 3 * 0] * p->m.v[0] + A[0 + 3 * 1] * p->m.v[1] + - A[0 + 3 * 2] * p->m.v[2]; - vel_body[1] = A[1 + 3 * 0] * p->m.v[0] + A[1 + 3 * 1] * p->m.v[1] + - A[1 + 3 * 2] * p->m.v[2]; - vel_body[2] = A[2 + 3 * 0] * p->m.v[0] + A[2 + 3 * 1] * p->m.v[1] + - A[2 + 3 * 2] * p->m.v[2]; -} - -void convert_vec_space_to_body(Particle *p, double *v, double *res) { - double A[9]; - define_rotation_matrix(*p, A); - - res[0] = A[0 + 3 * 0] * v[0] + A[0 + 3 * 1] * v[1] + A[0 + 3 * 2] * v[2]; - res[1] = A[1 + 3 * 0] * v[0] + A[1 + 3 * 1] * v[1] + A[1 + 3 * 2] * v[2]; - res[2] = A[2 + 3 * 0] * v[0] + A[2 + 3 * 1] * v[1] + A[2 + 3 * 2] * v[2]; -} - /** Rotate the particle p around the NORMALIZED axis aSpaceFrame by amount phi */ -void local_rotate_particle(Particle *p, double *aSpaceFrame, double phi) { +void local_rotate_particle(Particle &p, const Vector3d &axis_space_frame, + const double phi) { // Convert rotation axis to body-fixed frame - double a[3]; - convert_vec_space_to_body(p, aSpaceFrame, a); + Vector3d axis = convert_vector_space_to_body(p, axis_space_frame); // printf("%g %g %g - ",a[0],a[1],a[2]); // Rotation turned off entirely? - if (!p->p.rotation) + if (!p.p.rotation) return; // Per coordinate fixing - if (!(p->p.rotation & ROTATION_X)) - a[0] = 0; - if (!(p->p.rotation & ROTATION_Y)) - a[1] = 0; - if (!(p->p.rotation & ROTATION_Z)) - a[2] = 0; + if (!(p.p.rotation & ROTATION_X)) + axis[0] = 0; + if (!(p.p.rotation & ROTATION_Y)) + axis[1] = 0; + if (!(p.p.rotation & ROTATION_Z)) + axis[2] = 0; // Re-normalize rotation axis - double l = sqrt(sqrlen(a)); + double l = axis.norm(); // Check, if the rotation axis is nonzero - if (l < 1E-10) + if (l < std::numeric_limits::epsilon()) return; - for (int i = 0; i < 3; i++) - a[i] /= l; + axis /= l; double q[4]; q[0] = cos(phi / 2); double tmp = sin(phi / 2); - q[1] = tmp * a[0]; - q[2] = tmp * a[1]; - q[3] = tmp * a[2]; + q[1] = tmp * axis[0]; + q[2] = tmp * axis[1]; + q[3] = tmp * axis[2]; // Normalize normalize_quaternion(q); // Rotate the particle double qn[4]; // Resulting quaternion - multiply_quaternions(p->r.quat, q, qn); + multiply_quaternions(p.r.quat, q, qn); for (int k = 0; k < 4; k++) - p->r.quat[k] = qn[k]; + p.r.quat[k] = qn[k]; } #endif diff --git a/src/core/rotation.hpp b/src/core/rotation.hpp index 4f85ea1650a..5f7baf5a12b 100644 --- a/src/core/rotation.hpp +++ b/src/core/rotation.hpp @@ -52,23 +52,9 @@ void convert_torques_propagate_omega(); the integration loop */ void convert_initial_torques(); -/** convert angular velocities and torques from the - body-fixed frames to space-fixed coordinates */ -void convert_omega_body_to_space(const Particle *p, double *omega); -void convert_torques_body_to_space(const Particle *p, double *torque); - Vector3d convert_vector_body_to_space(const Particle &p, const Vector3d &v); Vector3d convert_vector_space_to_body(const Particle &p, const Vector3d &v); -/** convert velocity form the lab-fixed coordinates - to the body-fixed frame */ -void convert_vel_space_to_body(const Particle *p, double *vel_body); - -/** Here we use quaternions to calculate the rotation matrix which - will be used then to transform torques from the laboratory to - the body-fixed frames */ -void define_rotation_matrix(Particle const &p, double A[9]); - inline void convert_quat_to_director(const Vector<4, double> &quat, Vector3d &director) { /* director */ @@ -105,19 +91,10 @@ inline int convert_dip_to_quat(const Vector3d &dip, Vector<4, double> &quat, return 0; } -/** convert quaternion director to the dipole moment */ -inline void convert_director_to_dip(const Vector3d &director, double dipm, - Vector3d &dip) { - /* dipole moment */ - dip[0] = director[0] * dipm; - dip[1] = director[1] * dipm; - dip[2] = director[2] * dipm; -} - #endif /** Rotate the particle p around the NORMALIZED axis a by amount phi */ -void local_rotate_particle(Particle *p, double *a, double phi); +void local_rotate_particle(Particle &p, const Vector3d &a, const double phi); inline void normalize_quaternion(double *q) { double tmp = sqrt(q[0] * q[0] + q[1] * q[1] + q[2] * q[2] + q[3] * q[3]); diff --git a/src/core/virtual_sites/VirtualSitesRelative.cpp b/src/core/virtual_sites/VirtualSitesRelative.cpp index 9ab86eb5fc3..dc97726af30 100644 --- a/src/core/virtual_sites/VirtualSitesRelative.cpp +++ b/src/core/virtual_sites/VirtualSitesRelative.cpp @@ -140,8 +140,8 @@ void VirtualSitesRelative::update_vel(Particle &p) const { get_mi_vector(d, p.r.p, p_real->r.p); // Get omega of real particle in space-fixed frame - double omega_space_frame[3]; - convert_omega_body_to_space(p_real, omega_space_frame); + Vector3d omega_space_frame = + convert_vector_body_to_space(*p_real, p_real->m.omega); // Obtain velocity from v=v_real particle + omega_real_particle \times // director vector_product(omega_space_frame, d, p.m.v); diff --git a/src/python/espressomd/particle_data.pxd b/src/python/espressomd/particle_data.pxd index 44ab4fe80dc..37bcfb70bd6 100644 --- a/src/python/espressomd/particle_data.pxd +++ b/src/python/espressomd/particle_data.pxd @@ -124,12 +124,12 @@ cdef extern from "particle_data.hpp": IF ROTATION: int set_particle_quat(int part, double quat[4]) void pointer_to_quat(const particle * p, const double * & res) - int set_particle_omega_lab(int part, double omega[3]) - int set_particle_omega_body(int part, double omega[3]) - int set_particle_torque_lab(int part, double torque[3]) - int set_particle_torque_body(int part, double torque[3]) + int set_particle_omega_lab(int part, Vector3d omega) + int set_particle_omega_body(int part, Vector3d omega) + int set_particle_torque_lab(int part, Vector3d torque) + int set_particle_torque_body(int part, Vector3d torque) void pointer_to_omega_body(const particle * p, const double * & res) - void pointer_to_torque_lab(const particle * p, const double * & res) + Vector3d get_torque_body(const particle p) IF MEMBRANE_COLLISION: int set_particle_out_direction(int part, double out_direction[3]) @@ -225,11 +225,9 @@ cdef extern from "virtual_sites.hpp": int vs_relate_to(int part_num, int relate_to) cdef extern from "rotation.hpp": - void convert_omega_body_to_space(const particle * p, double * omega) - void convert_torques_body_to_space(const particle * p, double * torque) Vector3d convert_vector_body_to_space(const particle & p, const Vector3d & v) Vector3d convert_vector_space_to_body(const particle & p, const Vector3d & v) - void rotate_particle(int id, double * axis, double angle) + void rotate_particle(int id, Vector3d axis, double angle) cdef class ParticleHandle(object): cdef public int _id diff --git a/src/python/espressomd/particle_data.pyx b/src/python/espressomd/particle_data.pyx index 53412de8d1c..6a9ef388683 100644 --- a/src/python/espressomd/particle_data.pyx +++ b/src/python/espressomd/particle_data.pyx @@ -403,7 +403,7 @@ cdef class ParticleHandle(object): """ def __set__(self, _o): - cdef double myo[3] + cdef Vector3d myo check_type_or_throw_except( _o, 3, float, "Omega_lab has to be 3 floats.") for i in range(3): @@ -413,10 +413,7 @@ cdef class ParticleHandle(object): def __get__(self): self.update_particle_data() - cdef double o[3] - - convert_omega_body_to_space(self.particle_data, o) - return array_locked([o[0], o[1], o[2]]) + return array_locked(self.convert_vector_body_to_space(self.omega_body)) property quat: """ @@ -482,7 +479,7 @@ cdef class ParticleHandle(object): """ def __set__(self, _o): - cdef double myo[3] + cdef Vector3d myo check_type_or_throw_except( _o, 3, float, "Omega_body has to be 3 floats.") for i in range(3): @@ -518,7 +515,7 @@ cdef class ParticleHandle(object): """ def __set__(self, _t): - cdef double myt[3] + cdef Vector3d myt check_type_or_throw_except( _t, 3, float, "Torque has to be 3 floats.") for i in range(3): @@ -528,10 +525,13 @@ cdef class ParticleHandle(object): def __get__(self): self.update_particle_data() - cdef double x[3] + cdef Vector3d torque_body + cdef Vector3d torque_space + torque_body = get_torque_body(self.particle_data[0]) + torque_space = convert_vector_body_to_space( + self.particle_data[0], torque_body) - convert_torques_body_to_space(self.particle_data, x) - return array_locked([x[0], x[1], x[2]]) + return make_array_locked(torque_space) IF ROTATIONAL_INERTIA: property rinertia: @@ -1620,7 +1620,7 @@ cdef class ParticleHandle(object): angle : float """ - cdef double[3] a + cdef Vector3d a a[0] = axis[0] a[1] = axis[1] a[2] = axis[2] diff --git a/testsuite/python/data/engine_lb.vtk b/testsuite/python/data/engine_lb.vtk index ff798cf5ab0..48d1bb422c5 100644 --- a/testsuite/python/data/engine_lb.vtk +++ b/testsuite/python/data/engine_lb.vtk @@ -8,247 +8,247 @@ SPACING 1.000000 1.000000 1.000000 POINT_DATA 1728 SCALARS velocity float 3 LOOKUP_TABLE default -0.000125 -0.000021 -0.000027 -0.000103 -0.000070 0.000000 +0.000125 -0.000021 -0.000028 +0.000103 -0.000070 -0.000000 0.000037 -0.000113 0.000007 --0.000044 -0.000119 0.000003 --0.000099 -0.000087 -0.000009 +-0.000044 -0.000119 0.000004 +-0.000099 -0.000087 -0.000008 -0.000102 -0.000043 -0.000037 -0.000067 -0.000007 -0.000066 -0.000025 0.000011 -0.000081 -0.000014 0.000019 -0.000085 -0.000048 0.000022 -0.000083 -0.000080 0.000024 -0.000074 -0.000110 0.000012 -0.000057 -0.000115 -0.000006 -0.000036 -0.000087 -0.000025 -0.000014 +0.000014 0.000018 -0.000085 +0.000048 0.000022 -0.000084 +0.000080 0.000023 -0.000076 +0.000110 0.000012 -0.000058 +0.000115 -0.000006 -0.000037 +0.000087 -0.000025 -0.000015 0.000028 -0.000045 -0.000008 --0.000039 -0.000048 -0.000015 --0.000080 -0.000036 -0.000030 --0.000086 -0.000022 -0.000050 +-0.000038 -0.000048 -0.000014 +-0.000080 -0.000035 -0.000029 +-0.000086 -0.000022 -0.000049 -0.000065 -0.000009 -0.000068 -0.000030 0.000000 -0.000079 -0.000010 0.000006 -0.000082 -0.000050 0.000009 -0.000080 -0.000086 0.000009 -0.000072 -0.000111 0.000005 -0.000058 -0.000113 0.000008 -0.000038 -0.000085 0.000010 -0.000017 -0.000023 0.000010 -0.000011 --0.000040 0.000010 -0.000021 --0.000074 0.000007 -0.000036 --0.000078 0.000002 -0.000054 --0.000061 -0.000002 -0.000070 +0.000010 0.000006 -0.000083 +0.000050 0.000009 -0.000081 +0.000086 0.000009 -0.000074 +0.000111 0.000005 -0.000060 +0.000113 0.000008 -0.000040 +0.000086 0.000010 -0.000018 +0.000024 0.000010 -0.000011 +-0.000040 0.000010 -0.000020 +-0.000074 0.000007 -0.000035 +-0.000078 0.000002 -0.000053 +-0.000061 -0.000002 -0.000069 -0.000030 -0.000005 -0.000079 -0.000009 -0.000005 -0.000082 -0.000050 -0.000005 -0.000080 -0.000085 -0.000002 -0.000072 -0.000109 0.000003 -0.000059 -0.000116 0.000019 -0.000037 -0.000089 0.000044 -0.000014 +0.000009 -0.000005 -0.000083 +0.000050 -0.000005 -0.000081 +0.000085 -0.000002 -0.000074 +0.000109 0.000003 -0.000061 +0.000116 0.000019 -0.000039 +0.000089 0.000044 -0.000015 0.000025 0.000065 -0.000007 --0.000041 0.000065 -0.000017 --0.000077 0.000046 -0.000033 --0.000080 0.000024 -0.000052 +-0.000041 0.000065 -0.000016 +-0.000077 0.000046 -0.000031 +-0.000080 0.000024 -0.000051 -0.000059 0.000005 -0.000070 -0.000026 -0.000009 -0.000081 -0.000012 -0.000016 -0.000084 -0.000049 -0.000017 -0.000082 -0.000082 -0.000012 -0.000074 -0.000108 -0.000001 -0.000059 -0.000122 0.000029 -0.000029 -0.000100 0.000083 0.000000 +0.000012 -0.000016 -0.000085 +0.000049 -0.000017 -0.000083 +0.000082 -0.000012 -0.000076 +0.000108 -0.000001 -0.000062 +0.000123 0.000029 -0.000030 +0.000101 0.000083 -0.000000 0.000034 0.000126 0.000006 --0.000044 0.000128 -0.000001 --0.000093 0.000092 -0.000016 --0.000091 0.000044 -0.000044 --0.000057 0.000004 -0.000072 +-0.000044 0.000128 -0.000000 +-0.000093 0.000092 -0.000015 +-0.000091 0.000044 -0.000043 +-0.000057 0.000004 -0.000071 -0.000017 -0.000016 -0.000085 0.000017 -0.000024 -0.000089 -0.000046 -0.000027 -0.000086 -0.000076 -0.000025 -0.000078 -0.000105 -0.000009 -0.000060 -0.000119 0.000021 -0.000028 -0.000123 0.000121 0.000023 +0.000046 -0.000027 -0.000087 +0.000076 -0.000025 -0.000080 +0.000105 -0.000009 -0.000062 +0.000119 0.000021 -0.000029 +0.000124 0.000121 0.000022 0.000053 0.000201 0.000032 -0.000059 0.000205 0.000027 --0.000118 0.000135 0.000011 --0.000092 0.000040 -0.000042 --0.000039 -0.000011 -0.000082 +-0.000117 0.000135 0.000012 +-0.000092 0.000040 -0.000041 +-0.000038 -0.000011 -0.000082 -0.000001 -0.000026 -0.000094 -0.000023 -0.000029 -0.000095 -0.000043 -0.000033 -0.000093 -0.000061 -0.000038 -0.000087 -0.000085 -0.000029 -0.000070 -0.000040 -0.000032 -0.000082 +0.000023 -0.000029 -0.000096 +0.000043 -0.000033 -0.000094 +0.000061 -0.000038 -0.000088 +0.000086 -0.000029 -0.000072 +0.000040 -0.000032 -0.000083 0.000074 0.000091 -0.000029 0.000045 0.000255 0.000013 --0.000048 0.000260 0.000010 +-0.000048 0.000260 0.000011 -0.000068 0.000104 -0.000036 --0.000016 -0.000015 -0.000093 -0.000017 -0.000036 -0.000112 +-0.000016 -0.000015 -0.000092 +0.000017 -0.000036 -0.000111 0.000027 -0.000029 -0.000108 -0.000032 -0.000027 -0.000103 -0.000035 -0.000032 -0.000101 -0.000033 -0.000043 -0.000100 -0.000028 -0.000055 -0.000101 --0.000111 -0.000071 -0.000177 --0.000136 0.000003 -0.000238 +0.000032 -0.000027 -0.000104 +0.000035 -0.000032 -0.000102 +0.000033 -0.000043 -0.000101 +0.000028 -0.000055 -0.000102 +-0.000111 -0.000071 -0.000178 +-0.000136 0.000003 -0.000239 -0.000066 0.000181 -0.000254 0.000061 0.000185 -0.000255 0.000142 0.000011 -0.000245 0.000133 -0.000060 -0.000186 0.000089 -0.000038 -0.000134 -0.000060 -0.000017 -0.000114 +0.000061 -0.000017 -0.000114 0.000043 -0.000013 -0.000106 -0.000026 -0.000019 -0.000103 +0.000026 -0.000019 -0.000104 -0.000002 -0.000030 -0.000107 --0.000049 -0.000052 -0.000126 --0.000192 -0.000011 -0.000222 +-0.000049 -0.000052 -0.000127 +-0.000192 -0.000011 -0.000223 -0.000289 -0.000016 -0.000389 --0.000164 -0.000017 -0.000504 +-0.000163 -0.000017 -0.000504 0.000150 -0.000019 -0.000506 0.000292 -0.000016 -0.000396 0.000212 -0.000007 -0.000230 0.000119 0.000003 -0.000134 -0.000074 0.000008 -0.000110 -0.000049 0.000009 -0.000103 -0.000021 0.000007 -0.000100 --0.000019 0.000002 -0.000104 --0.000084 -0.000003 -0.000128 +0.000075 0.000008 -0.000110 +0.000049 0.000010 -0.000103 +0.000022 0.000007 -0.000101 +-0.000019 0.000002 -0.000105 +-0.000083 -0.000003 -0.000129 -0.000111 0.000057 -0.000177 -0.000144 -0.000024 -0.000244 -0.000075 -0.000207 -0.000265 0.000061 -0.000216 -0.000265 -0.000141 -0.000035 -0.000246 -0.000125 0.000052 -0.000181 -0.000079 0.000043 -0.000128 -0.000053 0.000030 -0.000110 -0.000041 0.000028 -0.000103 -0.000027 0.000030 -0.000100 --0.000000 0.000034 -0.000104 --0.000046 0.000047 -0.000123 -0.000043 0.000029 -0.000081 -0.000076 -0.000097 -0.000026 +0.000142 -0.000035 -0.000246 +0.000126 0.000052 -0.000181 +0.000080 0.000043 -0.000128 +0.000054 0.000030 -0.000110 +0.000042 0.000028 -0.000103 +0.000027 0.000030 -0.000101 +-0.000000 0.000034 -0.000105 +-0.000046 0.000047 -0.000124 +0.000043 0.000029 -0.000082 +0.000077 -0.000097 -0.000026 0.000046 -0.000273 0.000025 -0.000054 -0.000282 0.000026 -0.000080 -0.000115 -0.000025 --0.000032 0.000013 -0.000083 +-0.000031 0.000013 -0.000083 0.000002 0.000040 -0.000104 -0.000016 0.000036 -0.000103 -0.000028 0.000035 -0.000099 -0.000037 0.000040 -0.000096 -0.000038 0.000048 -0.000096 -0.000032 0.000054 -0.000098 -0.000124 -0.000019 -0.000025 +0.000017 0.000036 -0.000103 +0.000028 0.000035 -0.000100 +0.000037 0.000040 -0.000097 +0.000038 0.000048 -0.000097 +0.000033 0.000054 -0.000099 +0.000125 -0.000019 -0.000026 0.000131 -0.000121 0.000027 0.000058 -0.000203 0.000039 -0.000063 -0.000210 0.000037 -0.000131 -0.000140 0.000025 --0.000109 -0.000042 -0.000030 +-0.000108 -0.000042 -0.000030 -0.000053 0.000010 -0.000074 -0.000011 0.000026 -0.000088 -0.000019 0.000029 -0.000090 -0.000044 0.000034 -0.000088 -0.000066 0.000039 -0.000082 -0.000091 0.000031 -0.000066 -0.000129 -0.000027 -0.000044 -0.000110 -0.000102 -0.000022 -0.000043 -0.000185 -0.000017 --0.000053 -0.000195 -0.000028 --0.000109 -0.000127 -0.000053 --0.000101 -0.000059 -0.000083 +0.000019 0.000029 -0.000091 +0.000044 0.000034 -0.000089 +0.000066 0.000039 -0.000083 +0.000091 0.000031 -0.000067 +0.000129 -0.000027 -0.000045 +0.000111 -0.000102 -0.000022 +0.000043 -0.000185 -0.000016 +-0.000053 -0.000194 -0.000027 +-0.000109 -0.000127 -0.000052 +-0.000102 -0.000059 -0.000082 -0.000065 -0.000019 -0.000102 --0.000024 0.000003 -0.000108 +-0.000025 0.000003 -0.000108 0.000011 0.000012 -0.000109 -0.000044 0.000016 -0.000104 -0.000080 0.000017 -0.000093 -0.000114 0.000008 -0.000072 -0.000122 -0.000008 -0.000045 -0.000096 -0.000037 -0.000017 +0.000044 0.000015 -0.000106 +0.000080 0.000017 -0.000095 +0.000114 0.000007 -0.000073 +0.000122 -0.000008 -0.000047 +0.000096 -0.000037 -0.000018 0.000032 -0.000075 -0.000013 --0.000044 -0.000080 -0.000035 --0.000087 -0.000054 -0.000066 --0.000086 -0.000031 -0.000091 --0.000063 -0.000016 -0.000105 +-0.000044 -0.000080 -0.000034 +-0.000087 -0.000054 -0.000065 +-0.000087 -0.000031 -0.000090 +-0.000064 -0.000016 -0.000105 -0.000030 -0.000005 -0.000111 -0.000007 0.000002 -0.000111 -0.000046 0.000005 -0.000107 -0.000084 0.000005 -0.000096 -0.000115 0.000002 -0.000075 -0.000120 0.000011 -0.000046 -0.000095 0.000014 -0.000012 -0.000027 0.000014 -0.000008 --0.000045 0.000013 -0.000038 --0.000079 0.000008 -0.000071 --0.000077 0.000002 -0.000093 --0.000058 -0.000003 -0.000107 --0.000029 -0.000005 -0.000113 -0.000006 -0.000006 -0.000113 -0.000045 -0.000005 -0.000108 -0.000083 -0.000002 -0.000096 -0.000111 0.000005 -0.000077 -0.000123 0.000026 -0.000045 -0.000098 0.000064 -0.000010 -0.000029 0.000102 -0.000006 --0.000047 0.000102 -0.000036 --0.000083 0.000067 -0.000069 --0.000079 0.000034 -0.000093 +0.000007 0.000002 -0.000112 +0.000045 0.000005 -0.000108 +0.000084 0.000004 -0.000097 +0.000114 0.000002 -0.000078 +0.000120 0.000011 -0.000048 +0.000095 0.000014 -0.000013 +0.000028 0.000014 -0.000007 +-0.000045 0.000013 -0.000036 +-0.000080 0.000009 -0.000069 +-0.000078 0.000002 -0.000092 +-0.000058 -0.000002 -0.000106 +-0.000030 -0.000005 -0.000113 +0.000005 -0.000006 -0.000114 +0.000044 -0.000005 -0.000110 +0.000082 -0.000002 -0.000099 +0.000110 0.000004 -0.000079 +0.000123 0.000026 -0.000048 +0.000098 0.000064 -0.000012 +0.000029 0.000102 -0.000005 +-0.000047 0.000102 -0.000034 +-0.000083 0.000067 -0.000067 +-0.000080 0.000034 -0.000091 -0.000057 0.000011 -0.000107 --0.000025 -0.000005 -0.000113 -0.000008 -0.000013 -0.000113 -0.000043 -0.000014 -0.000109 -0.000080 -0.000009 -0.000097 -0.000111 0.000004 -0.000077 -0.000126 0.000040 -0.000042 -0.000109 0.000121 -0.000010 +-0.000026 -0.000005 -0.000113 +0.000007 -0.000013 -0.000114 +0.000043 -0.000014 -0.000110 +0.000079 -0.000009 -0.000099 +0.000110 0.000004 -0.000079 +0.000126 0.000040 -0.000044 +0.000110 0.000121 -0.000010 0.000040 0.000205 -0.000004 --0.000051 0.000207 -0.000026 --0.000098 0.000135 -0.000059 --0.000088 0.000062 -0.000089 --0.000053 0.000016 -0.000106 +-0.000052 0.000207 -0.000025 +-0.000099 0.000134 -0.000058 +-0.000089 0.000061 -0.000088 +-0.000054 0.000015 -0.000106 -0.000017 -0.000009 -0.000113 -0.000014 -0.000018 -0.000113 -0.000042 -0.000021 -0.000108 -0.000074 -0.000018 -0.000097 -0.000107 -0.000002 -0.000076 -0.000121 0.000038 -0.000041 +0.000013 -0.000018 -0.000113 +0.000041 -0.000021 -0.000109 +0.000073 -0.000018 -0.000099 +0.000107 -0.000002 -0.000079 +0.000121 0.000039 -0.000042 0.000136 0.000194 -0.000004 0.000064 0.000359 0.000006 --0.000072 0.000364 -0.000006 --0.000130 0.000213 -0.000036 --0.000088 0.000067 -0.000081 --0.000034 0.000004 -0.000107 -0.000000 -0.000017 -0.000113 -0.000021 -0.000022 -0.000112 -0.000039 -0.000026 -0.000108 -0.000060 -0.000031 -0.000097 -0.000089 -0.000021 -0.000076 -0.000065 0.000008 -0.000060 -0.000120 0.000250 -0.000024 +-0.000072 0.000364 -0.000005 +-0.000130 0.000212 -0.000035 +-0.000089 0.000067 -0.000080 +-0.000035 0.000004 -0.000107 +-0.000000 -0.000017 -0.000113 +0.000020 -0.000022 -0.000113 +0.000038 -0.000025 -0.000109 +0.000060 -0.000030 -0.000099 +0.000088 -0.000021 -0.000077 +0.000065 0.000009 -0.000061 +0.000120 0.000250 -0.000025 0.000077 0.000594 0.000004 --0.000078 0.000600 -0.000002 --0.000114 0.000266 -0.000042 +-0.000078 0.000599 -0.000001 +-0.000114 0.000265 -0.000041 -0.000037 0.000033 -0.000087 -0.000010 -0.000021 -0.000111 +0.000010 -0.000021 -0.000110 0.000025 -0.000024 -0.000114 -0.000030 -0.000023 -0.000112 -0.000034 -0.000028 -0.000107 -0.000039 -0.000042 -0.000096 -0.000042 -0.000048 -0.000082 --0.000109 -0.000031 -0.000109 --0.000145 0.000180 -0.000140 +0.000029 -0.000023 -0.000112 +0.000034 -0.000028 -0.000108 +0.000038 -0.000042 -0.000098 +0.000042 -0.000047 -0.000083 +-0.000109 -0.000031 -0.000110 +-0.000144 0.000181 -0.000140 -0.000076 0.000583 -0.000155 -0.000075 0.000588 -0.000159 -0.000154 0.000188 -0.000153 +0.000075 0.000587 -0.000159 +0.000154 0.000188 -0.000152 0.000133 -0.000017 -0.000127 -0.000094 -0.000034 -0.000113 +0.000094 -0.000035 -0.000113 0.000065 -0.000022 -0.000110 0.000044 -0.000017 -0.000107 -0.000024 -0.000023 -0.000101 --0.000003 -0.000038 -0.000094 --0.000048 -0.000054 -0.000093 --0.000240 -0.000013 -0.000142 +0.000024 -0.000023 -0.000102 +-0.000003 -0.000038 -0.000095 +-0.000048 -0.000053 -0.000093 +-0.000240 -0.000013 -0.000143 -0.000400 -0.000013 -0.000235 -0.000246 -0.000004 -0.000316 0.000228 -0.000011 -0.000320 @@ -258,296 +258,296 @@ LOOKUP_TABLE default 0.000089 0.000009 -0.000104 0.000052 0.000010 -0.000101 0.000016 0.000007 -0.000096 --0.000032 0.000001 -0.000091 +-0.000032 0.000001 -0.000092 -0.000108 -0.000005 -0.000097 --0.000116 0.000014 -0.000113 +-0.000115 0.000014 -0.000114 -0.000168 -0.000198 -0.000149 -0.000099 -0.000607 -0.000167 -0.000076 -0.000628 -0.000170 +0.000076 -0.000628 -0.000169 0.000160 -0.000221 -0.000157 0.000128 0.000005 -0.000125 0.000084 0.000040 -0.000108 0.000058 0.000036 -0.000105 -0.000041 0.000034 -0.000102 -0.000025 0.000036 -0.000097 --0.000003 0.000042 -0.000092 --0.000050 0.000046 -0.000094 +0.000041 0.000034 -0.000103 +0.000025 0.000036 -0.000098 +-0.000003 0.000042 -0.000093 +-0.000050 0.000046 -0.000095 0.000067 -0.000015 -0.000066 0.000123 -0.000260 -0.000031 0.000078 -0.000623 0.000003 --0.000089 -0.000642 0.000001 +-0.000089 -0.000641 0.000001 -0.000134 -0.000289 -0.000038 --0.000058 -0.000037 -0.000080 +-0.000058 -0.000036 -0.000079 -0.000009 0.000025 -0.000102 0.000013 0.000032 -0.000108 -0.000026 0.000032 -0.000106 -0.000037 0.000038 -0.000100 -0.000044 0.000048 -0.000092 -0.000046 0.000046 -0.000083 -0.000126 -0.000036 -0.000046 +0.000026 0.000032 -0.000107 +0.000037 0.000038 -0.000101 +0.000044 0.000047 -0.000093 +0.000046 0.000046 -0.000084 +0.000126 -0.000036 -0.000047 0.000141 -0.000191 -0.000014 -0.000068 -0.000362 -0.000002 --0.000077 -0.000374 -0.000008 --0.000146 -0.000218 -0.000029 --0.000108 -0.000066 -0.000071 --0.000051 -0.000005 -0.000100 --0.000010 0.000016 -0.000108 -0.000017 0.000021 -0.000107 -0.000042 0.000026 -0.000102 -0.000069 0.000034 -0.000090 -0.000096 0.000025 -0.000072 -0.000142 -0.000012 -0.000063 -0.000118 -0.000081 -0.000056 +0.000069 -0.000361 -0.000002 +-0.000077 -0.000373 -0.000007 +-0.000146 -0.000217 -0.000028 +-0.000108 -0.000066 -0.000070 +-0.000052 -0.000004 -0.000099 +-0.000011 0.000016 -0.000108 +0.000017 0.000021 -0.000108 +0.000042 0.000026 -0.000103 +0.000068 0.000033 -0.000091 +0.000096 0.000024 -0.000073 +0.000141 -0.000012 -0.000064 +0.000118 -0.000081 -0.000057 0.000039 -0.000164 -0.000065 --0.000063 -0.000179 -0.000086 --0.000112 -0.000126 -0.000118 --0.000092 -0.000072 -0.000138 --0.000053 -0.000032 -0.000139 --0.000020 -0.000007 -0.000133 -0.000007 0.000002 -0.000130 -0.000034 0.000003 -0.000129 -0.000071 0.000005 -0.000119 -0.000117 0.000008 -0.000091 -0.000129 0.000002 -0.000058 -0.000104 -0.000018 -0.000022 -0.000030 -0.000055 -0.000027 --0.000049 -0.000069 -0.000072 --0.000079 -0.000057 -0.000122 --0.000070 -0.000042 -0.000145 --0.000049 -0.000025 -0.000145 --0.000024 -0.000012 -0.000140 -0.000002 -0.000005 -0.000137 -0.000032 -0.000004 -0.000135 -0.000068 -0.000005 -0.000128 -0.000108 -0.000001 -0.000103 -0.000119 0.000014 -0.000060 -0.000099 0.000021 -0.000009 -0.000029 0.000022 -0.000011 --0.000042 0.000016 -0.000072 --0.000065 0.000007 -0.000125 --0.000057 -0.000001 -0.000144 --0.000041 -0.000005 -0.000147 --0.000023 -0.000008 -0.000143 --0.000000 -0.000009 -0.000140 -0.000029 -0.000008 -0.000138 -0.000063 -0.000005 -0.000129 -0.000098 0.000003 -0.000106 -0.000122 0.000024 -0.000059 -0.000103 0.000057 -0.000010 -0.000030 0.000095 -0.000013 --0.000043 0.000100 -0.000073 --0.000069 0.000069 -0.000125 --0.000059 0.000037 -0.000144 --0.000040 0.000014 -0.000146 --0.000019 -0.000002 -0.000142 -0.000002 -0.000011 -0.000139 -0.000027 -0.000012 -0.000137 -0.000060 -0.000006 -0.000128 -0.000098 0.000006 -0.000105 -0.000133 0.000030 -0.000058 -0.000118 0.000103 -0.000027 -0.000037 0.000187 -0.000033 --0.000056 0.000198 -0.000078 --0.000091 0.000138 -0.000126 --0.000072 0.000072 -0.000144 --0.000039 0.000025 -0.000141 --0.000011 -0.000002 -0.000136 -0.000008 -0.000011 -0.000134 -0.000028 -0.000012 -0.000132 -0.000058 -0.000009 -0.000125 -0.000100 0.000001 -0.000100 -0.000133 0.000023 -0.000063 +-0.000063 -0.000178 -0.000085 +-0.000112 -0.000126 -0.000116 +-0.000093 -0.000071 -0.000137 +-0.000054 -0.000032 -0.000138 +-0.000021 -0.000007 -0.000133 +0.000006 0.000001 -0.000131 +0.000032 0.000002 -0.000130 +0.000070 0.000004 -0.000121 +0.000116 0.000007 -0.000093 +0.000128 0.000002 -0.000060 +0.000104 -0.000018 -0.000023 +0.000029 -0.000055 -0.000027 +-0.000050 -0.000068 -0.000071 +-0.000081 -0.000056 -0.000120 +-0.000071 -0.000041 -0.000143 +-0.000050 -0.000025 -0.000144 +-0.000026 -0.000012 -0.000140 +0.000001 -0.000005 -0.000138 +0.000030 -0.000004 -0.000137 +0.000066 -0.000005 -0.000131 +0.000106 -0.000002 -0.000106 +0.000118 0.000013 -0.000063 +0.000099 0.000021 -0.000010 +0.000028 0.000022 -0.000010 +-0.000043 0.000016 -0.000069 +-0.000067 0.000007 -0.000123 +-0.000058 -0.000001 -0.000143 +-0.000042 -0.000005 -0.000146 +-0.000024 -0.000008 -0.000143 +-0.000002 -0.000009 -0.000141 +0.000027 -0.000008 -0.000139 +0.000061 -0.000005 -0.000132 +0.000096 0.000003 -0.000109 +0.000121 0.000024 -0.000063 +0.000102 0.000057 -0.000011 +0.000030 0.000095 -0.000012 +-0.000044 0.000099 -0.000070 +-0.000070 0.000068 -0.000123 +-0.000060 0.000037 -0.000142 +-0.000042 0.000014 -0.000145 +-0.000021 -0.000002 -0.000142 +0.000001 -0.000011 -0.000139 +0.000025 -0.000011 -0.000138 +0.000058 -0.000005 -0.000131 +0.000096 0.000006 -0.000108 +0.000132 0.000030 -0.000061 +0.000117 0.000103 -0.000028 +0.000037 0.000186 -0.000033 +-0.000057 0.000197 -0.000076 +-0.000093 0.000137 -0.000124 +-0.000073 0.000071 -0.000143 +-0.000040 0.000025 -0.000141 +-0.000012 -0.000002 -0.000136 +0.000007 -0.000011 -0.000134 +0.000026 -0.000012 -0.000133 +0.000056 -0.000008 -0.000127 +0.000099 0.000002 -0.000103 +0.000133 0.000024 -0.000064 0.000144 0.000174 -0.000071 0.000061 0.000340 -0.000084 --0.000082 0.000350 -0.000104 --0.000133 0.000213 -0.000130 --0.000079 0.000079 -0.000136 --0.000023 0.000017 -0.000131 -0.000005 -0.000007 -0.000126 -0.000016 -0.000012 -0.000124 -0.000028 -0.000013 -0.000123 -0.000051 -0.000019 -0.000112 -0.000092 -0.000021 -0.000084 -0.000074 -0.000004 -0.000062 +-0.000083 0.000350 -0.000103 +-0.000134 0.000212 -0.000129 +-0.000080 0.000079 -0.000135 +-0.000024 0.000017 -0.000130 +0.000004 -0.000007 -0.000126 +0.000015 -0.000011 -0.000125 +0.000027 -0.000012 -0.000124 +0.000050 -0.000018 -0.000114 +0.000091 -0.000020 -0.000086 +0.000074 -0.000003 -0.000063 0.000125 0.000237 -0.000088 -0.000076 0.000582 -0.000120 --0.000085 0.000589 -0.000128 --0.000120 0.000263 -0.000115 --0.000035 0.000041 -0.000107 -0.000017 -0.000009 -0.000109 +0.000076 0.000581 -0.000120 +-0.000085 0.000589 -0.000127 +-0.000120 0.000263 -0.000114 +-0.000035 0.000040 -0.000106 +0.000016 -0.000010 -0.000109 0.000028 -0.000015 -0.000111 -0.000027 -0.000014 -0.000111 -0.000028 -0.000018 -0.000107 -0.000036 -0.000034 -0.000092 -0.000048 -0.000050 -0.000068 --0.000105 -0.000038 -0.000030 --0.000143 0.000173 0.000007 +0.000026 -0.000014 -0.000111 +0.000027 -0.000017 -0.000108 +0.000035 -0.000033 -0.000093 +0.000048 -0.000049 -0.000069 +-0.000105 -0.000037 -0.000030 +-0.000143 0.000174 0.000007 -0.000076 0.000578 0.000019 0.000073 0.000584 0.000014 -0.000152 0.000187 -0.000008 +0.000152 0.000187 -0.000007 0.000134 -0.000013 -0.000054 0.000097 -0.000028 -0.000088 -0.000067 -0.000016 -0.000099 -0.000042 -0.000012 -0.000101 +0.000067 -0.000016 -0.000100 +0.000042 -0.000011 -0.000101 0.000021 -0.000017 -0.000096 --0.000003 -0.000034 -0.000082 --0.000045 -0.000055 -0.000061 --0.000238 -0.000015 -0.000005 +-0.000004 -0.000034 -0.000083 +-0.000045 -0.000055 -0.000062 +-0.000238 -0.000015 -0.000006 -0.000399 -0.000014 0.000095 --0.000246 -0.000001 0.000177 +-0.000246 -0.000001 0.000176 0.000227 -0.000008 0.000173 -0.000403 -0.000018 0.000084 +0.000403 -0.000018 0.000085 0.000261 -0.000008 -0.000022 0.000149 0.000004 -0.000081 -0.000091 0.000010 -0.000096 +0.000090 0.000010 -0.000096 0.000051 0.000012 -0.000097 -0.000015 0.000009 -0.000092 +0.000014 0.000009 -0.000092 -0.000032 0.000003 -0.000082 -0.000106 -0.000006 -0.000062 --0.000114 0.000016 -0.000035 --0.000168 -0.000193 0.000008 +-0.000113 0.000016 -0.000035 +-0.000167 -0.000193 0.000008 -0.000100 -0.000598 0.000029 -0.000075 -0.000619 0.000023 +0.000075 -0.000619 0.000024 0.000159 -0.000217 -0.000006 -0.000128 0.000004 -0.000054 +0.000128 0.000004 -0.000053 0.000086 0.000038 -0.000085 0.000059 0.000035 -0.000095 -0.000041 0.000032 -0.000096 -0.000023 0.000035 -0.000091 --0.000003 0.000041 -0.000081 +0.000040 0.000032 -0.000096 +0.000023 0.000034 -0.000092 +-0.000003 0.000041 -0.000082 -0.000048 0.000047 -0.000066 -0.000071 -0.000008 -0.000076 -0.000124 -0.000251 -0.000104 +0.000071 -0.000008 -0.000077 +0.000124 -0.000251 -0.000105 0.000077 -0.000611 -0.000138 --0.000091 -0.000631 -0.000146 +-0.000091 -0.000630 -0.000146 -0.000136 -0.000285 -0.000124 -0.000057 -0.000040 -0.000104 --0.000005 0.000019 -0.000101 -0.000015 0.000026 -0.000104 -0.000024 0.000027 -0.000103 -0.000035 0.000032 -0.000098 -0.000043 0.000044 -0.000086 +-0.000006 0.000019 -0.000101 +0.000014 0.000026 -0.000104 +0.000024 0.000027 -0.000104 +0.000034 0.000032 -0.000099 +0.000043 0.000043 -0.000087 0.000049 0.000048 -0.000073 -0.000135 -0.000023 -0.000079 +0.000135 -0.000023 -0.000080 0.000145 -0.000175 -0.000102 -0.000066 -0.000346 -0.000116 --0.000084 -0.000360 -0.000124 --0.000151 -0.000214 -0.000132 +0.000067 -0.000345 -0.000116 +-0.000084 -0.000359 -0.000124 +-0.000151 -0.000213 -0.000132 -0.000106 -0.000074 -0.000127 -0.000045 -0.000016 -0.000123 --0.000007 0.000006 -0.000120 -0.000014 0.000012 -0.000118 -0.000036 0.000015 -0.000114 -0.000066 0.000026 -0.000101 -0.000102 0.000027 -0.000081 -0.000150 0.000019 -0.000088 -0.000125 0.000007 -0.000072 -0.000027 -0.000035 -0.000081 --0.000065 -0.000075 -0.000120 --0.000093 -0.000098 -0.000176 --0.000067 -0.000084 -0.000191 --0.000034 -0.000044 -0.000167 --0.000013 -0.000017 -0.000147 -0.000002 -0.000009 -0.000140 -0.000017 -0.000012 -0.000143 -0.000046 -0.000015 -0.000144 -0.000103 -0.000001 -0.000123 -0.000117 0.000021 -0.000076 -0.000106 0.000058 0.000002 -0.000025 0.000042 -0.000001 --0.000036 -0.000015 -0.000094 --0.000037 -0.000060 -0.000183 --0.000023 -0.000062 -0.000201 --0.000019 -0.000039 -0.000178 --0.000014 -0.000022 -0.000159 --0.000005 -0.000016 -0.000153 -0.000006 -0.000019 -0.000157 -0.000026 -0.000027 -0.000165 -0.000068 -0.000019 -0.000147 -0.000076 0.000015 -0.000081 -0.000083 0.000048 0.000026 -0.000040 0.000051 0.000027 -0.000004 0.000021 -0.000096 --0.000002 -0.000007 -0.000188 --0.000003 -0.000013 -0.000197 --0.000008 -0.000013 -0.000179 --0.000012 -0.000013 -0.000163 --0.000009 -0.000014 -0.000157 --0.000001 -0.000014 -0.000160 -0.000012 -0.000015 -0.000166 -0.000039 -0.000009 -0.000153 -0.000079 0.000012 -0.000082 -0.000086 0.000007 0.000023 -0.000041 0.000026 0.000024 -0.000002 0.000056 -0.000099 --0.000005 0.000060 -0.000190 --0.000005 0.000040 -0.000197 --0.000007 0.000016 -0.000177 --0.000008 -0.000000 -0.000160 --0.000007 -0.000008 -0.000154 --0.000003 -0.000007 -0.000158 -0.000009 0.000002 -0.000163 -0.000039 0.000012 -0.000151 -0.000124 0.000003 -0.000081 -0.000119 0.000001 -0.000011 -0.000031 0.000041 -0.000013 --0.000042 0.000097 -0.000105 --0.000050 0.000117 -0.000195 --0.000029 0.000084 -0.000204 --0.000012 0.000035 -0.000172 --0.000002 0.000006 -0.000151 -0.000001 -0.000002 -0.000145 -0.000002 0.000001 -0.000149 -0.000015 0.000012 -0.000158 -0.000062 0.000015 -0.000143 -0.000144 -0.000018 -0.000084 +-0.000008 0.000006 -0.000120 +0.000014 0.000011 -0.000119 +0.000035 0.000015 -0.000115 +0.000065 0.000025 -0.000102 +0.000102 0.000027 -0.000082 +0.000150 0.000018 -0.000090 +0.000124 0.000007 -0.000073 +0.000026 -0.000034 -0.000080 +-0.000065 -0.000074 -0.000119 +-0.000094 -0.000097 -0.000174 +-0.000069 -0.000083 -0.000190 +-0.000035 -0.000044 -0.000166 +-0.000014 -0.000017 -0.000147 +0.000001 -0.000009 -0.000140 +0.000015 -0.000013 -0.000144 +0.000044 -0.000016 -0.000146 +0.000101 -0.000003 -0.000125 +0.000114 0.000020 -0.000080 +0.000105 0.000058 0.000001 +0.000024 0.000043 -0.000000 +-0.000038 -0.000013 -0.000092 +-0.000039 -0.000058 -0.000181 +-0.000025 -0.000061 -0.000199 +-0.000021 -0.000039 -0.000177 +-0.000015 -0.000022 -0.000159 +-0.000007 -0.000016 -0.000154 +0.000004 -0.000020 -0.000159 +0.000023 -0.000029 -0.000168 +0.000065 -0.000022 -0.000151 +0.000073 0.000014 -0.000086 +0.000080 0.000048 0.000023 +0.000038 0.000052 0.000029 +0.000001 0.000021 -0.000092 +-0.000004 -0.000006 -0.000185 +-0.000005 -0.000013 -0.000195 +-0.000010 -0.000012 -0.000178 +-0.000013 -0.000013 -0.000163 +-0.000011 -0.000014 -0.000158 +-0.000003 -0.000015 -0.000162 +0.000009 -0.000016 -0.000169 +0.000036 -0.000011 -0.000157 +0.000075 0.000013 -0.000087 +0.000083 0.000007 0.000021 +0.000039 0.000025 0.000026 +-0.000000 0.000055 -0.000095 +-0.000007 0.000060 -0.000187 +-0.000007 0.000039 -0.000195 +-0.000009 0.000016 -0.000176 +-0.000009 -0.000000 -0.000160 +-0.000008 -0.000007 -0.000155 +-0.000005 -0.000007 -0.000159 +0.000006 0.000002 -0.000166 +0.000035 0.000014 -0.000156 +0.000122 0.000004 -0.000085 +0.000118 0.000001 -0.000012 +0.000029 0.000040 -0.000012 +-0.000044 0.000096 -0.000103 +-0.000052 0.000115 -0.000192 +-0.000031 0.000083 -0.000202 +-0.000013 0.000034 -0.000171 +-0.000003 0.000006 -0.000151 +-0.000001 -0.000002 -0.000145 +0.000000 0.000002 -0.000151 +0.000013 0.000013 -0.000160 +0.000059 0.000018 -0.000147 +0.000144 -0.000017 -0.000086 0.000146 0.000046 -0.000092 -0.000043 0.000126 -0.000103 --0.000080 0.000164 -0.000141 --0.000112 0.000147 -0.000192 --0.000058 0.000081 -0.000183 --0.000006 0.000026 -0.000148 -0.000010 0.000002 -0.000131 -0.000011 -0.000002 -0.000127 -0.000011 0.000001 -0.000130 -0.000026 0.000001 -0.000130 -0.000078 -0.000016 -0.000107 -0.000059 -0.000062 -0.000048 -0.000085 0.000046 -0.000091 +0.000043 0.000125 -0.000102 +-0.000081 0.000163 -0.000140 +-0.000113 0.000146 -0.000191 +-0.000059 0.000080 -0.000182 +-0.000007 0.000026 -0.000148 +0.000009 0.000002 -0.000131 +0.000010 -0.000001 -0.000127 +0.000009 0.000002 -0.000131 +0.000025 0.000002 -0.000131 +0.000076 -0.000014 -0.000109 +0.000059 -0.000061 -0.000049 +0.000085 0.000046 -0.000092 0.000041 0.000211 -0.000137 --0.000062 0.000232 -0.000147 --0.000075 0.000105 -0.000130 --0.000005 0.000010 -0.000103 +-0.000062 0.000231 -0.000147 +-0.000075 0.000104 -0.000129 +-0.000006 0.000009 -0.000103 0.000033 -0.000008 -0.000097 -0.000034 -0.000005 -0.000101 -0.000025 -0.000004 -0.000104 -0.000019 -0.000005 -0.000103 -0.000022 -0.000019 -0.000090 -0.000035 -0.000053 -0.000060 --0.000102 -0.000086 0.000031 +0.000033 -0.000006 -0.000101 +0.000024 -0.000004 -0.000104 +0.000018 -0.000005 -0.000103 +0.000021 -0.000018 -0.000091 +0.000035 -0.000052 -0.000061 +-0.000102 -0.000086 0.000030 -0.000131 -0.000019 0.000096 --0.000066 0.000161 0.000109 +-0.000066 0.000161 0.000108 0.000055 0.000173 0.000102 0.000137 0.000011 0.000079 0.000136 -0.000049 0.000005 -0.000097 -0.000023 -0.000058 -0.000064 -0.000003 -0.000083 -0.000040 -0.000000 -0.000089 +0.000096 -0.000023 -0.000058 +0.000064 -0.000004 -0.000083 +0.000040 0.000000 -0.000089 0.000019 -0.000004 -0.000086 -0.000004 -0.000019 -0.000070 --0.000042 -0.000053 -0.000034 --0.000186 -0.000015 0.000069 +-0.000042 -0.000053 -0.000035 +-0.000186 -0.000015 0.000068 -0.000285 -0.000021 0.000240 -0.000163 -0.000019 0.000354 0.000147 -0.000018 0.000350 0.000289 -0.000015 0.000230 -0.000213 -0.000003 0.000052 +0.000212 -0.000003 0.000053 0.000124 0.000007 -0.000052 0.000077 0.000013 -0.000080 0.000046 0.000014 -0.000086 -0.000018 0.000011 -0.000082 --0.000019 0.000006 -0.000068 --0.000078 -0.000003 -0.000034 +0.000017 0.000011 -0.000082 +-0.000019 0.000006 -0.000069 +-0.000078 -0.000003 -0.000035 -0.000105 0.000062 0.000022 -0.000142 -0.000014 0.000096 -0.000076 -0.000193 0.000118 @@ -557,131 +557,131 @@ LOOKUP_TABLE default 0.000084 0.000039 -0.000058 0.000056 0.000026 -0.000081 0.000039 0.000024 -0.000087 -0.000023 0.000026 -0.000082 +0.000023 0.000026 -0.000083 -0.000000 0.000031 -0.000069 -0.000041 0.000047 -0.000040 -0.000051 0.000045 -0.000067 -0.000079 -0.000070 -0.000115 -0.000044 -0.000243 -0.000166 --0.000057 -0.000261 -0.000174 +0.000051 0.000045 -0.000068 +0.000079 -0.000070 -0.000116 +0.000045 -0.000243 -0.000166 +-0.000057 -0.000260 -0.000174 -0.000083 -0.000110 -0.000141 -0.000027 0.000003 -0.000100 0.000010 0.000025 -0.000091 0.000020 0.000022 -0.000096 0.000025 0.000022 -0.000098 -0.000030 0.000026 -0.000094 -0.000035 0.000037 -0.000082 -0.000038 0.000055 -0.000064 -0.000143 0.000012 -0.000108 +0.000030 0.000025 -0.000094 +0.000035 0.000036 -0.000082 +0.000038 0.000055 -0.000065 +0.000142 0.000011 -0.000109 0.000141 -0.000072 -0.000149 0.000053 -0.000153 -0.000163 -0.000076 -0.000176 -0.000174 --0.000136 -0.000138 -0.000193 --0.000096 -0.000066 -0.000169 +-0.000136 -0.000137 -0.000192 +-0.000097 -0.000065 -0.000169 -0.000036 -0.000018 -0.000138 -0.000004 0.000002 -0.000124 0.000012 0.000006 -0.000120 -0.000028 0.000007 -0.000118 -0.000055 0.000016 -0.000111 -0.000098 0.000030 -0.000097 -0.000114 0.000043 -0.000117 -0.000100 0.000114 -0.000076 -0.000020 0.000106 -0.000075 +0.000027 0.000007 -0.000118 +0.000054 0.000015 -0.000112 +0.000098 0.000029 -0.000098 +0.000113 0.000042 -0.000119 +0.000100 0.000114 -0.000077 +0.000019 0.000107 -0.000076 -0.000032 0.000014 -0.000131 --0.000032 -0.000070 -0.000193 --0.000022 -0.000081 -0.000201 +-0.000033 -0.000069 -0.000193 +-0.000023 -0.000080 -0.000201 -0.000014 -0.000046 -0.000168 -0.000005 -0.000022 -0.000142 --0.000001 -0.000016 -0.000134 -0.000001 -0.000021 -0.000137 -0.000015 -0.000029 -0.000147 -0.000060 -0.000017 -0.000147 -0.000022 0.000029 -0.000109 -0.000059 0.000166 0.000025 -0.000050 0.000172 0.000033 -0.000056 0.000027 -0.000112 -0.000075 -0.000081 -0.000223 -0.000055 -0.000084 -0.000222 -0.000019 -0.000052 -0.000184 --0.000001 -0.000032 -0.000159 --0.000013 -0.000026 -0.000151 --0.000026 -0.000033 -0.000157 --0.000040 -0.000053 -0.000180 --0.000030 -0.000056 -0.000188 --0.000118 0.000011 -0.000117 --0.000022 0.000095 0.000078 -0.000115 0.000104 0.000096 -0.000201 0.000022 -0.000116 -0.000184 -0.000034 -0.000243 -0.000110 -0.000033 -0.000224 -0.000047 -0.000022 -0.000187 -0.000007 -0.000020 -0.000165 --0.000021 -0.000020 -0.000157 --0.000049 -0.000023 -0.000164 --0.000086 -0.000032 -0.000186 --0.000126 -0.000034 -0.000205 --0.000117 0.000002 -0.000120 --0.000022 -0.000067 0.000075 -0.000115 -0.000068 0.000093 -0.000200 0.000013 -0.000118 -0.000182 0.000060 -0.000245 -0.000108 0.000045 -0.000225 -0.000048 0.000018 -0.000186 -0.000010 0.000002 -0.000161 --0.000019 -0.000004 -0.000153 --0.000050 -0.000002 -0.000160 --0.000089 0.000013 -0.000184 --0.000126 0.000030 -0.000204 -0.000024 -0.000021 -0.000112 -0.000063 -0.000142 0.000019 -0.000050 -0.000142 0.000031 -0.000054 0.000002 -0.000114 -0.000069 0.000103 -0.000227 -0.000051 0.000090 -0.000223 -0.000026 0.000040 -0.000176 -0.000010 0.000013 -0.000148 --0.000008 0.000007 -0.000140 --0.000030 0.000014 -0.000147 --0.000051 0.000035 -0.000170 --0.000037 0.000045 -0.000182 -0.000092 -0.000066 -0.000094 -0.000096 -0.000115 -0.000068 -0.000020 -0.000097 -0.000064 --0.000034 -0.000006 -0.000119 --0.000028 0.000068 -0.000183 -0.000001 0.000055 -0.000174 -0.000022 0.000019 -0.000136 +-0.000002 -0.000016 -0.000134 +0.000000 -0.000021 -0.000137 +0.000014 -0.000030 -0.000148 +0.000059 -0.000018 -0.000148 +0.000017 0.000027 -0.000113 +0.000055 0.000165 0.000022 +0.000047 0.000173 0.000033 +0.000053 0.000029 -0.000110 +0.000072 -0.000080 -0.000221 +0.000053 -0.000083 -0.000221 +0.000017 -0.000051 -0.000184 +-0.000002 -0.000032 -0.000159 +-0.000014 -0.000026 -0.000151 +-0.000027 -0.000034 -0.000158 +-0.000043 -0.000055 -0.000181 +-0.000034 -0.000059 -0.000191 +-0.000129 0.000010 -0.000125 +-0.000031 0.000094 0.000073 +0.000109 0.000105 0.000098 +0.000195 0.000023 -0.000110 +0.000179 -0.000033 -0.000239 +0.000107 -0.000032 -0.000223 +0.000045 -0.000022 -0.000187 +0.000006 -0.000020 -0.000165 +-0.000023 -0.000020 -0.000157 +-0.000052 -0.000023 -0.000165 +-0.000091 -0.000032 -0.000189 +-0.000134 -0.000036 -0.000210 +-0.000128 0.000003 -0.000128 +-0.000031 -0.000067 0.000071 +0.000108 -0.000069 0.000096 +0.000194 0.000012 -0.000112 +0.000177 0.000059 -0.000241 +0.000105 0.000044 -0.000224 +0.000046 0.000018 -0.000186 +0.000008 0.000002 -0.000162 +-0.000021 -0.000004 -0.000154 +-0.000053 -0.000001 -0.000161 +-0.000094 0.000014 -0.000186 +-0.000134 0.000031 -0.000210 +0.000019 -0.000019 -0.000116 +0.000060 -0.000142 0.000016 +0.000047 -0.000143 0.000031 +0.000051 0.000000 -0.000111 +0.000066 0.000101 -0.000225 +0.000049 0.000089 -0.000222 +0.000024 0.000040 -0.000176 +0.000009 0.000013 -0.000148 +-0.000009 0.000007 -0.000140 +-0.000032 0.000014 -0.000147 +-0.000053 0.000036 -0.000171 +-0.000042 0.000048 -0.000185 +0.000090 -0.000065 -0.000096 +0.000096 -0.000115 -0.000069 +0.000020 -0.000098 -0.000064 +-0.000034 -0.000006 -0.000118 +-0.000029 0.000067 -0.000182 +0.000001 0.000054 -0.000174 +0.000021 0.000018 -0.000136 0.000020 0.000006 -0.000119 -0.000008 0.000006 -0.000116 --0.000006 0.000011 -0.000120 --0.000008 0.000013 -0.000126 -0.000027 -0.000009 -0.000119 -0.000025 -0.000108 -0.000031 +0.000007 0.000006 -0.000116 +-0.000007 0.000011 -0.000120 +-0.000009 0.000014 -0.000126 +0.000025 -0.000008 -0.000120 +0.000024 -0.000107 -0.000032 0.000034 -0.000110 -0.000050 0.000007 -0.000065 -0.000071 -0.000028 -0.000021 -0.000082 --0.000010 -0.000011 -0.000084 -0.000035 -0.000023 -0.000071 -0.000051 -0.000015 -0.000074 +-0.000010 -0.000012 -0.000084 +0.000035 -0.000024 -0.000071 +0.000051 -0.000016 -0.000074 0.000039 -0.000001 -0.000087 -0.000023 0.000004 -0.000092 +0.000023 0.000005 -0.000093 0.000011 0.000003 -0.000092 -0.000006 -0.000012 -0.000081 -0.000009 -0.000055 -0.000052 --0.000059 -0.000095 0.000037 --0.000069 -0.000111 0.000081 +0.000005 -0.000011 -0.000081 +0.000009 -0.000055 -0.000053 +-0.000059 -0.000094 0.000036 +-0.000068 -0.000111 0.000081 -0.000035 -0.000068 0.000081 -0.000020 -0.000045 0.000078 +0.000021 -0.000046 0.000078 0.000077 -0.000062 0.000068 0.000097 -0.000050 0.000017 0.000077 -0.000015 -0.000040 0.000053 0.000006 -0.000069 0.000035 0.000009 -0.000078 -0.000019 0.000004 -0.000075 +0.000019 0.000005 -0.000075 0.000003 -0.000009 -0.000060 --0.000024 -0.000044 -0.000024 --0.000080 -0.000012 0.000051 --0.000115 -0.000023 0.000155 +-0.000024 -0.000043 -0.000024 +-0.000080 -0.000011 0.000050 +-0.000115 -0.000023 0.000154 -0.000066 -0.000025 0.000204 0.000050 -0.000018 0.000202 0.000120 -0.000008 0.000148 @@ -690,131 +690,131 @@ LOOKUP_TABLE default 0.000056 0.000015 -0.000065 0.000039 0.000016 -0.000073 0.000022 0.000013 -0.000070 -0.000001 0.000008 -0.000056 +0.000001 0.000008 -0.000057 -0.000031 0.000000 -0.000025 -0.000056 0.000072 0.000026 --0.000069 0.000069 0.000073 +-0.000068 0.000069 0.000072 -0.000036 0.000024 0.000077 0.000021 0.000016 0.000074 -0.000072 0.000053 0.000063 +0.000073 0.000053 0.000063 0.000085 0.000059 0.000011 0.000064 0.000035 -0.000043 0.000046 0.000020 -0.000069 0.000036 0.000019 -0.000077 -0.000025 0.000021 -0.000074 +0.000025 0.000020 -0.000075 0.000010 0.000026 -0.000061 --0.000018 0.000044 -0.000029 -0.000023 0.000089 -0.000046 +-0.000018 0.000043 -0.000029 +0.000023 0.000089 -0.000047 0.000030 0.000068 -0.000075 0.000012 0.000019 -0.000101 --0.000026 -0.000004 -0.000105 +-0.000025 -0.000004 -0.000105 -0.000023 0.000017 -0.000092 -0.000010 0.000043 -0.000071 +0.000010 0.000044 -0.000071 0.000027 0.000036 -0.000074 -0.000027 0.000021 -0.000086 +0.000027 0.000021 -0.000087 0.000026 0.000016 -0.000091 -0.000027 0.000020 -0.000088 -0.000027 0.000035 -0.000077 -0.000023 0.000064 -0.000055 +0.000026 0.000020 -0.000088 +0.000026 0.000034 -0.000077 +0.000023 0.000064 -0.000056 0.000106 0.000059 -0.000114 -0.000094 0.000058 -0.000136 -0.000024 0.000035 -0.000137 +0.000094 0.000058 -0.000137 +0.000024 0.000035 -0.000138 -0.000044 -0.000010 -0.000149 --0.000071 -0.000043 -0.000174 --0.000050 -0.000028 -0.000159 --0.000013 -0.000004 -0.000128 +-0.000071 -0.000042 -0.000174 +-0.000050 -0.000027 -0.000159 +-0.000014 -0.000004 -0.000128 0.000005 0.000002 -0.000115 0.000012 0.000002 -0.000111 0.000020 0.000003 -0.000110 -0.000037 0.000013 -0.000107 -0.000070 0.000037 -0.000103 -0.000052 0.000061 -0.000128 -0.000056 0.000173 -0.000106 -0.000026 0.000177 -0.000106 -0.000015 0.000055 -0.000137 -0.000023 -0.000038 -0.000160 +0.000036 0.000013 -0.000107 +0.000069 0.000036 -0.000103 +0.000051 0.000061 -0.000130 +0.000056 0.000173 -0.000107 +0.000027 0.000177 -0.000107 +0.000015 0.000055 -0.000136 +0.000023 -0.000037 -0.000160 0.000020 -0.000052 -0.000157 0.000012 -0.000035 -0.000137 -0.000006 -0.000020 -0.000119 +0.000007 -0.000020 -0.000119 -0.000002 -0.000018 -0.000112 --0.000010 -0.000021 -0.000113 +-0.000010 -0.000022 -0.000113 -0.000008 -0.000024 -0.000121 -0.000017 -0.000010 -0.000132 --0.000132 0.000025 -0.000131 --0.000036 0.000228 -0.000056 -0.000108 0.000250 -0.000053 -0.000204 0.000039 -0.000135 -0.000194 -0.000089 -0.000185 -0.000121 -0.000079 -0.000175 +0.000016 -0.000011 -0.000133 +-0.000135 0.000024 -0.000134 +-0.000039 0.000228 -0.000060 +0.000107 0.000250 -0.000054 +0.000202 0.000040 -0.000133 +0.000193 -0.000089 -0.000184 +0.000120 -0.000078 -0.000175 0.000054 -0.000052 -0.000152 0.000012 -0.000036 -0.000134 --0.000019 -0.000032 -0.000125 --0.000052 -0.000039 -0.000128 --0.000093 -0.000059 -0.000145 --0.000135 -0.000072 -0.000163 --0.000430 -0.000000 -0.000135 --0.000219 0.000127 -0.000018 -0.000251 0.000144 -0.000009 -0.000514 0.000015 -0.000138 -0.000415 -0.000056 -0.000202 -0.000227 -0.000042 -0.000179 -0.000106 -0.000028 -0.000154 +-0.000020 -0.000032 -0.000125 +-0.000053 -0.000039 -0.000128 +-0.000094 -0.000059 -0.000145 +-0.000137 -0.000073 -0.000164 +-0.000438 -0.000001 -0.000142 +-0.000226 0.000127 -0.000026 +0.000246 0.000144 -0.000008 +0.000510 0.000016 -0.000131 +0.000412 -0.000055 -0.000199 +0.000226 -0.000042 -0.000179 +0.000105 -0.000028 -0.000154 0.000027 -0.000024 -0.000138 --0.000034 -0.000025 -0.000130 --0.000097 -0.000029 -0.000133 --0.000187 -0.000040 -0.000152 --0.000332 -0.000052 -0.000176 --0.000434 -0.000003 -0.000135 --0.000223 -0.000123 -0.000017 -0.000249 -0.000137 -0.000008 -0.000513 -0.000010 -0.000137 -0.000415 0.000056 -0.000201 -0.000227 0.000037 -0.000179 -0.000107 0.000015 -0.000152 +-0.000035 -0.000025 -0.000130 +-0.000099 -0.000029 -0.000133 +-0.000189 -0.000040 -0.000153 +-0.000337 -0.000053 -0.000179 +-0.000442 -0.000003 -0.000142 +-0.000231 -0.000123 -0.000025 +0.000243 -0.000137 -0.000007 +0.000509 -0.000011 -0.000130 +0.000412 0.000056 -0.000198 +0.000225 0.000037 -0.000178 +0.000106 0.000015 -0.000152 0.000030 0.000002 -0.000134 --0.000032 -0.000002 -0.000126 --0.000099 0.000001 -0.000129 --0.000191 0.000017 -0.000149 --0.000335 0.000039 -0.000175 --0.000141 -0.000035 -0.000124 --0.000044 -0.000233 -0.000049 -0.000103 -0.000253 -0.000043 -0.000203 -0.000043 -0.000125 -0.000197 0.000082 -0.000177 +-0.000033 -0.000002 -0.000126 +-0.000101 0.000001 -0.000129 +-0.000193 0.000017 -0.000149 +-0.000339 0.000039 -0.000177 +-0.000145 -0.000034 -0.000127 +-0.000046 -0.000233 -0.000053 +0.000102 -0.000253 -0.000044 +0.000202 -0.000044 -0.000123 +0.000195 0.000082 -0.000176 0.000126 0.000066 -0.000167 0.000066 0.000031 -0.000138 0.000025 0.000012 -0.000119 -0.000014 0.000010 -0.000112 -0.000058 0.000017 -0.000115 --0.000107 0.000035 -0.000131 --0.000149 0.000052 -0.000151 -0.000022 -0.000088 -0.000094 -0.000040 -0.000192 -0.000079 -0.000020 -0.000194 -0.000077 +-0.000108 0.000035 -0.000131 +-0.000151 0.000052 -0.000152 +0.000022 -0.000088 -0.000095 +0.000039 -0.000192 -0.000081 +0.000020 -0.000194 -0.000078 0.000020 -0.000072 -0.000107 -0.000038 0.000018 -0.000132 +0.000038 0.000018 -0.000131 0.000048 0.000024 -0.000121 -0.000047 0.000009 -0.000099 +0.000047 0.000009 -0.000100 0.000031 0.000005 -0.000093 0.000006 0.000010 -0.000094 -0.000017 0.000013 -0.000095 -0.000032 0.000009 -0.000096 --0.000018 -0.000015 -0.000098 +-0.000019 -0.000014 -0.000098 0.000018 -0.000105 -0.000042 -0.000018 -0.000151 -0.000050 --0.000005 -0.000145 -0.000060 +0.000018 -0.000151 -0.000051 +-0.000004 -0.000145 -0.000060 -0.000011 -0.000085 -0.000064 0.000014 -0.000037 -0.000063 -0.000042 -0.000022 -0.000055 -0.000051 -0.000008 -0.000060 -0.000038 0.000005 -0.000072 +0.000042 -0.000023 -0.000055 +0.000051 -0.000009 -0.000060 +0.000038 0.000005 -0.000073 0.000020 0.000011 -0.000079 0.000007 0.000009 -0.000078 0.000001 -0.000008 -0.000070 -0.000005 -0.000048 -0.000052 --0.000005 -0.000069 -0.000004 +0.000005 -0.000048 -0.000053 +-0.000005 -0.000069 -0.000005 -0.000011 -0.000103 0.000017 --0.000015 -0.000104 0.000020 +-0.000014 -0.000104 0.000020 -0.000005 -0.000074 0.000020 0.000025 -0.000045 0.000014 0.000048 -0.000023 -0.000011 @@ -824,883 +824,883 @@ LOOKUP_TABLE default 0.000021 0.000009 -0.000068 0.000014 -0.000004 -0.000059 0.000005 -0.000030 -0.000037 --0.000007 -0.000008 0.000001 +-0.000006 -0.000008 0.000001 -0.000015 -0.000019 0.000048 --0.000017 -0.000022 0.000074 +-0.000016 -0.000022 0.000074 -0.000002 -0.000012 0.000074 0.000025 -0.000001 0.000046 -0.000041 0.000007 -0.000003 +0.000042 0.000007 -0.000003 0.000043 0.000013 -0.000041 0.000039 0.000016 -0.000058 -0.000033 0.000017 -0.000066 -0.000026 0.000014 -0.000065 +0.000034 0.000017 -0.000066 +0.000027 0.000014 -0.000065 0.000017 0.000009 -0.000056 -0.000005 0.000002 -0.000036 --0.000003 0.000051 -0.000011 +0.000005 0.000003 -0.000036 +-0.000003 0.000051 -0.000012 -0.000010 0.000062 0.000010 -0.000013 0.000060 0.000014 --0.000006 0.000051 0.000014 +-0.000005 0.000051 0.000014 0.000019 0.000044 0.000007 0.000037 0.000037 -0.000017 -0.000037 0.000026 -0.000047 +0.000038 0.000026 -0.000047 0.000034 0.000018 -0.000064 -0.000031 0.000017 -0.000071 +0.000032 0.000017 -0.000071 0.000028 0.000019 -0.000070 0.000021 0.000024 -0.000061 -0.000010 0.000035 -0.000041 +0.000010 0.000035 -0.000042 0.000026 0.000089 -0.000052 0.000019 0.000103 -0.000066 --0.000004 0.000093 -0.000078 +-0.000003 0.000093 -0.000078 -0.000016 0.000064 -0.000079 --0.000005 0.000045 -0.000071 +-0.000005 0.000046 -0.000071 0.000016 0.000043 -0.000061 0.000027 0.000032 -0.000065 0.000027 0.000017 -0.000077 -0.000024 0.000012 -0.000081 +0.000025 0.000011 -0.000081 0.000025 0.000016 -0.000080 0.000026 0.000031 -0.000073 0.000025 0.000059 -0.000058 0.000068 0.000085 -0.000104 -0.000056 0.000125 -0.000116 -0.000007 0.000119 -0.000118 +0.000056 0.000125 -0.000117 +0.000008 0.000119 -0.000118 -0.000022 0.000059 -0.000123 -0.000023 0.000011 -0.000130 --0.000009 0.000002 -0.000120 -0.000010 0.000006 -0.000102 +-0.000008 0.000002 -0.000120 +0.000011 0.000006 -0.000102 0.000016 0.000003 -0.000096 0.000013 -0.000001 -0.000095 0.000013 0.000001 -0.000094 0.000022 0.000016 -0.000092 -0.000044 0.000045 -0.000092 -0.000033 0.000076 -0.000126 -0.000043 0.000194 -0.000160 -0.000022 0.000201 -0.000166 -0.000018 0.000079 -0.000136 -0.000035 -0.000017 -0.000108 -0.000038 -0.000036 -0.000099 -0.000027 -0.000026 -0.000093 +0.000044 0.000045 -0.000093 +0.000034 0.000076 -0.000127 +0.000044 0.000194 -0.000162 +0.000023 0.000201 -0.000166 +0.000019 0.000079 -0.000136 +0.000036 -0.000017 -0.000108 +0.000039 -0.000036 -0.000099 +0.000028 -0.000027 -0.000093 0.000015 -0.000017 -0.000085 -0.000000 -0.000016 -0.000082 --0.000013 -0.000020 -0.000081 --0.000017 -0.000021 -0.000082 -0.000001 -0.000003 -0.000095 --0.000148 0.000033 -0.000128 --0.000048 0.000239 -0.000216 -0.000102 0.000262 -0.000230 -0.000204 0.000053 -0.000149 -0.000201 -0.000078 -0.000090 -0.000134 -0.000069 -0.000088 -0.000067 -0.000046 -0.000094 -0.000019 -0.000033 -0.000090 --0.000018 -0.000030 -0.000084 --0.000055 -0.000037 -0.000081 --0.000101 -0.000056 -0.000077 --0.000149 -0.000067 -0.000080 --0.000448 -0.000003 -0.000118 --0.000233 0.000124 -0.000250 -0.000241 0.000141 -0.000275 -0.000509 0.000013 -0.000149 -0.000418 -0.000057 -0.000073 -0.000236 -0.000043 -0.000081 -0.000115 -0.000030 -0.000090 -0.000032 -0.000025 -0.000088 --0.000034 -0.000026 -0.000083 --0.000100 -0.000030 -0.000079 --0.000195 -0.000041 -0.000073 --0.000346 -0.000054 -0.000064 --0.000453 -0.000015 -0.000115 --0.000239 -0.000138 -0.000246 -0.000238 -0.000155 -0.000271 -0.000508 -0.000028 -0.000146 -0.000419 0.000041 -0.000070 -0.000238 0.000024 -0.000078 -0.000118 0.000007 -0.000086 -0.000036 -0.000002 -0.000083 --0.000031 -0.000006 -0.000078 --0.000103 -0.000002 -0.000074 --0.000200 0.000012 -0.000068 --0.000351 0.000031 -0.000061 --0.000162 -0.000052 -0.000117 --0.000058 -0.000256 -0.000204 -0.000097 -0.000280 -0.000218 -0.000204 -0.000071 -0.000137 -0.000207 0.000059 -0.000078 -0.000143 0.000049 -0.000076 -0.000080 0.000022 -0.000079 -0.000032 0.000008 -0.000075 --0.000012 0.000008 -0.000072 --0.000061 0.000015 -0.000069 --0.000116 0.000031 -0.000063 --0.000166 0.000043 -0.000066 -0.000010 -0.000094 -0.000100 -0.000028 -0.000211 -0.000138 +0.000001 -0.000016 -0.000082 +-0.000012 -0.000020 -0.000081 +-0.000016 -0.000021 -0.000083 +0.000002 -0.000003 -0.000095 +-0.000144 0.000034 -0.000132 +-0.000044 0.000239 -0.000219 +0.000105 0.000262 -0.000230 +0.000206 0.000052 -0.000147 +0.000204 -0.000078 -0.000089 +0.000135 -0.000069 -0.000088 +0.000068 -0.000046 -0.000094 +0.000020 -0.000033 -0.000090 +-0.000016 -0.000030 -0.000084 +-0.000053 -0.000037 -0.000081 +-0.000099 -0.000056 -0.000077 +-0.000146 -0.000066 -0.000081 +-0.000438 -0.000002 -0.000125 +-0.000224 0.000124 -0.000258 +0.000247 0.000141 -0.000274 +0.000515 0.000013 -0.000143 +0.000422 -0.000058 -0.000070 +0.000239 -0.000043 -0.000080 +0.000117 -0.000030 -0.000090 +0.000034 -0.000025 -0.000088 +-0.000032 -0.000025 -0.000083 +-0.000098 -0.000029 -0.000079 +-0.000192 -0.000041 -0.000073 +-0.000340 -0.000054 -0.000067 +-0.000444 -0.000016 -0.000122 +-0.000230 -0.000138 -0.000254 +0.000245 -0.000154 -0.000270 +0.000514 -0.000028 -0.000139 +0.000423 0.000042 -0.000066 +0.000241 0.000025 -0.000077 +0.000120 0.000007 -0.000086 +0.000038 -0.000002 -0.000083 +-0.000030 -0.000006 -0.000078 +-0.000100 -0.000002 -0.000074 +-0.000197 0.000012 -0.000068 +-0.000345 0.000030 -0.000063 +-0.000158 -0.000053 -0.000120 +-0.000055 -0.000257 -0.000208 +0.000100 -0.000280 -0.000218 +0.000206 -0.000070 -0.000135 +0.000209 0.000059 -0.000077 +0.000144 0.000049 -0.000076 +0.000081 0.000022 -0.000079 +0.000033 0.000008 -0.000075 +-0.000011 0.000008 -0.000072 +-0.000059 0.000015 -0.000069 +-0.000114 0.000031 -0.000063 +-0.000162 0.000042 -0.000067 +0.000012 -0.000094 -0.000102 +0.000029 -0.000211 -0.000140 0.000016 -0.000219 -0.000143 -0.000023 -0.000097 -0.000113 -0.000048 -0.000001 -0.000085 -0.000059 0.000018 -0.000073 -0.000051 0.000011 -0.000068 -0.000031 0.000008 -0.000067 -0.000006 0.000011 -0.000069 --0.000018 0.000015 -0.000068 --0.000033 0.000012 -0.000065 --0.000024 -0.000012 -0.000070 -0.000030 -0.000091 -0.000071 -0.000023 -0.000149 -0.000081 --0.000005 -0.000154 -0.000085 +0.000023 -0.000097 -0.000112 +0.000049 -0.000000 -0.000085 +0.000060 0.000018 -0.000074 +0.000052 0.000011 -0.000068 +0.000032 0.000008 -0.000067 +0.000007 0.000011 -0.000069 +-0.000017 0.000015 -0.000068 +-0.000032 0.000012 -0.000065 +-0.000023 -0.000012 -0.000071 +0.000031 -0.000091 -0.000072 +0.000023 -0.000149 -0.000082 +-0.000004 -0.000154 -0.000085 -0.000011 -0.000094 -0.000080 0.000009 -0.000035 -0.000068 -0.000029 -0.000008 -0.000057 -0.000037 0.000005 -0.000057 +0.000030 -0.000008 -0.000058 +0.000038 0.000005 -0.000057 0.000031 0.000012 -0.000063 -0.000018 0.000014 -0.000066 +0.000019 0.000014 -0.000067 0.000009 0.000012 -0.000067 -0.000007 -0.000001 -0.000066 -0.000017 -0.000035 -0.000065 -0.000021 -0.000052 -0.000049 +0.000008 -0.000002 -0.000066 +0.000018 -0.000035 -0.000066 +0.000022 -0.000053 -0.000050 0.000011 -0.000087 -0.000039 -0.000007 -0.000097 -0.000035 --0.000013 -0.000068 -0.000035 -0.000003 -0.000030 -0.000035 +-0.000012 -0.000068 -0.000035 +0.000003 -0.000029 -0.000035 0.000021 -0.000006 -0.000041 -0.000029 0.000008 -0.000052 -0.000030 0.000015 -0.000060 +0.000030 0.000008 -0.000052 +0.000031 0.000015 -0.000060 0.000027 0.000016 -0.000064 -0.000023 0.000011 -0.000065 +0.000024 0.000011 -0.000065 0.000023 -0.000001 -0.000064 -0.000023 -0.000022 -0.000059 +0.000024 -0.000022 -0.000060 0.000018 -0.000006 -0.000043 -0.000010 -0.000016 -0.000021 +0.000011 -0.000016 -0.000021 -0.000005 -0.000018 -0.000007 -0.000013 -0.000009 -0.000007 --0.000001 0.000002 -0.000018 -0.000016 0.000009 -0.000037 +-0.000001 0.000002 -0.000019 +0.000017 0.000009 -0.000037 0.000026 0.000014 -0.000051 -0.000029 0.000017 -0.000060 -0.000030 0.000017 -0.000064 -0.000029 0.000015 -0.000065 +0.000030 0.000017 -0.000060 +0.000031 0.000017 -0.000064 +0.000030 0.000015 -0.000065 0.000026 0.000010 -0.000063 0.000022 0.000003 -0.000057 0.000022 0.000038 -0.000052 0.000011 0.000050 -0.000041 -0.000006 0.000058 -0.000037 --0.000012 0.000050 -0.000037 +-0.000012 0.000050 -0.000038 -0.000001 0.000033 -0.000039 -0.000012 0.000024 -0.000046 -0.000020 0.000020 -0.000056 -0.000025 0.000016 -0.000064 -0.000029 0.000016 -0.000067 -0.000030 0.000017 -0.000068 +0.000013 0.000024 -0.000046 +0.000020 0.000020 -0.000057 +0.000026 0.000016 -0.000064 +0.000029 0.000016 -0.000068 +0.000031 0.000018 -0.000068 0.000030 0.000022 -0.000067 -0.000027 0.000028 -0.000062 -0.000037 0.000076 -0.000075 +0.000028 0.000028 -0.000062 +0.000038 0.000076 -0.000075 0.000023 0.000102 -0.000081 -0.000004 0.000103 -0.000085 -0.000015 0.000074 -0.000085 -0.000008 0.000045 -0.000078 -0.000004 0.000031 -0.000067 +0.000005 0.000031 -0.000068 0.000016 0.000020 -0.000066 -0.000021 0.000012 -0.000070 -0.000023 0.000009 -0.000073 -0.000026 0.000013 -0.000074 -0.000031 0.000026 -0.000073 -0.000036 0.000048 -0.000072 -0.000056 0.000090 -0.000104 -0.000044 0.000142 -0.000117 -0.000003 0.000142 -0.000119 --0.000018 0.000082 -0.000114 +0.000022 0.000011 -0.000070 +0.000024 0.000009 -0.000073 +0.000027 0.000013 -0.000074 +0.000032 0.000026 -0.000074 +0.000037 0.000048 -0.000073 +0.000057 0.000090 -0.000105 +0.000044 0.000142 -0.000118 +0.000004 0.000142 -0.000119 +-0.000017 0.000082 -0.000114 -0.000011 0.000029 -0.000105 0.000004 0.000008 -0.000092 -0.000016 0.000003 -0.000080 -0.000018 0.000001 -0.000077 +0.000017 0.000003 -0.000080 +0.000019 0.000001 -0.000077 0.000014 -0.000002 -0.000078 0.000013 -0.000001 -0.000079 -0.000020 0.000013 -0.000080 -0.000038 0.000042 -0.000088 -0.000061 0.000088 -0.000132 -0.000056 0.000181 -0.000192 -0.000004 0.000185 -0.000196 --0.000018 0.000094 -0.000141 -0.000010 -0.000000 -0.000077 -0.000030 -0.000032 -0.000052 -0.000025 -0.000023 -0.000054 -0.000015 -0.000014 -0.000056 -0.000005 -0.000013 -0.000055 --0.000005 -0.000018 -0.000052 --0.000006 -0.000023 -0.000049 -0.000021 0.000003 -0.000071 --0.000019 0.000051 -0.000133 -0.000026 0.000197 -0.000282 -0.000035 0.000211 -0.000299 -0.000062 0.000068 -0.000157 -0.000100 -0.000046 -0.000040 -0.000090 -0.000057 -0.000025 -0.000049 -0.000037 -0.000042 -0.000016 -0.000025 -0.000049 --0.000009 -0.000022 -0.000047 --0.000033 -0.000030 -0.000040 --0.000060 -0.000048 -0.000026 --0.000065 -0.000045 -0.000034 --0.000158 0.000004 -0.000116 --0.000055 0.000087 -0.000328 -0.000097 0.000097 -0.000359 -0.000201 0.000016 -0.000151 -0.000202 -0.000039 -0.000017 -0.000138 -0.000037 -0.000019 -0.000072 -0.000026 -0.000038 -0.000021 -0.000022 -0.000045 --0.000018 -0.000022 -0.000044 --0.000056 -0.000026 -0.000036 --0.000106 -0.000035 -0.000021 --0.000159 -0.000040 -0.000014 --0.000162 -0.000031 -0.000114 --0.000059 -0.000111 -0.000326 -0.000096 -0.000120 -0.000357 -0.000201 -0.000040 -0.000149 -0.000204 0.000015 -0.000015 -0.000141 0.000011 -0.000017 -0.000076 -0.000002 -0.000035 -0.000025 -0.000009 -0.000042 --0.000016 -0.000012 -0.000041 --0.000059 -0.000009 -0.000033 --0.000111 0.000003 -0.000018 --0.000163 0.000010 -0.000012 --0.000031 -0.000072 -0.000126 -0.000018 -0.000218 -0.000276 -0.000032 -0.000231 -0.000293 -0.000063 -0.000088 -0.000151 -0.000106 0.000025 -0.000034 -0.000099 0.000036 -0.000019 -0.000060 0.000015 -0.000036 -0.000027 0.000003 -0.000042 --0.000004 0.000002 -0.000042 --0.000038 0.000009 -0.000034 --0.000072 0.000025 -0.000019 --0.000078 0.000021 -0.000027 -0.000044 -0.000101 -0.000123 -0.000044 -0.000195 -0.000183 --0.000002 -0.000199 -0.000188 --0.000015 -0.000108 -0.000133 -0.000020 -0.000014 -0.000069 -0.000045 0.000020 -0.000043 -0.000042 0.000014 -0.000045 -0.000026 0.000009 -0.000049 -0.000008 0.000011 -0.000050 --0.000009 0.000015 -0.000047 --0.000018 0.000017 -0.000042 -0.000003 -0.000013 -0.000062 -0.000041 -0.000087 -0.000103 -0.000026 -0.000136 -0.000116 --0.000005 -0.000139 -0.000117 --0.000017 -0.000094 -0.000106 --0.000003 -0.000038 -0.000081 -0.000016 -0.000003 -0.000061 -0.000027 0.000009 -0.000056 -0.000025 0.000012 -0.000058 -0.000019 0.000013 -0.000059 -0.000014 0.000012 -0.000060 -0.000017 0.000002 -0.000064 -0.000031 -0.000031 -0.000079 -0.000027 -0.000049 -0.000086 -0.000014 -0.000077 -0.000086 --0.000003 -0.000085 -0.000085 --0.000011 -0.000063 -0.000082 --0.000006 -0.000028 -0.000072 -0.000008 -0.000004 -0.000064 -0.000019 0.000008 -0.000062 -0.000025 0.000014 -0.000062 -0.000026 0.000015 -0.000064 -0.000027 0.000010 -0.000066 -0.000029 -0.000001 -0.000071 +0.000021 0.000013 -0.000080 +0.000039 0.000042 -0.000088 +0.000063 0.000089 -0.000134 +0.000058 0.000181 -0.000193 +0.000005 0.000185 -0.000196 +-0.000017 0.000093 -0.000140 +0.000012 -0.000001 -0.000077 +0.000032 -0.000032 -0.000052 +0.000026 -0.000024 -0.000054 +0.000016 -0.000014 -0.000056 +0.000006 -0.000013 -0.000055 +-0.000004 -0.000018 -0.000052 +-0.000003 -0.000022 -0.000050 +0.000024 0.000004 -0.000073 +-0.000013 0.000053 -0.000137 +0.000031 0.000197 -0.000284 +0.000039 0.000210 -0.000298 +0.000066 0.000066 -0.000154 +0.000104 -0.000048 -0.000038 +0.000093 -0.000058 -0.000024 +0.000051 -0.000037 -0.000042 +0.000018 -0.000025 -0.000049 +-0.000006 -0.000022 -0.000048 +-0.000030 -0.000029 -0.000041 +-0.000056 -0.000047 -0.000028 +-0.000059 -0.000043 -0.000038 +-0.000146 0.000005 -0.000124 +-0.000045 0.000087 -0.000333 +0.000105 0.000096 -0.000356 +0.000209 0.000015 -0.000145 +0.000208 -0.000040 -0.000013 +0.000142 -0.000037 -0.000018 +0.000075 -0.000026 -0.000037 +0.000024 -0.000022 -0.000045 +-0.000015 -0.000022 -0.000044 +-0.000052 -0.000026 -0.000037 +-0.000100 -0.000035 -0.000023 +-0.000150 -0.000038 -0.000019 +-0.000151 -0.000032 -0.000122 +-0.000049 -0.000111 -0.000330 +0.000104 -0.000119 -0.000354 +0.000209 -0.000038 -0.000143 +0.000210 0.000016 -0.000011 +0.000145 0.000011 -0.000016 +0.000079 -0.000002 -0.000035 +0.000028 -0.000009 -0.000042 +-0.000013 -0.000012 -0.000041 +-0.000055 -0.000009 -0.000034 +-0.000105 0.000002 -0.000020 +-0.000154 0.000009 -0.000017 +-0.000025 -0.000075 -0.000131 +0.000022 -0.000218 -0.000278 +0.000035 -0.000230 -0.000292 +0.000067 -0.000086 -0.000148 +0.000110 0.000027 -0.000032 +0.000102 0.000037 -0.000018 +0.000062 0.000015 -0.000035 +0.000029 0.000003 -0.000042 +-0.000002 0.000002 -0.000042 +-0.000035 0.000009 -0.000035 +-0.000068 0.000024 -0.000021 +-0.000072 0.000019 -0.000031 +0.000046 -0.000102 -0.000124 +0.000046 -0.000195 -0.000184 +-0.000000 -0.000199 -0.000188 +-0.000013 -0.000107 -0.000132 +0.000022 -0.000013 -0.000069 +0.000047 0.000020 -0.000043 +0.000043 0.000015 -0.000045 +0.000028 0.000009 -0.000049 +0.000010 0.000010 -0.000050 +-0.000007 0.000015 -0.000047 +-0.000015 0.000016 -0.000043 +0.000006 -0.000014 -0.000063 +0.000042 -0.000088 -0.000103 +0.000027 -0.000136 -0.000117 +-0.000004 -0.000138 -0.000117 +-0.000016 -0.000094 -0.000106 +-0.000003 -0.000037 -0.000081 +0.000017 -0.000002 -0.000061 +0.000028 0.000009 -0.000056 +0.000026 0.000013 -0.000058 +0.000020 0.000013 -0.000059 +0.000015 0.000012 -0.000060 +0.000019 0.000001 -0.000065 +0.000032 -0.000032 -0.000080 +0.000028 -0.000050 -0.000087 +0.000014 -0.000077 -0.000087 +-0.000002 -0.000085 -0.000085 +-0.000011 -0.000062 -0.000082 +-0.000005 -0.000028 -0.000072 +0.000009 -0.000004 -0.000064 +0.000020 0.000009 -0.000062 +0.000026 0.000014 -0.000062 +0.000027 0.000015 -0.000064 +0.000027 0.000010 -0.000067 +0.000030 -0.000001 -0.000072 0.000032 -0.000021 -0.000080 -0.000023 -0.000005 -0.000080 -0.000013 -0.000013 -0.000076 --0.000001 -0.000014 -0.000071 --0.000012 -0.000007 -0.000069 --0.000008 0.000003 -0.000067 -0.000006 0.000009 -0.000065 +0.000024 -0.000006 -0.000080 +0.000014 -0.000013 -0.000076 +-0.000000 -0.000014 -0.000071 +-0.000011 -0.000007 -0.000069 +-0.000007 0.000003 -0.000067 +0.000006 0.000010 -0.000065 0.000017 0.000014 -0.000065 0.000024 0.000017 -0.000065 -0.000029 0.000017 -0.000067 -0.000032 0.000014 -0.000070 -0.000032 0.000010 -0.000074 -0.000030 0.000003 -0.000078 -0.000027 0.000036 -0.000084 -0.000014 0.000046 -0.000082 --0.000002 0.000053 -0.000081 --0.000011 0.000047 -0.000079 +0.000030 0.000017 -0.000067 +0.000033 0.000014 -0.000070 +0.000033 0.000010 -0.000074 +0.000030 0.000003 -0.000079 +0.000028 0.000036 -0.000084 +0.000014 0.000046 -0.000083 +-0.000001 0.000053 -0.000081 +-0.000010 0.000047 -0.000079 -0.000008 0.000032 -0.000074 0.000002 0.000023 -0.000069 -0.000012 0.000019 -0.000067 -0.000021 0.000016 -0.000067 -0.000028 0.000015 -0.000068 +0.000013 0.000019 -0.000067 +0.000022 0.000016 -0.000067 +0.000029 0.000015 -0.000068 0.000033 0.000017 -0.000071 -0.000035 0.000021 -0.000075 -0.000034 0.000027 -0.000081 -0.000039 0.000071 -0.000095 -0.000021 0.000094 -0.000100 --0.000001 0.000096 -0.000101 --0.000013 0.000074 -0.000098 --0.000013 0.000047 -0.000086 --0.000004 0.000027 -0.000074 -0.000008 0.000016 -0.000068 -0.000017 0.000010 -0.000067 -0.000023 0.000010 -0.000068 -0.000029 0.000014 -0.000070 -0.000037 0.000024 -0.000076 -0.000043 0.000043 -0.000085 -0.000058 0.000091 -0.000114 -0.000040 0.000134 -0.000128 -0.000001 0.000132 -0.000128 +0.000036 0.000021 -0.000076 +0.000035 0.000028 -0.000081 +0.000040 0.000071 -0.000096 +0.000022 0.000094 -0.000100 +-0.000000 0.000096 -0.000101 +-0.000012 0.000074 -0.000098 +-0.000012 0.000046 -0.000086 +-0.000003 0.000027 -0.000074 +0.000009 0.000016 -0.000068 +0.000018 0.000010 -0.000067 +0.000024 0.000010 -0.000068 +0.000030 0.000014 -0.000070 +0.000038 0.000024 -0.000076 +0.000043 0.000044 -0.000086 +0.000059 0.000091 -0.000114 +0.000041 0.000134 -0.000129 +0.000002 0.000132 -0.000128 -0.000022 0.000088 -0.000117 --0.000017 0.000037 -0.000093 --0.000000 0.000007 -0.000072 -0.000011 0.000001 -0.000064 -0.000015 -0.000000 -0.000063 -0.000015 -0.000002 -0.000064 -0.000017 -0.000001 -0.000065 -0.000027 0.000009 -0.000070 -0.000046 0.000039 -0.000087 -0.000082 0.000086 -0.000131 -0.000057 0.000125 -0.000171 --0.000002 0.000123 -0.000171 --0.000039 0.000086 -0.000133 --0.000027 0.000026 -0.000071 -0.000000 -0.000011 -0.000032 -0.000010 -0.000012 -0.000031 -0.000010 -0.000005 -0.000038 -0.000009 -0.000004 -0.000040 -0.000009 -0.000008 -0.000037 -0.000022 -0.000005 -0.000039 -0.000057 0.000027 -0.000071 -0.000066 0.000052 -0.000129 -0.000060 0.000109 -0.000224 -0.000005 0.000112 -0.000230 --0.000020 0.000058 -0.000139 -0.000005 -0.000004 -0.000044 -0.000023 -0.000026 -0.000010 -0.000017 -0.000021 -0.000017 -0.000007 -0.000014 -0.000026 -0.000001 -0.000011 -0.000028 --0.000002 -0.000015 -0.000023 -0.000002 -0.000021 -0.000017 -0.000028 -0.000005 -0.000042 -0.000030 0.000006 -0.000119 -0.000042 0.000037 -0.000240 -0.000021 0.000041 -0.000253 -0.000016 0.000011 -0.000133 -0.000033 -0.000014 -0.000034 -0.000037 -0.000019 -0.000010 -0.000024 -0.000017 -0.000014 -0.000007 -0.000016 -0.000021 --0.000004 -0.000017 -0.000023 --0.000010 -0.000018 -0.000019 --0.000011 -0.000020 -0.000015 -0.000002 -0.000016 -0.000035 -0.000027 -0.000034 -0.000120 -0.000039 -0.000062 -0.000242 -0.000020 -0.000064 -0.000254 -0.000017 -0.000034 -0.000134 -0.000036 -0.000010 -0.000035 -0.000040 -0.000007 -0.000012 -0.000028 -0.000010 -0.000016 -0.000012 -0.000015 -0.000023 --0.000002 -0.000018 -0.000025 --0.000012 -0.000017 -0.000021 --0.000015 -0.000013 -0.000017 --0.000002 -0.000013 -0.000036 -0.000055 -0.000075 -0.000132 -0.000052 -0.000131 -0.000228 -0.000002 -0.000132 -0.000234 --0.000018 -0.000077 -0.000144 -0.000012 -0.000016 -0.000048 -0.000033 0.000005 -0.000015 -0.000029 -0.000001 -0.000021 -0.000018 -0.000008 -0.000030 -0.000006 -0.000009 -0.000032 --0.000007 -0.000006 -0.000027 --0.000010 -0.000002 -0.000021 -0.000015 -0.000019 -0.000046 -0.000066 -0.000099 -0.000137 -0.000045 -0.000140 -0.000177 --0.000007 -0.000138 -0.000178 --0.000034 -0.000099 -0.000140 --0.000016 -0.000039 -0.000078 -0.000016 -0.000001 -0.000040 -0.000027 0.000003 -0.000037 -0.000022 0.000000 -0.000043 -0.000013 0.000002 -0.000042 -0.000005 0.000005 -0.000039 -0.000010 -0.000001 -0.000042 -0.000039 -0.000037 -0.000077 -0.000045 -0.000085 -0.000127 -0.000023 -0.000109 -0.000137 --0.000005 -0.000110 -0.000135 --0.000021 -0.000090 -0.000125 --0.000017 -0.000050 -0.000098 -0.000005 -0.000013 -0.000071 -0.000021 0.000004 -0.000059 -0.000024 0.000007 -0.000057 -0.000021 0.000008 -0.000056 -0.000020 0.000007 -0.000057 -0.000028 -0.000007 -0.000068 -0.000043 -0.000042 -0.000097 -0.000026 -0.000047 -0.000117 +-0.000016 0.000036 -0.000093 +0.000001 0.000007 -0.000072 +0.000012 0.000000 -0.000064 +0.000016 -0.000000 -0.000063 +0.000016 -0.000001 -0.000064 +0.000019 -0.000000 -0.000065 +0.000029 0.000010 -0.000070 +0.000047 0.000040 -0.000088 +0.000084 0.000087 -0.000132 +0.000059 0.000125 -0.000172 +-0.000000 0.000123 -0.000171 +-0.000037 0.000084 -0.000132 +-0.000025 0.000025 -0.000070 +0.000003 -0.000012 -0.000032 +0.000012 -0.000013 -0.000030 +0.000012 -0.000005 -0.000038 +0.000011 -0.000004 -0.000040 +0.000011 -0.000007 -0.000037 +0.000024 -0.000004 -0.000041 +0.000059 0.000029 -0.000073 +0.000069 0.000054 -0.000132 +0.000062 0.000110 -0.000225 +0.000007 0.000111 -0.000229 +-0.000017 0.000056 -0.000137 +0.000009 -0.000006 -0.000041 +0.000027 -0.000027 -0.000009 +0.000020 -0.000021 -0.000016 +0.000009 -0.000014 -0.000026 +0.000003 -0.000011 -0.000029 +0.000001 -0.000014 -0.000024 +0.000005 -0.000020 -0.000019 +0.000032 -0.000003 -0.000046 +0.000035 0.000007 -0.000124 +0.000045 0.000037 -0.000243 +0.000024 0.000040 -0.000251 +0.000020 0.000011 -0.000129 +0.000037 -0.000015 -0.000030 +0.000041 -0.000020 -0.000009 +0.000027 -0.000017 -0.000013 +0.000009 -0.000016 -0.000021 +-0.000002 -0.000017 -0.000023 +-0.000006 -0.000018 -0.000020 +-0.000007 -0.000019 -0.000018 +0.000007 -0.000015 -0.000039 +0.000032 -0.000035 -0.000125 +0.000042 -0.000063 -0.000244 +0.000023 -0.000063 -0.000253 +0.000021 -0.000033 -0.000130 +0.000039 -0.000009 -0.000032 +0.000044 -0.000006 -0.000010 +0.000031 -0.000010 -0.000015 +0.000014 -0.000014 -0.000023 +0.000001 -0.000018 -0.000026 +-0.000009 -0.000017 -0.000022 +-0.000011 -0.000013 -0.000020 +0.000003 -0.000015 -0.000041 +0.000058 -0.000076 -0.000136 +0.000054 -0.000131 -0.000229 +0.000004 -0.000131 -0.000233 +-0.000016 -0.000076 -0.000141 +0.000015 -0.000015 -0.000046 +0.000036 0.000006 -0.000013 +0.000031 -0.000001 -0.000021 +0.000020 -0.000008 -0.000030 +0.000008 -0.000009 -0.000032 +-0.000004 -0.000006 -0.000028 +-0.000006 -0.000004 -0.000024 +0.000019 -0.000022 -0.000050 +0.000067 -0.000100 -0.000139 +0.000047 -0.000140 -0.000178 +-0.000006 -0.000137 -0.000177 +-0.000033 -0.000098 -0.000139 +-0.000014 -0.000038 -0.000077 +0.000018 0.000001 -0.000039 +0.000029 0.000004 -0.000037 +0.000024 0.000000 -0.000043 +0.000015 0.000001 -0.000043 +0.000007 0.000004 -0.000040 +0.000013 -0.000002 -0.000044 +0.000042 -0.000039 -0.000079 +0.000046 -0.000086 -0.000127 +0.000024 -0.000109 -0.000138 +-0.000005 -0.000110 -0.000136 +-0.000020 -0.000089 -0.000125 +-0.000016 -0.000049 -0.000098 +0.000006 -0.000012 -0.000071 +0.000022 0.000004 -0.000059 +0.000025 0.000007 -0.000057 +0.000022 0.000008 -0.000057 +0.000021 0.000006 -0.000058 +0.000030 -0.000007 -0.000069 +0.000045 -0.000043 -0.000098 +0.000026 -0.000048 -0.000118 0.000011 -0.000064 -0.000127 --0.000002 -0.000071 -0.000128 --0.000010 -0.000060 -0.000122 --0.000009 -0.000033 -0.000108 -0.000004 -0.000008 -0.000089 -0.000017 0.000005 -0.000075 -0.000024 0.000011 -0.000069 -0.000027 0.000012 -0.000068 -0.000029 0.000007 -0.000072 -0.000033 -0.000005 -0.000082 -0.000034 -0.000025 -0.000100 -0.000020 -0.000005 -0.000113 +-0.000001 -0.000071 -0.000128 +-0.000010 -0.000059 -0.000122 +-0.000008 -0.000033 -0.000107 +0.000005 -0.000008 -0.000089 +0.000017 0.000006 -0.000075 +0.000025 0.000011 -0.000069 +0.000028 0.000011 -0.000068 +0.000030 0.000007 -0.000072 +0.000034 -0.000005 -0.000083 +0.000035 -0.000026 -0.000100 +0.000020 -0.000005 -0.000114 0.000011 -0.000009 -0.000125 -0.000000 -0.000010 -0.000129 +0.000001 -0.000010 -0.000129 -0.000009 -0.000006 -0.000124 --0.000008 0.000001 -0.000111 -0.000004 0.000008 -0.000094 -0.000015 0.000013 -0.000082 -0.000023 0.000016 -0.000075 -0.000029 0.000016 -0.000073 -0.000033 0.000013 -0.000077 +-0.000007 0.000001 -0.000111 +0.000005 0.000008 -0.000094 +0.000016 0.000013 -0.000082 +0.000024 0.000016 -0.000075 +0.000030 0.000016 -0.000073 +0.000034 0.000013 -0.000077 0.000034 0.000009 -0.000087 -0.000029 0.000002 -0.000100 +0.000030 0.000002 -0.000100 0.000024 0.000035 -0.000111 0.000011 0.000043 -0.000119 --0.000001 0.000049 -0.000120 +-0.000000 0.000049 -0.000120 -0.000008 0.000046 -0.000115 -0.000008 0.000034 -0.000105 --0.000000 0.000024 -0.000091 -0.000010 0.000020 -0.000080 -0.000020 0.000017 -0.000074 +0.000001 0.000024 -0.000091 +0.000011 0.000020 -0.000080 +0.000021 0.000017 -0.000074 0.000029 0.000017 -0.000073 -0.000034 0.000018 -0.000077 -0.000036 0.000022 -0.000086 +0.000035 0.000018 -0.000077 +0.000037 0.000023 -0.000086 0.000034 0.000029 -0.000098 -0.000037 0.000069 -0.000110 -0.000018 0.000081 -0.000115 --0.000000 0.000082 -0.000113 --0.000012 0.000071 -0.000107 --0.000016 0.000052 -0.000095 --0.000008 0.000032 -0.000081 -0.000005 0.000019 -0.000071 -0.000016 0.000014 -0.000067 -0.000024 0.000013 -0.000066 -0.000032 0.000017 -0.000070 -0.000041 0.000028 -0.000080 -0.000045 0.000048 -0.000096 -0.000062 0.000088 -0.000118 -0.000037 0.000107 -0.000128 -0.000001 0.000104 -0.000126 --0.000027 0.000084 -0.000115 --0.000030 0.000049 -0.000088 --0.000012 0.000017 -0.000062 -0.000005 0.000006 -0.000054 -0.000013 0.000005 -0.000054 -0.000017 0.000004 -0.000054 -0.000023 0.000004 -0.000055 -0.000038 0.000017 -0.000066 -0.000059 0.000050 -0.000092 -0.000080 0.000064 -0.000102 -0.000050 0.000071 -0.000120 -0.000006 0.000067 -0.000117 --0.000031 0.000056 -0.000097 --0.000043 0.000032 -0.000061 --0.000031 0.000009 -0.000030 --0.000013 0.000005 -0.000025 -0.000002 0.000008 -0.000034 -0.000013 0.000008 -0.000038 -0.000026 0.000009 -0.000039 -0.000049 0.000019 -0.000047 -0.000077 0.000041 -0.000071 -0.000081 0.000036 -0.000098 -0.000056 0.000046 -0.000140 -0.000007 0.000044 -0.000140 --0.000029 0.000033 -0.000096 --0.000033 0.000012 -0.000044 --0.000024 -0.000004 -0.000016 --0.000016 -0.000008 -0.000012 --0.000006 -0.000005 -0.000019 -0.000007 -0.000002 -0.000025 -0.000024 -0.000001 -0.000026 -0.000048 0.000001 -0.000029 -0.000073 0.000014 -0.000051 -0.000077 0.000005 -0.000095 -0.000057 0.000011 -0.000150 -0.000009 0.000011 -0.000153 --0.000024 0.000006 -0.000094 --0.000026 -0.000001 -0.000038 --0.000018 -0.000007 -0.000015 --0.000012 -0.000010 -0.000009 --0.000007 -0.000012 -0.000014 -0.000004 -0.000012 -0.000019 -0.000021 -0.000011 -0.000021 -0.000044 -0.000009 -0.000026 -0.000065 -0.000003 -0.000046 -0.000074 -0.000026 -0.000097 -0.000055 -0.000028 -0.000153 -0.000008 -0.000025 -0.000155 --0.000024 -0.000020 -0.000097 --0.000024 -0.000014 -0.000042 --0.000015 -0.000012 -0.000017 --0.000009 -0.000012 -0.000012 --0.000002 -0.000016 -0.000018 -0.000006 -0.000019 -0.000024 -0.000019 -0.000020 -0.000025 -0.000039 -0.000020 -0.000030 -0.000062 -0.000021 -0.000049 -0.000071 -0.000058 -0.000107 -0.000049 -0.000066 -0.000150 -0.000004 -0.000061 -0.000151 --0.000026 -0.000050 -0.000107 --0.000026 -0.000030 -0.000054 --0.000014 -0.000016 -0.000026 --0.000002 -0.000017 -0.000025 -0.000008 -0.000020 -0.000032 -0.000013 -0.000020 -0.000035 -0.000019 -0.000022 -0.000036 -0.000034 -0.000027 -0.000041 -0.000059 -0.000041 -0.000062 -0.000059 -0.000083 -0.000124 -0.000035 -0.000089 -0.000139 --0.000000 -0.000084 -0.000138 --0.000026 -0.000073 -0.000119 --0.000029 -0.000049 -0.000082 --0.000009 -0.000027 -0.000054 -0.000012 -0.000020 -0.000049 -0.000019 -0.000017 -0.000050 -0.000019 -0.000013 -0.000048 -0.000021 -0.000015 -0.000049 -0.000033 -0.000029 -0.000062 -0.000052 -0.000058 -0.000093 -0.000033 -0.000079 -0.000138 -0.000014 -0.000085 -0.000141 +0.000038 0.000069 -0.000111 +0.000019 0.000082 -0.000115 +0.000001 0.000082 -0.000113 +-0.000011 0.000071 -0.000107 +-0.000015 0.000051 -0.000095 +-0.000007 0.000032 -0.000081 +0.000006 0.000019 -0.000071 +0.000017 0.000014 -0.000067 +0.000025 0.000013 -0.000066 +0.000033 0.000017 -0.000070 +0.000042 0.000028 -0.000080 +0.000046 0.000048 -0.000097 +0.000063 0.000089 -0.000119 +0.000038 0.000107 -0.000128 +0.000002 0.000103 -0.000126 +-0.000026 0.000083 -0.000115 +-0.000029 0.000048 -0.000088 +-0.000011 0.000016 -0.000062 +0.000007 0.000006 -0.000054 +0.000015 0.000005 -0.000054 +0.000018 0.000004 -0.000054 +0.000025 0.000005 -0.000056 +0.000040 0.000018 -0.000067 +0.000060 0.000051 -0.000093 +0.000081 0.000064 -0.000103 +0.000051 0.000071 -0.000120 +0.000007 0.000066 -0.000117 +-0.000030 0.000055 -0.000096 +-0.000041 0.000031 -0.000060 +-0.000029 0.000008 -0.000029 +-0.000011 0.000004 -0.000025 +0.000004 0.000008 -0.000034 +0.000015 0.000008 -0.000038 +0.000028 0.000010 -0.000040 +0.000051 0.000020 -0.000049 +0.000078 0.000042 -0.000073 +0.000083 0.000037 -0.000101 +0.000058 0.000046 -0.000141 +0.000009 0.000043 -0.000139 +-0.000027 0.000032 -0.000094 +-0.000031 0.000011 -0.000042 +-0.000022 -0.000005 -0.000014 +-0.000014 -0.000008 -0.000011 +-0.000004 -0.000005 -0.000019 +0.000009 -0.000002 -0.000025 +0.000027 -0.000001 -0.000027 +0.000050 0.000002 -0.000031 +0.000075 0.000015 -0.000054 +0.000079 0.000005 -0.000098 +0.000059 0.000011 -0.000152 +0.000010 0.000011 -0.000152 +-0.000022 0.000006 -0.000092 +-0.000023 -0.000002 -0.000036 +-0.000015 -0.000008 -0.000013 +-0.000010 -0.000010 -0.000009 +-0.000005 -0.000012 -0.000014 +0.000006 -0.000012 -0.000020 +0.000024 -0.000011 -0.000022 +0.000046 -0.000009 -0.000028 +0.000068 -0.000003 -0.000050 +0.000076 -0.000026 -0.000100 +0.000056 -0.000028 -0.000155 +0.000009 -0.000025 -0.000154 +-0.000021 -0.000020 -0.000094 +-0.000021 -0.000014 -0.000039 +-0.000013 -0.000011 -0.000016 +-0.000007 -0.000012 -0.000012 +-0.000000 -0.000016 -0.000018 +0.000008 -0.000019 -0.000024 +0.000022 -0.000020 -0.000027 +0.000042 -0.000020 -0.000032 +0.000065 -0.000022 -0.000052 +0.000072 -0.000059 -0.000110 +0.000050 -0.000066 -0.000151 +0.000005 -0.000061 -0.000150 +-0.000025 -0.000049 -0.000105 +-0.000024 -0.000029 -0.000052 +-0.000012 -0.000015 -0.000024 +-0.000000 -0.000017 -0.000024 +0.000010 -0.000020 -0.000032 +0.000015 -0.000020 -0.000036 +0.000022 -0.000022 -0.000038 +0.000037 -0.000028 -0.000043 +0.000061 -0.000042 -0.000065 +0.000060 -0.000084 -0.000126 +0.000036 -0.000089 -0.000140 +0.000000 -0.000084 -0.000138 +-0.000025 -0.000073 -0.000118 +-0.000027 -0.000048 -0.000080 +-0.000007 -0.000026 -0.000053 +0.000013 -0.000020 -0.000048 +0.000021 -0.000017 -0.000050 +0.000021 -0.000014 -0.000049 +0.000023 -0.000015 -0.000050 +0.000035 -0.000030 -0.000063 +0.000054 -0.000059 -0.000095 +0.000033 -0.000080 -0.000139 +0.000014 -0.000086 -0.000142 -0.000004 -0.000085 -0.000137 --0.000015 -0.000078 -0.000130 --0.000016 -0.000057 -0.000114 -0.000000 -0.000033 -0.000094 -0.000019 -0.000014 -0.000076 -0.000025 -0.000005 -0.000065 -0.000024 -0.000002 -0.000062 -0.000027 -0.000006 -0.000065 -0.000035 -0.000024 -0.000083 -0.000041 -0.000056 -0.000115 -0.000013 -0.000045 -0.000145 -0.000002 -0.000056 -0.000161 +-0.000014 -0.000077 -0.000129 +-0.000015 -0.000057 -0.000114 +0.000002 -0.000033 -0.000093 +0.000020 -0.000014 -0.000075 +0.000026 -0.000005 -0.000065 +0.000026 -0.000002 -0.000062 +0.000028 -0.000006 -0.000066 +0.000037 -0.000025 -0.000084 +0.000042 -0.000056 -0.000116 +0.000014 -0.000045 -0.000145 +0.000002 -0.000056 -0.000162 -0.000004 -0.000064 -0.000165 --0.000007 -0.000058 -0.000159 --0.000002 -0.000039 -0.000146 -0.000009 -0.000019 -0.000120 -0.000020 -0.000003 -0.000094 -0.000027 0.000006 -0.000080 -0.000029 0.000006 -0.000076 -0.000031 0.000001 -0.000080 -0.000033 -0.000012 -0.000096 -0.000028 -0.000031 -0.000120 -0.000008 -0.000004 -0.000144 +-0.000006 -0.000058 -0.000159 +-0.000002 -0.000039 -0.000145 +0.000010 -0.000018 -0.000120 +0.000021 -0.000002 -0.000094 +0.000028 0.000006 -0.000080 +0.000030 0.000006 -0.000076 +0.000032 0.000001 -0.000081 +0.000034 -0.000013 -0.000097 +0.000028 -0.000031 -0.000121 +0.000009 -0.000004 -0.000145 0.000003 -0.000007 -0.000171 --0.000002 -0.000008 -0.000185 +-0.000001 -0.000008 -0.000185 -0.000006 -0.000005 -0.000180 --0.000001 -0.000000 -0.000159 -0.000011 0.000006 -0.000127 -0.000021 0.000011 -0.000101 +-0.000000 -0.000000 -0.000158 +0.000012 0.000006 -0.000127 +0.000022 0.000011 -0.000101 0.000028 0.000014 -0.000087 -0.000032 0.000014 -0.000082 -0.000033 0.000011 -0.000087 -0.000030 0.000007 -0.000101 -0.000020 0.000001 -0.000120 +0.000032 0.000014 -0.000083 +0.000034 0.000011 -0.000087 +0.000030 0.000006 -0.000101 +0.000021 0.000001 -0.000120 0.000013 0.000035 -0.000136 -0.000003 0.000041 -0.000151 --0.000003 0.000048 -0.000155 +0.000003 0.000041 -0.000152 +-0.000002 0.000048 -0.000155 -0.000005 0.000047 -0.000150 -0.000001 0.000036 -0.000138 -0.000007 0.000028 -0.000118 -0.000015 0.000023 -0.000097 +0.000008 0.000028 -0.000118 +0.000016 0.000023 -0.000097 0.000024 0.000020 -0.000084 -0.000030 0.000019 -0.000080 -0.000034 0.000021 -0.000085 -0.000033 0.000025 -0.000097 -0.000025 0.000031 -0.000115 -0.000029 0.000068 -0.000121 -0.000013 0.000070 -0.000121 --0.000001 0.000070 -0.000116 --0.000010 0.000065 -0.000110 --0.000014 0.000055 -0.000104 --0.000008 0.000044 -0.000095 -0.000007 0.000031 -0.000082 -0.000018 0.000021 -0.000071 -0.000026 0.000018 -0.000069 -0.000034 0.000023 -0.000074 -0.000042 0.000037 -0.000089 -0.000040 0.000056 -0.000109 -0.000059 0.000077 -0.000107 -0.000034 0.000078 -0.000107 +0.000031 0.000019 -0.000080 +0.000035 0.000021 -0.000085 +0.000034 0.000025 -0.000098 +0.000026 0.000031 -0.000116 +0.000030 0.000068 -0.000122 +0.000014 0.000070 -0.000121 +-0.000000 0.000070 -0.000116 +-0.000009 0.000065 -0.000110 +-0.000014 0.000055 -0.000103 +-0.000007 0.000043 -0.000095 +0.000008 0.000030 -0.000082 +0.000019 0.000021 -0.000071 +0.000027 0.000019 -0.000069 +0.000035 0.000023 -0.000074 +0.000043 0.000038 -0.000089 +0.000041 0.000057 -0.000110 +0.000060 0.000078 -0.000108 +0.000035 0.000078 -0.000108 0.000004 0.000073 -0.000105 --0.000023 0.000066 -0.000098 --0.000037 0.000051 -0.000079 --0.000026 0.000033 -0.000061 --0.000003 0.000022 -0.000055 -0.000012 0.000018 -0.000054 -0.000020 0.000014 -0.000053 -0.000031 0.000017 -0.000056 -0.000047 0.000035 -0.000072 -0.000062 0.000062 -0.000096 -0.000087 0.000033 -0.000060 -0.000055 0.000030 -0.000064 -0.000013 0.000023 -0.000062 --0.000025 0.000017 -0.000051 --0.000052 0.000010 -0.000034 --0.000058 0.000005 -0.000021 --0.000040 0.000010 -0.000027 --0.000011 0.000015 -0.000039 -0.000015 0.000017 -0.000045 -0.000040 0.000020 -0.000049 -0.000067 0.000028 -0.000054 -0.000089 0.000034 -0.000057 -0.000089 0.000017 -0.000061 -0.000058 0.000016 -0.000077 -0.000013 0.000012 -0.000075 --0.000026 0.000009 -0.000053 --0.000049 0.000003 -0.000030 --0.000054 -0.000004 -0.000018 --0.000043 -0.000005 -0.000018 --0.000019 -0.000000 -0.000027 -0.000010 0.000003 -0.000035 -0.000041 0.000006 -0.000039 -0.000072 0.000008 -0.000041 -0.000093 0.000012 -0.000046 -0.000090 0.000004 -0.000064 -0.000062 0.000005 -0.000086 -0.000011 0.000006 -0.000085 --0.000030 0.000006 -0.000056 --0.000047 0.000002 -0.000030 --0.000049 -0.000003 -0.000020 --0.000039 -0.000006 -0.000019 --0.000018 -0.000008 -0.000025 -0.000009 -0.000009 -0.000032 -0.000040 -0.000008 -0.000036 -0.000070 -0.000005 -0.000040 -0.000090 -0.000000 -0.000046 -0.000090 -0.000011 -0.000063 -0.000060 -0.000005 -0.000086 -0.000010 -0.000000 -0.000085 --0.000029 0.000000 -0.000056 --0.000046 -0.000001 -0.000031 --0.000048 -0.000003 -0.000020 --0.000037 -0.000007 -0.000020 --0.000015 -0.000014 -0.000028 -0.000011 -0.000019 -0.000035 -0.000038 -0.000020 -0.000040 -0.000067 -0.000018 -0.000042 -0.000089 -0.000015 -0.000047 -0.000083 -0.000031 -0.000067 -0.000054 -0.000024 -0.000083 -0.000011 -0.000016 -0.000082 --0.000024 -0.000012 -0.000061 --0.000045 -0.000010 -0.000036 --0.000047 -0.000009 -0.000024 --0.000030 -0.000017 -0.000030 --0.000005 -0.000024 -0.000040 -0.000017 -0.000025 -0.000046 -0.000036 -0.000028 -0.000050 -0.000059 -0.000033 -0.000053 -0.000081 -0.000035 -0.000057 -0.000058 -0.000063 -0.000092 -0.000039 -0.000050 -0.000089 -0.000007 -0.000040 -0.000089 --0.000019 -0.000034 -0.000079 --0.000036 -0.000030 -0.000060 --0.000028 -0.000033 -0.000055 --0.000003 -0.000036 -0.000062 -0.000014 -0.000030 -0.000063 -0.000024 -0.000025 -0.000061 -0.000033 -0.000029 -0.000065 -0.000044 -0.000044 -0.000076 -0.000055 -0.000061 -0.000090 -0.000011 -0.000081 -0.000140 +-0.000022 0.000065 -0.000097 +-0.000035 0.000051 -0.000079 +-0.000025 0.000032 -0.000061 +-0.000002 0.000022 -0.000054 +0.000013 0.000018 -0.000054 +0.000021 0.000014 -0.000053 +0.000032 0.000018 -0.000057 +0.000049 0.000036 -0.000073 +0.000063 0.000063 -0.000097 +0.000088 0.000034 -0.000061 +0.000056 0.000030 -0.000065 +0.000014 0.000023 -0.000062 +-0.000024 0.000016 -0.000050 +-0.000051 0.000010 -0.000033 +-0.000057 0.000004 -0.000020 +-0.000038 0.000009 -0.000027 +-0.000010 0.000015 -0.000039 +0.000017 0.000017 -0.000046 +0.000041 0.000021 -0.000050 +0.000068 0.000029 -0.000055 +0.000090 0.000035 -0.000059 +0.000090 0.000017 -0.000063 +0.000059 0.000016 -0.000078 +0.000014 0.000012 -0.000074 +-0.000025 0.000009 -0.000052 +-0.000048 0.000002 -0.000028 +-0.000052 -0.000004 -0.000016 +-0.000041 -0.000005 -0.000018 +-0.000017 -0.000000 -0.000027 +0.000012 0.000003 -0.000036 +0.000043 0.000006 -0.000041 +0.000073 0.000009 -0.000043 +0.000095 0.000013 -0.000048 +0.000092 0.000004 -0.000066 +0.000062 0.000006 -0.000087 +0.000012 0.000006 -0.000084 +-0.000029 0.000006 -0.000055 +-0.000046 0.000002 -0.000029 +-0.000047 -0.000003 -0.000019 +-0.000037 -0.000006 -0.000018 +-0.000017 -0.000008 -0.000025 +0.000010 -0.000009 -0.000033 +0.000042 -0.000008 -0.000038 +0.000072 -0.000005 -0.000042 +0.000092 0.000000 -0.000049 +0.000091 -0.000011 -0.000066 +0.000061 -0.000006 -0.000088 +0.000011 -0.000000 -0.000085 +-0.000028 0.000000 -0.000055 +-0.000045 -0.000001 -0.000029 +-0.000046 -0.000002 -0.000019 +-0.000036 -0.000007 -0.000019 +-0.000013 -0.000014 -0.000028 +0.000012 -0.000019 -0.000036 +0.000040 -0.000020 -0.000041 +0.000069 -0.000018 -0.000044 +0.000091 -0.000015 -0.000049 +0.000084 -0.000031 -0.000068 +0.000054 -0.000024 -0.000084 +0.000012 -0.000015 -0.000082 +-0.000023 -0.000012 -0.000060 +-0.000044 -0.000009 -0.000035 +-0.000046 -0.000008 -0.000023 +-0.000029 -0.000017 -0.000030 +-0.000003 -0.000024 -0.000040 +0.000018 -0.000025 -0.000047 +0.000038 -0.000029 -0.000051 +0.000061 -0.000033 -0.000055 +0.000083 -0.000035 -0.000059 +0.000058 -0.000063 -0.000093 +0.000039 -0.000050 -0.000090 +0.000008 -0.000040 -0.000089 +-0.000018 -0.000034 -0.000078 +-0.000035 -0.000030 -0.000059 +-0.000027 -0.000033 -0.000055 +-0.000002 -0.000036 -0.000062 +0.000015 -0.000030 -0.000063 +0.000025 -0.000026 -0.000062 +0.000035 -0.000030 -0.000066 +0.000045 -0.000044 -0.000078 +0.000056 -0.000062 -0.000092 +0.000012 -0.000082 -0.000141 0.000005 -0.000073 -0.000133 -0.000002 -0.000063 -0.000124 -0.000008 -0.000057 -0.000119 --0.000005 -0.000056 -0.000118 -0.000011 -0.000055 -0.000116 -0.000026 -0.000039 -0.000100 -0.000030 -0.000021 -0.000081 -0.000030 -0.000015 -0.000075 -0.000032 -0.000020 -0.000079 -0.000032 -0.000039 -0.000097 -0.000023 -0.000066 -0.000125 --0.000017 -0.000055 -0.000173 --0.000022 -0.000064 -0.000199 +-0.000004 -0.000056 -0.000117 +0.000012 -0.000055 -0.000115 +0.000027 -0.000039 -0.000099 +0.000031 -0.000021 -0.000082 +0.000031 -0.000015 -0.000075 +0.000033 -0.000020 -0.000080 +0.000032 -0.000039 -0.000099 +0.000023 -0.000067 -0.000126 +-0.000017 -0.000055 -0.000174 +-0.000022 -0.000064 -0.000200 -0.000011 -0.000063 -0.000203 0.000003 -0.000059 -0.000199 -0.000022 -0.000053 -0.000190 +0.000023 -0.000053 -0.000189 0.000036 -0.000039 -0.000159 0.000037 -0.000018 -0.000119 -0.000035 -0.000003 -0.000094 -0.000034 -0.000001 -0.000086 -0.000032 -0.000007 -0.000092 -0.000024 -0.000020 -0.000109 -0.000005 -0.000038 -0.000137 --0.000019 -0.000003 -0.000177 +0.000036 -0.000003 -0.000094 +0.000035 -0.000001 -0.000087 +0.000033 -0.000007 -0.000093 +0.000025 -0.000020 -0.000110 +0.000006 -0.000038 -0.000137 +-0.000018 -0.000003 -0.000177 -0.000024 -0.000007 -0.000227 -0.000013 -0.000009 -0.000254 0.000006 -0.000008 -0.000251 0.000026 -0.000003 -0.000219 0.000036 0.000003 -0.000166 -0.000036 0.000008 -0.000123 -0.000036 0.000012 -0.000100 +0.000037 0.000008 -0.000123 +0.000037 0.000012 -0.000101 0.000036 0.000012 -0.000093 0.000032 0.000009 -0.000098 -0.000020 0.000005 -0.000112 -0.000001 0.000001 -0.000136 --0.000015 0.000046 -0.000164 --0.000019 0.000050 -0.000189 --0.000010 0.000048 -0.000193 -0.000002 0.000046 -0.000190 -0.000020 0.000047 -0.000181 -0.000031 0.000043 -0.000153 -0.000031 0.000032 -0.000118 -0.000031 0.000023 -0.000095 -0.000034 0.000021 -0.000088 -0.000033 0.000024 -0.000093 -0.000025 0.000028 -0.000107 -0.000006 0.000037 -0.000131 -0.000014 0.000074 -0.000127 -0.000008 0.000063 -0.000116 +0.000021 0.000005 -0.000113 +0.000002 0.000000 -0.000136 +-0.000014 0.000047 -0.000165 +-0.000018 0.000050 -0.000190 +-0.000009 0.000048 -0.000194 +0.000003 0.000046 -0.000190 +0.000021 0.000047 -0.000180 +0.000032 0.000043 -0.000153 +0.000031 0.000032 -0.000117 +0.000032 0.000023 -0.000095 +0.000034 0.000021 -0.000089 +0.000034 0.000024 -0.000094 +0.000025 0.000028 -0.000108 +0.000007 0.000037 -0.000131 +0.000014 0.000075 -0.000127 +0.000009 0.000063 -0.000117 0.000000 0.000052 -0.000105 --0.000008 0.000048 -0.000101 --0.000008 0.000053 -0.000105 -0.000003 0.000060 -0.000110 -0.000015 0.000048 -0.000098 -0.000022 0.000032 -0.000081 -0.000029 0.000026 -0.000076 -0.000036 0.000032 -0.000082 -0.000036 0.000046 -0.000097 -0.000026 0.000066 -0.000117 -0.000062 0.000060 -0.000079 +-0.000008 0.000048 -0.000100 +-0.000008 0.000053 -0.000104 +0.000003 0.000059 -0.000110 +0.000016 0.000048 -0.000098 +0.000023 0.000032 -0.000081 +0.000030 0.000026 -0.000076 +0.000037 0.000032 -0.000082 +0.000037 0.000047 -0.000098 +0.000026 0.000066 -0.000118 +0.000063 0.000060 -0.000080 0.000043 0.000046 -0.000068 0.000010 0.000036 -0.000067 --0.000020 0.000030 -0.000062 --0.000043 0.000029 -0.000051 --0.000041 0.000035 -0.000053 --0.000015 0.000036 -0.000060 -0.000007 0.000030 -0.000061 -0.000022 0.000025 -0.000060 -0.000038 0.000030 -0.000065 -0.000052 0.000046 -0.000078 -0.000062 0.000062 -0.000088 -0.000110 0.000000 -0.000028 -0.000079 -0.000019 -0.000017 +-0.000019 0.000030 -0.000061 +-0.000042 0.000029 -0.000051 +-0.000040 0.000034 -0.000052 +-0.000014 0.000036 -0.000059 +0.000008 0.000030 -0.000061 +0.000023 0.000025 -0.000061 +0.000039 0.000030 -0.000066 +0.000053 0.000046 -0.000079 +0.000062 0.000063 -0.000089 +0.000110 0.000001 -0.000029 +0.000080 -0.000019 -0.000017 0.000024 -0.000032 -0.000016 --0.000032 -0.000038 -0.000012 --0.000076 -0.000033 -0.000007 --0.000087 -0.000020 -0.000015 --0.000061 0.000001 -0.000038 +-0.000031 -0.000038 -0.000012 +-0.000075 -0.000034 -0.000006 +-0.000086 -0.000020 -0.000015 +-0.000060 0.000001 -0.000038 -0.000021 0.000015 -0.000055 -0.000015 0.000020 -0.000062 -0.000047 0.000024 -0.000064 -0.000076 0.000027 -0.000061 -0.000103 0.000020 -0.000049 -0.000104 0.000002 -0.000039 +0.000016 0.000020 -0.000063 +0.000047 0.000024 -0.000065 +0.000077 0.000027 -0.000063 +0.000104 0.000021 -0.000050 +0.000104 0.000002 -0.000040 0.000072 -0.000006 -0.000035 0.000020 -0.000013 -0.000031 --0.000031 -0.000015 -0.000024 --0.000065 -0.000015 -0.000020 --0.000075 -0.000013 -0.000025 --0.000059 -0.000006 -0.000038 --0.000026 0.000002 -0.000049 +-0.000031 -0.000015 -0.000023 +-0.000065 -0.000015 -0.000019 +-0.000074 -0.000013 -0.000024 +-0.000058 -0.000006 -0.000037 +-0.000025 0.000002 -0.000049 0.000012 0.000007 -0.000056 -0.000048 0.000010 -0.000058 -0.000081 0.000010 -0.000055 -0.000104 0.000008 -0.000047 -0.000102 0.000005 -0.000043 -0.000072 0.000007 -0.000042 +0.000049 0.000010 -0.000059 +0.000082 0.000010 -0.000057 +0.000105 0.000008 -0.000049 +0.000103 0.000005 -0.000045 +0.000073 0.000007 -0.000043 0.000017 0.000007 -0.000039 --0.000034 0.000008 -0.000030 --0.000061 0.000005 -0.000025 --0.000067 -0.000000 -0.000030 --0.000054 -0.000004 -0.000040 +-0.000033 0.000008 -0.000029 +-0.000061 0.000005 -0.000024 +-0.000067 -0.000000 -0.000029 +-0.000053 -0.000004 -0.000039 -0.000025 -0.000006 -0.000049 -0.000011 -0.000006 -0.000054 -0.000048 -0.000005 -0.000056 -0.000080 -0.000003 -0.000054 -0.000101 0.000002 -0.000048 -0.000104 0.000005 -0.000040 -0.000073 0.000018 -0.000039 +0.000012 -0.000006 -0.000055 +0.000049 -0.000005 -0.000058 +0.000081 -0.000003 -0.000056 +0.000102 0.000002 -0.000051 +0.000105 0.000005 -0.000042 +0.000074 0.000018 -0.000040 0.000017 0.000027 -0.000036 --0.000034 0.000027 -0.000028 --0.000063 0.000021 -0.000023 --0.000069 0.000011 -0.000028 +-0.000033 0.000027 -0.000026 +-0.000062 0.000021 -0.000021 +-0.000068 0.000011 -0.000027 -0.000053 -0.000001 -0.000040 -0.000022 -0.000012 -0.000051 -0.000013 -0.000018 -0.000057 -0.000047 -0.000019 -0.000059 -0.000078 -0.000016 -0.000057 -0.000101 -0.000007 -0.000048 -0.000107 0.000003 -0.000034 +0.000014 -0.000018 -0.000058 +0.000048 -0.000019 -0.000061 +0.000079 -0.000016 -0.000058 +0.000102 -0.000007 -0.000051 +0.000108 0.000003 -0.000035 0.000077 0.000027 -0.000027 -0.000021 0.000042 -0.000027 --0.000032 0.000044 -0.000020 --0.000070 0.000036 -0.000013 --0.000077 0.000018 -0.000022 --0.000051 -0.000006 -0.000044 +0.000021 0.000042 -0.000026 +-0.000032 0.000044 -0.000019 +-0.000070 0.000036 -0.000012 +-0.000076 0.000018 -0.000021 +-0.000050 -0.000006 -0.000043 -0.000014 -0.000021 -0.000059 -0.000017 -0.000026 -0.000065 -0.000045 -0.000029 -0.000067 -0.000072 -0.000029 -0.000064 -0.000099 -0.000020 -0.000052 -0.000087 -0.000026 -0.000049 +0.000018 -0.000026 -0.000066 +0.000045 -0.000029 -0.000068 +0.000073 -0.000030 -0.000066 +0.000099 -0.000020 -0.000054 +0.000088 -0.000026 -0.000050 0.000075 0.000016 -0.000023 0.000025 0.000039 -0.000025 --0.000033 0.000044 -0.000022 --0.000070 0.000030 -0.000015 +-0.000032 0.000044 -0.000022 +-0.000070 0.000030 -0.000014 -0.000061 -0.000006 -0.000039 --0.000024 -0.000030 -0.000068 +-0.000024 -0.000029 -0.000067 0.000005 -0.000032 -0.000076 -0.000024 -0.000030 -0.000077 -0.000040 -0.000034 -0.000079 -0.000054 -0.000044 -0.000081 -0.000070 -0.000048 -0.000075 -0.000009 -0.000076 -0.000122 -0.000019 -0.000037 -0.000095 +0.000025 -0.000030 -0.000078 +0.000041 -0.000035 -0.000080 +0.000055 -0.000044 -0.000082 +0.000071 -0.000048 -0.000077 +0.000009 -0.000076 -0.000123 +0.000020 -0.000037 -0.000095 0.000011 0.000008 -0.000076 --0.000017 0.000013 -0.000075 --0.000016 -0.000024 -0.000091 +-0.000017 0.000013 -0.000074 +-0.000016 -0.000024 -0.000090 0.000013 -0.000058 -0.000116 0.000029 -0.000049 -0.000112 -0.000031 -0.000030 -0.000096 -0.000032 -0.000024 -0.000090 +0.000032 -0.000030 -0.000097 +0.000033 -0.000024 -0.000090 0.000034 -0.000029 -0.000092 -0.000028 -0.000044 -0.000102 -0.000015 -0.000068 -0.000119 --0.000071 -0.000078 -0.000197 --0.000077 -0.000075 -0.000241 +0.000029 -0.000044 -0.000103 +0.000015 -0.000068 -0.000120 +-0.000070 -0.000078 -0.000197 +-0.000077 -0.000075 -0.000242 -0.000034 -0.000033 -0.000244 0.000027 -0.000028 -0.000242 0.000079 -0.000066 -0.000239 0.000090 -0.000066 -0.000194 -0.000067 -0.000033 -0.000139 +0.000067 -0.000033 -0.000138 0.000049 -0.000011 -0.000108 -0.000039 -0.000008 -0.000098 -0.000029 -0.000013 -0.000100 +0.000040 -0.000008 -0.000099 +0.000029 -0.000013 -0.000101 0.000009 -0.000024 -0.000114 --0.000028 -0.000047 -0.000143 +-0.000027 -0.000047 -0.000144 -0.000090 -0.000006 -0.000214 --0.000122 -0.000012 -0.000318 +-0.000121 -0.000012 -0.000319 -0.000065 -0.000015 -0.000369 0.000056 -0.000014 -0.000368 0.000124 -0.000009 -0.000317 0.000108 -0.000002 -0.000212 0.000072 0.000005 -0.000138 -0.000052 0.000010 -0.000110 +0.000053 0.000010 -0.000110 0.000042 0.000010 -0.000101 -0.000028 0.000007 -0.000103 -0.000002 0.000004 -0.000115 --0.000037 -0.000001 -0.000142 --0.000066 0.000066 -0.000190 +0.000028 0.000007 -0.000104 +0.000003 0.000004 -0.000115 +-0.000036 -0.000001 -0.000142 +-0.000065 0.000066 -0.000190 -0.000074 0.000057 -0.000236 -0.000034 0.000011 -0.000240 0.000026 0.000009 -0.000238 @@ -1708,31 +1708,31 @@ LOOKUP_TABLE default 0.000082 0.000063 -0.000186 0.000058 0.000041 -0.000134 0.000043 0.000026 -0.000106 -0.000038 0.000024 -0.000097 +0.000039 0.000024 -0.000098 0.000031 0.000026 -0.000100 -0.000011 0.000030 -0.000111 --0.000024 0.000044 -0.000138 +0.000011 0.000030 -0.000112 +-0.000024 0.000044 -0.000139 0.000013 0.000071 -0.000115 -0.000024 0.000030 -0.000084 +0.000024 0.000030 -0.000085 0.000014 -0.000020 -0.000059 -0.000020 -0.000024 -0.000057 --0.000024 0.000019 -0.000078 +-0.000023 0.000019 -0.000078 0.000002 0.000059 -0.000107 -0.000016 0.000055 -0.000106 -0.000022 0.000038 -0.000092 +0.000017 0.000054 -0.000106 +0.000023 0.000038 -0.000092 0.000030 0.000033 -0.000087 -0.000036 0.000038 -0.000090 -0.000033 0.000049 -0.000099 -0.000019 0.000067 -0.000113 -0.000092 0.000026 -0.000041 -0.000081 -0.000017 -0.000009 -0.000028 -0.000041 -0.000010 --0.000035 -0.000047 -0.000008 --0.000079 -0.000032 -0.000002 --0.000075 0.000006 -0.000030 --0.000037 0.000029 -0.000061 --0.000004 0.000031 -0.000071 -0.000021 0.000031 -0.000074 -0.000042 0.000035 -0.000076 -0.000059 0.000045 -0.000078 -0.000075 0.000048 -0.000071 +0.000037 0.000038 -0.000090 +0.000033 0.000049 -0.000100 +0.000019 0.000067 -0.000114 +0.000093 0.000026 -0.000041 +0.000082 -0.000017 -0.000009 +0.000029 -0.000041 -0.000010 +-0.000034 -0.000047 -0.000008 +-0.000079 -0.000032 -0.000001 +-0.000074 0.000006 -0.000029 +-0.000036 0.000029 -0.000061 +-0.000003 0.000031 -0.000071 +0.000022 0.000031 -0.000074 +0.000043 0.000035 -0.000077 +0.000060 0.000045 -0.000079 +0.000076 0.000048 -0.000072 diff --git a/testsuite/python/data/engine_lbgpu_2pt.vtk b/testsuite/python/data/engine_lbgpu_2pt.vtk index bef25d0cd6f..ea8466b5d57 100644 --- a/testsuite/python/data/engine_lbgpu_2pt.vtk +++ b/testsuite/python/data/engine_lbgpu_2pt.vtk @@ -8,103 +8,103 @@ SPACING 1.000000 1.000000 1.000000 POINT_DATA 1728 SCALARS velocity float 3 LOOKUP_TABLE default -0.000074 -0.000021 -0.000027 -0.000052 -0.000070 0.000000 +0.000074 -0.000021 -0.000028 +0.000052 -0.000070 -0.000000 -0.000013 -0.000113 0.000007 --0.000094 -0.000120 0.000003 --0.000150 -0.000088 -0.000009 +-0.000094 -0.000120 0.000004 +-0.000150 -0.000088 -0.000008 -0.000153 -0.000044 -0.000037 -0.000118 -0.000008 -0.000066 --0.000075 0.000011 -0.000080 --0.000037 0.000018 -0.000085 --0.000002 0.000022 -0.000082 -0.000030 0.000024 -0.000074 -0.000059 0.000012 -0.000057 -0.000064 -0.000006 -0.000035 -0.000036 -0.000025 -0.000014 +-0.000075 0.000011 -0.000081 +-0.000036 0.000018 -0.000085 +-0.000002 0.000022 -0.000084 +0.000030 0.000024 -0.000076 +0.000059 0.000012 -0.000058 +0.000064 -0.000006 -0.000037 +0.000036 -0.000025 -0.000015 -0.000023 -0.000045 -0.000008 --0.000089 -0.000048 -0.000015 --0.000131 -0.000036 -0.000030 --0.000137 -0.000022 -0.000050 +-0.000089 -0.000048 -0.000014 +-0.000131 -0.000036 -0.000029 +-0.000137 -0.000022 -0.000049 -0.000116 -0.000010 -0.000068 -0.000081 -0.000000 -0.000079 --0.000041 0.000006 -0.000082 --0.000001 0.000009 -0.000080 -0.000035 0.000009 -0.000072 -0.000060 0.000005 -0.000058 -0.000062 0.000008 -0.000038 -0.000034 0.000010 -0.000017 --0.000028 0.000010 -0.000011 --0.000091 0.000010 -0.000021 --0.000126 0.000007 -0.000036 --0.000129 0.000001 -0.000054 --0.000112 -0.000002 -0.000070 +-0.000041 0.000006 -0.000083 +-0.000001 0.000009 -0.000081 +0.000035 0.000009 -0.000074 +0.000060 0.000005 -0.000060 +0.000062 0.000008 -0.000040 +0.000034 0.000010 -0.000018 +-0.000027 0.000010 -0.000011 +-0.000091 0.000010 -0.000020 +-0.000125 0.000007 -0.000035 +-0.000129 0.000002 -0.000053 +-0.000112 -0.000002 -0.000069 -0.000081 -0.000005 -0.000079 --0.000042 -0.000005 -0.000082 --0.000001 -0.000005 -0.000080 -0.000034 -0.000002 -0.000072 -0.000057 0.000003 -0.000058 -0.000065 0.000019 -0.000036 -0.000037 0.000044 -0.000014 +-0.000042 -0.000005 -0.000083 +-0.000001 -0.000005 -0.000081 +0.000034 -0.000002 -0.000074 +0.000058 0.000003 -0.000061 +0.000065 0.000019 -0.000039 +0.000038 0.000044 -0.000015 -0.000026 0.000065 -0.000007 --0.000092 0.000064 -0.000017 --0.000128 0.000045 -0.000033 --0.000131 0.000024 -0.000052 +-0.000092 0.000064 -0.000016 +-0.000128 0.000045 -0.000031 +-0.000131 0.000024 -0.000051 -0.000110 0.000005 -0.000070 -0.000077 -0.000009 -0.000081 --0.000039 -0.000016 -0.000084 --0.000002 -0.000017 -0.000082 -0.000031 -0.000012 -0.000074 -0.000057 -0.000000 -0.000059 -0.000072 0.000029 -0.000028 -0.000050 0.000083 0.000000 +-0.000039 -0.000016 -0.000085 +-0.000002 -0.000017 -0.000083 +0.000031 -0.000012 -0.000076 +0.000057 -0.000000 -0.000062 +0.000072 0.000029 -0.000030 +0.000050 0.000083 -0.000000 -0.000017 0.000126 0.000006 -0.000095 0.000128 -0.000001 --0.000143 0.000091 -0.000016 --0.000142 0.000043 -0.000044 --0.000107 0.000004 -0.000072 +-0.000143 0.000091 -0.000015 +-0.000142 0.000043 -0.000043 +-0.000107 0.000004 -0.000071 -0.000068 -0.000016 -0.000085 --0.000034 -0.000024 -0.000089 --0.000004 -0.000027 -0.000086 -0.000025 -0.000025 -0.000078 -0.000055 -0.000009 -0.000060 -0.000068 0.000021 -0.000028 -0.000073 0.000122 0.000023 -0.000002 0.000201 0.000032 +-0.000034 -0.000024 -0.000090 +-0.000004 -0.000026 -0.000088 +0.000025 -0.000025 -0.000080 +0.000055 -0.000009 -0.000062 +0.000069 0.000021 -0.000029 +0.000073 0.000122 0.000022 +0.000003 0.000201 0.000032 -0.000109 0.000205 0.000027 --0.000168 0.000134 0.000011 --0.000142 0.000039 -0.000042 +-0.000168 0.000134 0.000012 +-0.000142 0.000039 -0.000041 -0.000089 -0.000012 -0.000082 -0.000051 -0.000026 -0.000094 --0.000027 -0.000029 -0.000095 --0.000008 -0.000033 -0.000093 -0.000011 -0.000038 -0.000086 -0.000035 -0.000029 -0.000070 --0.000009 -0.000032 -0.000082 -0.000024 0.000092 -0.000028 +-0.000027 -0.000029 -0.000096 +-0.000008 -0.000033 -0.000094 +0.000011 -0.000038 -0.000088 +0.000035 -0.000029 -0.000072 +-0.000009 -0.000031 -0.000083 +0.000024 0.000092 -0.000029 -0.000005 0.000255 0.000013 -0.000097 0.000260 0.000010 --0.000117 0.000103 -0.000037 +-0.000117 0.000103 -0.000036 -0.000066 -0.000015 -0.000093 -0.000033 -0.000036 -0.000112 -0.000023 -0.000029 -0.000108 --0.000018 -0.000027 -0.000103 --0.000014 -0.000032 -0.000101 --0.000016 -0.000043 -0.000100 --0.000022 -0.000054 -0.000101 --0.000160 -0.000071 -0.000177 +-0.000018 -0.000027 -0.000104 +-0.000014 -0.000032 -0.000102 +-0.000016 -0.000043 -0.000101 +-0.000021 -0.000054 -0.000102 +-0.000160 -0.000071 -0.000178 -0.000185 0.000003 -0.000238 -0.000115 0.000181 -0.000254 0.000012 0.000185 -0.000256 -0.000093 0.000011 -0.000246 -0.000084 -0.000060 -0.000186 -0.000040 -0.000038 -0.000134 +0.000093 0.000011 -0.000245 +0.000084 -0.000061 -0.000186 +0.000041 -0.000038 -0.000134 0.000011 -0.000017 -0.000114 -0.000006 -0.000013 -0.000106 --0.000023 -0.000019 -0.000103 --0.000051 -0.000030 -0.000107 --0.000098 -0.000052 -0.000126 --0.000241 -0.000011 -0.000222 +-0.000023 -0.000019 -0.000104 +-0.000051 -0.000030 -0.000108 +-0.000098 -0.000052 -0.000127 +-0.000241 -0.000011 -0.000223 -0.000338 -0.000016 -0.000389 -0.000213 -0.000017 -0.000504 0.000101 -0.000019 -0.000506 @@ -112,144 +112,144 @@ LOOKUP_TABLE default 0.000163 -0.000007 -0.000230 0.000071 0.000003 -0.000134 0.000026 0.000008 -0.000110 --0.000000 0.000009 -0.000103 --0.000028 0.000007 -0.000100 --0.000068 0.000002 -0.000104 --0.000132 -0.000003 -0.000128 --0.000160 0.000057 -0.000176 --0.000194 -0.000024 -0.000244 +-0.000000 0.000010 -0.000103 +-0.000027 0.000007 -0.000101 +-0.000068 0.000002 -0.000105 +-0.000132 -0.000003 -0.000129 +-0.000160 0.000057 -0.000177 +-0.000193 -0.000024 -0.000244 -0.000125 -0.000208 -0.000265 0.000011 -0.000218 -0.000265 0.000092 -0.000036 -0.000246 -0.000076 0.000051 -0.000181 +0.000076 0.000051 -0.000180 0.000030 0.000043 -0.000128 0.000004 0.000030 -0.000110 -0.000007 0.000028 -0.000103 --0.000022 0.000030 -0.000100 --0.000049 0.000034 -0.000104 --0.000095 0.000047 -0.000123 --0.000006 0.000029 -0.000081 -0.000027 -0.000096 -0.000026 +-0.000022 0.000030 -0.000101 +-0.000049 0.000034 -0.000105 +-0.000095 0.000047 -0.000124 +-0.000006 0.000029 -0.000082 +0.000027 -0.000096 -0.000027 -0.000003 -0.000273 0.000026 -0.000103 -0.000284 0.000026 -0.000130 -0.000116 -0.000024 -0.000081 0.000013 -0.000082 -0.000048 0.000040 -0.000103 --0.000033 0.000036 -0.000102 --0.000021 0.000035 -0.000099 --0.000012 0.000040 -0.000096 --0.000012 0.000048 -0.000096 --0.000017 0.000054 -0.000098 -0.000074 -0.000019 -0.000025 +-0.000033 0.000036 -0.000103 +-0.000021 0.000035 -0.000100 +-0.000012 0.000040 -0.000097 +-0.000011 0.000048 -0.000097 +-0.000017 0.000054 -0.000099 +0.000074 -0.000019 -0.000026 0.000081 -0.000121 0.000027 0.000008 -0.000203 0.000039 -0.000113 -0.000211 0.000037 -0.000181 -0.000141 0.000025 --0.000159 -0.000042 -0.000030 --0.000103 0.000010 -0.000074 +-0.000159 -0.000042 -0.000029 +-0.000103 0.000010 -0.000073 -0.000061 0.000025 -0.000088 --0.000031 0.000029 -0.000090 --0.000006 0.000034 -0.000088 -0.000016 0.000039 -0.000081 -0.000041 0.000031 -0.000066 -0.000078 -0.000027 -0.000044 -0.000060 -0.000102 -0.000022 --0.000008 -0.000185 -0.000017 --0.000103 -0.000195 -0.000028 --0.000159 -0.000128 -0.000053 --0.000152 -0.000060 -0.000083 +-0.000031 0.000029 -0.000091 +-0.000006 0.000034 -0.000089 +0.000017 0.000039 -0.000083 +0.000041 0.000031 -0.000067 +0.000078 -0.000027 -0.000046 +0.000060 -0.000102 -0.000023 +-0.000008 -0.000185 -0.000016 +-0.000103 -0.000195 -0.000027 +-0.000160 -0.000128 -0.000052 +-0.000153 -0.000060 -0.000082 -0.000116 -0.000019 -0.000102 --0.000075 0.000003 -0.000108 --0.000039 0.000012 -0.000108 --0.000006 0.000016 -0.000104 -0.000030 0.000017 -0.000093 -0.000063 0.000008 -0.000071 -0.000071 -0.000008 -0.000045 -0.000045 -0.000037 -0.000017 +-0.000076 0.000003 -0.000109 +-0.000040 0.000012 -0.000109 +-0.000007 0.000015 -0.000106 +0.000029 0.000017 -0.000095 +0.000063 0.000008 -0.000073 +0.000070 -0.000008 -0.000047 +0.000045 -0.000037 -0.000018 -0.000019 -0.000075 -0.000013 --0.000095 -0.000080 -0.000035 --0.000138 -0.000054 -0.000066 --0.000137 -0.000032 -0.000091 --0.000114 -0.000017 -0.000105 --0.000081 -0.000005 -0.000111 --0.000044 0.000002 -0.000111 --0.000006 0.000005 -0.000106 -0.000033 0.000005 -0.000095 -0.000063 0.000002 -0.000075 -0.000069 0.000011 -0.000046 -0.000043 0.000014 -0.000012 --0.000024 0.000014 -0.000008 --0.000097 0.000013 -0.000038 --0.000131 0.000008 -0.000071 --0.000128 0.000002 -0.000093 --0.000109 -0.000003 -0.000107 --0.000080 -0.000005 -0.000113 --0.000045 -0.000006 -0.000113 --0.000007 -0.000005 -0.000108 -0.000031 -0.000002 -0.000096 -0.000060 0.000005 -0.000077 -0.000072 0.000026 -0.000045 -0.000047 0.000064 -0.000010 --0.000022 0.000102 -0.000006 --0.000098 0.000102 -0.000036 --0.000134 0.000066 -0.000069 --0.000130 0.000034 -0.000093 --0.000108 0.000011 -0.000107 --0.000077 -0.000005 -0.000113 --0.000043 -0.000013 -0.000113 --0.000008 -0.000014 -0.000108 -0.000029 -0.000009 -0.000097 -0.000060 0.000004 -0.000077 -0.000075 0.000040 -0.000042 -0.000058 0.000121 -0.000009 +-0.000095 -0.000080 -0.000034 +-0.000138 -0.000054 -0.000065 +-0.000138 -0.000032 -0.000090 +-0.000115 -0.000016 -0.000105 +-0.000082 -0.000005 -0.000111 +-0.000045 0.000002 -0.000112 +-0.000006 0.000005 -0.000108 +0.000032 0.000005 -0.000098 +0.000063 0.000002 -0.000078 +0.000068 0.000011 -0.000048 +0.000043 0.000014 -0.000013 +-0.000024 0.000014 -0.000007 +-0.000097 0.000013 -0.000036 +-0.000131 0.000008 -0.000069 +-0.000129 0.000002 -0.000092 +-0.000110 -0.000003 -0.000106 +-0.000081 -0.000005 -0.000113 +-0.000046 -0.000006 -0.000114 +-0.000008 -0.000005 -0.000110 +0.000030 -0.000002 -0.000099 +0.000059 0.000005 -0.000079 +0.000071 0.000027 -0.000048 +0.000047 0.000064 -0.000012 +-0.000022 0.000102 -0.000005 +-0.000099 0.000102 -0.000034 +-0.000134 0.000066 -0.000067 +-0.000131 0.000034 -0.000092 +-0.000109 0.000011 -0.000107 +-0.000078 -0.000005 -0.000113 +-0.000044 -0.000013 -0.000114 +-0.000009 -0.000014 -0.000110 +0.000028 -0.000008 -0.000099 +0.000059 0.000004 -0.000080 +0.000075 0.000040 -0.000044 +0.000058 0.000122 -0.000010 -0.000011 0.000205 -0.000004 --0.000102 0.000207 -0.000027 --0.000149 0.000134 -0.000059 --0.000139 0.000061 -0.000089 --0.000104 0.000015 -0.000106 --0.000068 -0.000009 -0.000112 --0.000037 -0.000018 -0.000113 --0.000009 -0.000021 -0.000108 -0.000023 -0.000018 -0.000097 -0.000056 -0.000002 -0.000076 -0.000071 0.000039 -0.000041 -0.000085 0.000194 -0.000004 +-0.000103 0.000207 -0.000025 +-0.000150 0.000134 -0.000058 +-0.000140 0.000061 -0.000088 +-0.000105 0.000015 -0.000106 +-0.000068 -0.000009 -0.000113 +-0.000038 -0.000018 -0.000114 +-0.000010 -0.000021 -0.000110 +0.000022 -0.000018 -0.000099 +0.000056 -0.000002 -0.000079 +0.000071 0.000039 -0.000042 +0.000085 0.000194 -0.000005 0.000014 0.000359 0.000006 --0.000122 0.000364 -0.000006 --0.000180 0.000212 -0.000036 --0.000138 0.000067 -0.000081 --0.000084 0.000004 -0.000107 --0.000050 -0.000017 -0.000113 --0.000030 -0.000022 -0.000112 --0.000011 -0.000026 -0.000108 -0.000010 -0.000031 -0.000097 -0.000038 -0.000021 -0.000076 -0.000015 0.000009 -0.000060 -0.000071 0.000251 -0.000024 +-0.000123 0.000364 -0.000006 +-0.000180 0.000212 -0.000035 +-0.000139 0.000066 -0.000080 +-0.000085 0.000003 -0.000107 +-0.000051 -0.000017 -0.000113 +-0.000030 -0.000022 -0.000113 +-0.000012 -0.000025 -0.000109 +0.000009 -0.000030 -0.000099 +0.000038 -0.000021 -0.000077 +0.000015 0.000009 -0.000061 +0.000071 0.000251 -0.000025 0.000028 0.000594 0.000004 -0.000128 0.000599 -0.000002 --0.000163 0.000265 -0.000042 --0.000086 0.000033 -0.000087 --0.000039 -0.000021 -0.000111 --0.000024 -0.000025 -0.000114 --0.000020 -0.000023 -0.000112 --0.000015 -0.000028 -0.000106 --0.000011 -0.000042 -0.000096 --0.000008 -0.000047 -0.000082 --0.000158 -0.000031 -0.000109 --0.000193 0.000181 -0.000139 +-0.000164 0.000265 -0.000042 +-0.000087 0.000032 -0.000087 +-0.000040 -0.000021 -0.000110 +-0.000025 -0.000025 -0.000114 +-0.000021 -0.000023 -0.000112 +-0.000016 -0.000028 -0.000108 +-0.000011 -0.000041 -0.000098 +-0.000008 -0.000047 -0.000083 +-0.000158 -0.000031 -0.000110 +-0.000193 0.000181 -0.000140 -0.000125 0.000584 -0.000155 -0.000026 0.000587 -0.000160 +0.000027 0.000587 -0.000160 0.000106 0.000188 -0.000153 0.000084 -0.000017 -0.000127 0.000045 -0.000035 -0.000113 0.000016 -0.000022 -0.000110 --0.000005 -0.000017 -0.000107 --0.000025 -0.000023 -0.000101 --0.000052 -0.000038 -0.000094 +-0.000006 -0.000017 -0.000107 +-0.000025 -0.000023 -0.000102 +-0.000052 -0.000038 -0.000095 -0.000097 -0.000053 -0.000093 -0.000289 -0.000013 -0.000142 --0.000449 -0.000012 -0.000234 +-0.000449 -0.000012 -0.000235 -0.000296 -0.000003 -0.000315 0.000178 -0.000012 -0.000320 0.000356 -0.000020 -0.000246 @@ -258,20 +258,20 @@ LOOKUP_TABLE default 0.000040 0.000009 -0.000104 0.000003 0.000010 -0.000101 -0.000033 0.000007 -0.000096 --0.000081 0.000001 -0.000091 +-0.000081 0.000001 -0.000092 -0.000157 -0.000005 -0.000097 --0.000165 0.000014 -0.000113 --0.000218 -0.000197 -0.000148 +-0.000165 0.000014 -0.000114 +-0.000218 -0.000197 -0.000149 -0.000150 -0.000606 -0.000166 0.000025 -0.000630 -0.000169 0.000109 -0.000223 -0.000156 0.000078 0.000004 -0.000125 0.000035 0.000040 -0.000108 0.000008 0.000036 -0.000105 --0.000008 0.000034 -0.000102 --0.000025 0.000036 -0.000097 --0.000053 0.000042 -0.000092 --0.000099 0.000046 -0.000094 +-0.000008 0.000034 -0.000103 +-0.000025 0.000036 -0.000098 +-0.000053 0.000042 -0.000093 +-0.000099 0.000046 -0.000095 0.000017 -0.000014 -0.000066 0.000073 -0.000259 -0.000031 0.000028 -0.000623 0.000003 @@ -280,404 +280,404 @@ LOOKUP_TABLE default -0.000108 -0.000037 -0.000079 -0.000059 0.000025 -0.000102 -0.000037 0.000032 -0.000108 --0.000024 0.000032 -0.000106 --0.000012 0.000038 -0.000100 --0.000006 0.000048 -0.000092 --0.000004 0.000046 -0.000083 -0.000075 -0.000035 -0.000046 -0.000091 -0.000190 -0.000014 -0.000018 -0.000361 -0.000002 --0.000127 -0.000374 -0.000008 --0.000196 -0.000219 -0.000029 --0.000159 -0.000067 -0.000071 --0.000101 -0.000005 -0.000100 +-0.000024 0.000032 -0.000107 +-0.000012 0.000038 -0.000101 +-0.000006 0.000047 -0.000093 +-0.000004 0.000046 -0.000084 +0.000076 -0.000035 -0.000047 +0.000091 -0.000190 -0.000015 +0.000019 -0.000361 -0.000002 +-0.000127 -0.000374 -0.000007 +-0.000196 -0.000219 -0.000028 +-0.000159 -0.000067 -0.000070 +-0.000102 -0.000005 -0.000099 -0.000061 0.000016 -0.000108 --0.000033 0.000021 -0.000107 --0.000008 0.000026 -0.000102 -0.000018 0.000034 -0.000090 -0.000046 0.000025 -0.000072 -0.000090 -0.000011 -0.000063 -0.000067 -0.000080 -0.000056 --0.000012 -0.000164 -0.000065 --0.000114 -0.000179 -0.000086 --0.000163 -0.000127 -0.000118 --0.000144 -0.000072 -0.000138 --0.000105 -0.000033 -0.000139 --0.000071 -0.000007 -0.000133 --0.000044 0.000002 -0.000130 --0.000018 0.000003 -0.000129 -0.000020 0.000006 -0.000118 -0.000066 0.000008 -0.000091 -0.000077 0.000003 -0.000058 -0.000052 -0.000017 -0.000022 +-0.000034 0.000021 -0.000108 +-0.000008 0.000026 -0.000103 +0.000018 0.000033 -0.000091 +0.000045 0.000025 -0.000073 +0.000090 -0.000012 -0.000064 +0.000067 -0.000080 -0.000057 +-0.000012 -0.000163 -0.000065 +-0.000114 -0.000178 -0.000085 +-0.000164 -0.000126 -0.000117 +-0.000145 -0.000071 -0.000137 +-0.000106 -0.000032 -0.000138 +-0.000072 -0.000007 -0.000133 +-0.000045 0.000001 -0.000131 +-0.000019 0.000002 -0.000130 +0.000019 0.000005 -0.000121 +0.000065 0.000007 -0.000093 +0.000076 0.000002 -0.000060 +0.000052 -0.000018 -0.000023 -0.000022 -0.000055 -0.000027 --0.000101 -0.000069 -0.000072 --0.000131 -0.000057 -0.000122 --0.000121 -0.000042 -0.000145 --0.000101 -0.000026 -0.000145 --0.000076 -0.000012 -0.000140 --0.000050 -0.000005 -0.000137 --0.000020 -0.000004 -0.000135 -0.000016 -0.000004 -0.000128 -0.000056 -0.000000 -0.000103 -0.000067 0.000014 -0.000059 -0.000047 0.000022 -0.000009 --0.000023 0.000022 -0.000012 --0.000094 0.000016 -0.000072 --0.000117 0.000007 -0.000125 --0.000109 -0.000001 -0.000144 --0.000093 -0.000005 -0.000147 --0.000075 -0.000008 -0.000143 --0.000052 -0.000009 -0.000140 --0.000023 -0.000008 -0.000137 -0.000011 -0.000004 -0.000129 -0.000046 0.000003 -0.000106 -0.000070 0.000024 -0.000059 -0.000051 0.000057 -0.000009 --0.000022 0.000095 -0.000013 --0.000095 0.000100 -0.000073 --0.000120 0.000069 -0.000126 --0.000111 0.000037 -0.000144 --0.000092 0.000014 -0.000146 --0.000071 -0.000002 -0.000142 --0.000050 -0.000011 -0.000139 --0.000025 -0.000011 -0.000136 -0.000008 -0.000006 -0.000128 -0.000046 0.000006 -0.000105 -0.000081 0.000030 -0.000058 -0.000066 0.000103 -0.000027 --0.000014 0.000187 -0.000033 --0.000108 0.000198 -0.000078 --0.000143 0.000138 -0.000126 --0.000123 0.000072 -0.000144 --0.000090 0.000025 -0.000141 --0.000063 -0.000002 -0.000136 --0.000043 -0.000011 -0.000133 --0.000024 -0.000012 -0.000132 -0.000006 -0.000009 -0.000125 -0.000049 0.000001 -0.000100 -0.000083 0.000024 -0.000063 -0.000093 0.000174 -0.000071 -0.000010 0.000341 -0.000084 --0.000133 0.000350 -0.000104 --0.000184 0.000213 -0.000131 --0.000130 0.000079 -0.000136 --0.000074 0.000017 -0.000131 --0.000046 -0.000007 -0.000126 --0.000034 -0.000012 -0.000124 --0.000023 -0.000013 -0.000123 -0.000000 -0.000019 -0.000112 -0.000041 -0.000021 -0.000084 -0.000024 -0.000003 -0.000062 -0.000075 0.000237 -0.000088 +-0.000101 -0.000068 -0.000071 +-0.000132 -0.000056 -0.000120 +-0.000123 -0.000041 -0.000143 +-0.000102 -0.000025 -0.000144 +-0.000078 -0.000012 -0.000140 +-0.000051 -0.000005 -0.000138 +-0.000022 -0.000004 -0.000137 +0.000015 -0.000005 -0.000131 +0.000054 -0.000002 -0.000106 +0.000066 0.000014 -0.000063 +0.000046 0.000021 -0.000010 +-0.000024 0.000022 -0.000010 +-0.000095 0.000016 -0.000069 +-0.000119 0.000007 -0.000123 +-0.000110 -0.000001 -0.000143 +-0.000095 -0.000005 -0.000146 +-0.000076 -0.000008 -0.000143 +-0.000054 -0.000009 -0.000141 +-0.000025 -0.000008 -0.000139 +0.000009 -0.000005 -0.000132 +0.000044 0.000003 -0.000110 +0.000068 0.000024 -0.000063 +0.000050 0.000057 -0.000011 +-0.000022 0.000095 -0.000012 +-0.000096 0.000099 -0.000071 +-0.000122 0.000068 -0.000123 +-0.000113 0.000037 -0.000142 +-0.000094 0.000014 -0.000145 +-0.000073 -0.000002 -0.000142 +-0.000051 -0.000011 -0.000140 +-0.000027 -0.000011 -0.000138 +0.000006 -0.000005 -0.000131 +0.000044 0.000006 -0.000109 +0.000080 0.000031 -0.000061 +0.000066 0.000103 -0.000028 +-0.000015 0.000186 -0.000033 +-0.000109 0.000197 -0.000077 +-0.000144 0.000137 -0.000125 +-0.000125 0.000071 -0.000143 +-0.000092 0.000024 -0.000141 +-0.000064 -0.000002 -0.000137 +-0.000045 -0.000011 -0.000134 +-0.000026 -0.000012 -0.000134 +0.000004 -0.000008 -0.000127 +0.000047 0.000002 -0.000103 +0.000082 0.000024 -0.000065 +0.000093 0.000174 -0.000072 +0.000010 0.000340 -0.000084 +-0.000134 0.000349 -0.000103 +-0.000185 0.000212 -0.000129 +-0.000131 0.000079 -0.000135 +-0.000075 0.000017 -0.000130 +-0.000047 -0.000007 -0.000126 +-0.000036 -0.000011 -0.000125 +-0.000024 -0.000012 -0.000124 +-0.000001 -0.000018 -0.000114 +0.000040 -0.000020 -0.000086 +0.000024 -0.000003 -0.000063 +0.000075 0.000237 -0.000089 0.000026 0.000582 -0.000121 --0.000135 0.000589 -0.000128 --0.000170 0.000263 -0.000115 --0.000085 0.000041 -0.000107 --0.000033 -0.000009 -0.000109 --0.000022 -0.000015 -0.000111 --0.000023 -0.000014 -0.000111 --0.000022 -0.000018 -0.000107 --0.000014 -0.000034 -0.000092 --0.000002 -0.000050 -0.000068 --0.000154 -0.000037 -0.000030 --0.000192 0.000174 0.000007 +-0.000135 0.000588 -0.000128 +-0.000170 0.000262 -0.000115 +-0.000085 0.000040 -0.000106 +-0.000034 -0.000010 -0.000109 +-0.000023 -0.000015 -0.000111 +-0.000024 -0.000014 -0.000111 +-0.000023 -0.000017 -0.000108 +-0.000015 -0.000033 -0.000093 +-0.000003 -0.000049 -0.000069 +-0.000154 -0.000037 -0.000031 +-0.000192 0.000174 0.000006 -0.000125 0.000578 0.000019 -0.000023 0.000583 0.000013 +0.000023 0.000583 0.000014 0.000103 0.000186 -0.000007 -0.000085 -0.000013 -0.000054 -0.000048 -0.000028 -0.000088 -0.000017 -0.000016 -0.000099 --0.000007 -0.000012 -0.000101 +0.000084 -0.000013 -0.000054 +0.000047 -0.000028 -0.000088 +0.000017 -0.000016 -0.000100 +-0.000008 -0.000011 -0.000101 -0.000029 -0.000017 -0.000096 --0.000053 -0.000034 -0.000082 --0.000094 -0.000055 -0.000061 --0.000288 -0.000014 -0.000005 +-0.000053 -0.000033 -0.000083 +-0.000094 -0.000055 -0.000062 +-0.000288 -0.000014 -0.000006 -0.000448 -0.000013 0.000095 -0.000296 -0.000000 0.000177 0.000176 -0.000009 0.000173 0.000354 -0.000019 0.000085 0.000211 -0.000008 -0.000022 0.000099 0.000004 -0.000081 -0.000041 0.000010 -0.000095 -0.000002 0.000012 -0.000097 --0.000035 0.000009 -0.000092 +0.000041 0.000010 -0.000096 +0.000001 0.000012 -0.000097 +-0.000035 0.000009 -0.000093 -0.000082 0.000003 -0.000082 -0.000156 -0.000006 -0.000062 -0.000164 0.000017 -0.000035 --0.000218 -0.000191 0.000009 +-0.000218 -0.000191 0.000008 -0.000151 -0.000595 0.000030 -0.000024 -0.000620 0.000024 +0.000024 -0.000619 0.000024 0.000108 -0.000219 -0.000005 0.000078 0.000004 -0.000053 0.000036 0.000038 -0.000085 0.000009 0.000035 -0.000095 -0.000009 0.000032 -0.000096 --0.000027 0.000035 -0.000091 --0.000053 0.000041 -0.000081 --0.000098 0.000047 -0.000065 -0.000020 -0.000007 -0.000076 +-0.000027 0.000034 -0.000092 +-0.000053 0.000041 -0.000082 +-0.000098 0.000047 -0.000066 +0.000020 -0.000008 -0.000077 0.000073 -0.000249 -0.000104 0.000026 -0.000609 -0.000138 -0.000142 -0.000631 -0.000146 --0.000187 -0.000287 -0.000124 --0.000108 -0.000041 -0.000105 +-0.000187 -0.000286 -0.000124 +-0.000108 -0.000040 -0.000104 -0.000056 0.000019 -0.000101 -0.000036 0.000026 -0.000104 --0.000026 0.000027 -0.000103 --0.000016 0.000032 -0.000098 --0.000007 0.000044 -0.000086 --0.000001 0.000048 -0.000073 -0.000084 -0.000022 -0.000079 +-0.000026 0.000027 -0.000104 +-0.000016 0.000032 -0.000099 +-0.000007 0.000043 -0.000087 +-0.000002 0.000048 -0.000073 +0.000084 -0.000023 -0.000080 0.000094 -0.000174 -0.000102 0.000016 -0.000345 -0.000116 --0.000135 -0.000360 -0.000124 --0.000202 -0.000215 -0.000132 --0.000157 -0.000075 -0.000127 --0.000095 -0.000016 -0.000123 --0.000058 0.000006 -0.000120 --0.000036 0.000012 -0.000118 --0.000015 0.000015 -0.000114 -0.000015 0.000026 -0.000100 -0.000051 0.000028 -0.000080 -0.000098 0.000020 -0.000088 -0.000073 0.000008 -0.000072 --0.000025 -0.000035 -0.000080 --0.000117 -0.000075 -0.000120 --0.000144 -0.000098 -0.000176 --0.000119 -0.000085 -0.000191 --0.000086 -0.000045 -0.000167 --0.000065 -0.000017 -0.000146 --0.000050 -0.000009 -0.000140 --0.000035 -0.000012 -0.000143 --0.000006 -0.000015 -0.000144 -0.000051 -0.000000 -0.000122 -0.000064 0.000022 -0.000075 -0.000053 0.000059 0.000002 --0.000028 0.000042 -0.000001 --0.000088 -0.000015 -0.000095 --0.000089 -0.000060 -0.000184 --0.000076 -0.000062 -0.000201 --0.000072 -0.000039 -0.000178 --0.000067 -0.000022 -0.000159 --0.000058 -0.000016 -0.000153 --0.000046 -0.000019 -0.000157 --0.000027 -0.000027 -0.000165 -0.000015 -0.000019 -0.000147 -0.000024 0.000015 -0.000080 -0.000030 0.000048 0.000026 --0.000013 0.000051 0.000027 --0.000049 0.000020 -0.000096 --0.000054 -0.000007 -0.000188 --0.000055 -0.000014 -0.000197 --0.000061 -0.000013 -0.000179 --0.000064 -0.000013 -0.000163 --0.000062 -0.000014 -0.000157 --0.000054 -0.000014 -0.000160 --0.000040 -0.000015 -0.000166 --0.000013 -0.000009 -0.000152 -0.000026 0.000012 -0.000081 -0.000033 0.000007 0.000023 --0.000011 0.000026 0.000024 --0.000050 0.000056 -0.000099 --0.000057 0.000060 -0.000191 --0.000057 0.000040 -0.000197 --0.000060 0.000016 -0.000177 --0.000061 -0.000000 -0.000160 --0.000059 -0.000008 -0.000154 --0.000055 -0.000007 -0.000157 --0.000043 0.000002 -0.000163 --0.000014 0.000013 -0.000151 -0.000072 0.000003 -0.000081 -0.000067 0.000001 -0.000010 --0.000022 0.000042 -0.000013 --0.000095 0.000097 -0.000106 --0.000102 0.000117 -0.000195 --0.000081 0.000084 -0.000204 --0.000064 0.000034 -0.000172 --0.000054 0.000006 -0.000151 --0.000051 -0.000002 -0.000145 --0.000050 0.000001 -0.000149 --0.000037 0.000012 -0.000158 -0.000010 0.000015 -0.000143 -0.000093 -0.000018 -0.000084 -0.000094 0.000046 -0.000092 +-0.000135 -0.000359 -0.000124 +-0.000202 -0.000214 -0.000132 +-0.000157 -0.000074 -0.000127 +-0.000096 -0.000016 -0.000123 +-0.000059 0.000006 -0.000120 +-0.000037 0.000011 -0.000119 +-0.000015 0.000015 -0.000115 +0.000014 0.000025 -0.000102 +0.000051 0.000027 -0.000082 +0.000097 0.000018 -0.000089 +0.000072 0.000008 -0.000073 +-0.000025 -0.000034 -0.000080 +-0.000117 -0.000074 -0.000119 +-0.000145 -0.000097 -0.000175 +-0.000121 -0.000083 -0.000190 +-0.000088 -0.000044 -0.000166 +-0.000066 -0.000017 -0.000147 +-0.000051 -0.000009 -0.000140 +-0.000037 -0.000013 -0.000144 +-0.000008 -0.000016 -0.000146 +0.000049 -0.000002 -0.000125 +0.000062 0.000020 -0.000079 +0.000052 0.000059 0.000001 +-0.000029 0.000043 -0.000000 +-0.000090 -0.000013 -0.000092 +-0.000091 -0.000058 -0.000181 +-0.000078 -0.000061 -0.000199 +-0.000073 -0.000039 -0.000177 +-0.000068 -0.000022 -0.000159 +-0.000059 -0.000016 -0.000154 +-0.000049 -0.000020 -0.000159 +-0.000030 -0.000029 -0.000168 +0.000012 -0.000021 -0.000151 +0.000020 0.000014 -0.000086 +0.000027 0.000048 0.000023 +-0.000015 0.000052 0.000029 +-0.000052 0.000021 -0.000092 +-0.000057 -0.000006 -0.000185 +-0.000058 -0.000013 -0.000195 +-0.000063 -0.000013 -0.000178 +-0.000066 -0.000013 -0.000163 +-0.000064 -0.000014 -0.000158 +-0.000056 -0.000015 -0.000162 +-0.000044 -0.000016 -0.000169 +-0.000017 -0.000010 -0.000158 +0.000022 0.000013 -0.000087 +0.000031 0.000007 0.000021 +-0.000013 0.000025 0.000026 +-0.000053 0.000055 -0.000095 +-0.000060 0.000059 -0.000187 +-0.000060 0.000039 -0.000195 +-0.000062 0.000015 -0.000176 +-0.000062 -0.000000 -0.000160 +-0.000061 -0.000007 -0.000155 +-0.000058 -0.000007 -0.000159 +-0.000047 0.000002 -0.000166 +-0.000018 0.000014 -0.000156 +0.000069 0.000004 -0.000085 +0.000066 0.000001 -0.000012 +-0.000023 0.000041 -0.000012 +-0.000097 0.000096 -0.000103 +-0.000104 0.000115 -0.000192 +-0.000084 0.000083 -0.000202 +-0.000066 0.000034 -0.000171 +-0.000056 0.000006 -0.000151 +-0.000053 -0.000002 -0.000145 +-0.000052 0.000002 -0.000151 +-0.000040 0.000013 -0.000161 +0.000006 0.000018 -0.000147 +0.000092 -0.000017 -0.000086 +0.000094 0.000047 -0.000093 -0.000009 0.000126 -0.000103 --0.000132 0.000164 -0.000141 --0.000163 0.000147 -0.000192 --0.000109 0.000081 -0.000183 --0.000058 0.000026 -0.000148 --0.000041 0.000002 -0.000130 --0.000040 -0.000002 -0.000127 --0.000041 0.000002 -0.000130 --0.000025 0.000001 -0.000129 -0.000027 -0.000015 -0.000107 -0.000009 -0.000062 -0.000048 -0.000035 0.000046 -0.000091 --0.000010 0.000212 -0.000137 --0.000113 0.000232 -0.000147 --0.000126 0.000105 -0.000129 --0.000056 0.000010 -0.000103 +-0.000133 0.000163 -0.000140 +-0.000165 0.000146 -0.000191 +-0.000111 0.000080 -0.000182 +-0.000059 0.000025 -0.000148 +-0.000042 0.000002 -0.000131 +-0.000042 -0.000001 -0.000127 +-0.000042 0.000002 -0.000131 +-0.000027 0.000002 -0.000131 +0.000025 -0.000014 -0.000109 +0.000008 -0.000061 -0.000049 +0.000034 0.000046 -0.000092 +-0.000010 0.000211 -0.000137 +-0.000113 0.000231 -0.000147 +-0.000126 0.000104 -0.000129 +-0.000057 0.000009 -0.000103 -0.000018 -0.000008 -0.000097 --0.000017 -0.000006 -0.000101 --0.000026 -0.000004 -0.000104 --0.000032 -0.000005 -0.000103 --0.000029 -0.000019 -0.000090 --0.000016 -0.000053 -0.000060 --0.000152 -0.000086 0.000031 +-0.000018 -0.000006 -0.000101 +-0.000027 -0.000004 -0.000104 +-0.000033 -0.000005 -0.000103 +-0.000030 -0.000018 -0.000091 +-0.000016 -0.000052 -0.000061 +-0.000152 -0.000086 0.000030 -0.000181 -0.000019 0.000096 -0.000117 0.000161 0.000108 0.000005 0.000173 0.000102 -0.000086 0.000011 0.000079 -0.000086 -0.000049 0.000005 +0.000086 0.000010 0.000079 +0.000085 -0.000049 0.000005 0.000046 -0.000023 -0.000058 0.000013 -0.000003 -0.000083 --0.000011 -0.000000 -0.000089 +-0.000011 0.000000 -0.000089 -0.000032 -0.000004 -0.000086 --0.000055 -0.000019 -0.000070 --0.000093 -0.000053 -0.000034 --0.000236 -0.000015 0.000069 --0.000335 -0.000021 0.000240 --0.000214 -0.000019 0.000354 +-0.000055 -0.000018 -0.000070 +-0.000093 -0.000053 -0.000035 +-0.000236 -0.000015 0.000068 +-0.000335 -0.000021 0.000239 +-0.000214 -0.000019 0.000353 0.000096 -0.000018 0.000350 0.000238 -0.000015 0.000230 0.000162 -0.000003 0.000053 0.000073 0.000007 -0.000052 -0.000027 0.000013 -0.000080 +0.000026 0.000013 -0.000080 -0.000004 0.000014 -0.000086 -0.000033 0.000011 -0.000082 --0.000069 0.000006 -0.000068 --0.000128 -0.000003 -0.000034 --0.000156 0.000062 0.000023 +-0.000070 0.000006 -0.000069 +-0.000128 -0.000003 -0.000035 +-0.000156 0.000062 0.000022 -0.000193 -0.000013 0.000096 -0.000127 -0.000192 0.000119 -0.000007 -0.000204 0.000113 -0.000089 -0.000032 0.000081 +0.000008 -0.000204 0.000113 +0.000088 -0.000032 0.000081 0.000076 0.000049 0.000003 -0.000034 0.000039 -0.000058 -0.000006 0.000026 -0.000081 --0.000011 0.000024 -0.000086 --0.000027 0.000026 -0.000082 --0.000050 0.000031 -0.000069 --0.000092 0.000048 -0.000039 --0.000000 0.000046 -0.000066 -0.000027 -0.000069 -0.000114 --0.000006 -0.000242 -0.000166 +0.000033 0.000039 -0.000058 +0.000005 0.000026 -0.000081 +-0.000011 0.000024 -0.000087 +-0.000027 0.000026 -0.000083 +-0.000051 0.000031 -0.000069 +-0.000092 0.000047 -0.000040 +-0.000000 0.000046 -0.000067 +0.000027 -0.000069 -0.000115 +-0.000006 -0.000241 -0.000166 -0.000108 -0.000260 -0.000174 --0.000134 -0.000111 -0.000141 --0.000078 0.000002 -0.000101 +-0.000134 -0.000110 -0.000141 +-0.000078 0.000003 -0.000101 -0.000041 0.000025 -0.000091 -0.000031 0.000022 -0.000096 -0.000026 0.000022 -0.000098 --0.000021 0.000026 -0.000094 +-0.000021 0.000025 -0.000094 -0.000016 0.000037 -0.000082 --0.000013 0.000056 -0.000064 -0.000091 0.000013 -0.000108 -0.000089 -0.000071 -0.000148 -0.000001 -0.000153 -0.000162 --0.000127 -0.000176 -0.000174 +-0.000013 0.000055 -0.000064 +0.000091 0.000012 -0.000109 +0.000089 -0.000071 -0.000149 +0.000001 -0.000152 -0.000163 +-0.000127 -0.000175 -0.000174 -0.000187 -0.000138 -0.000193 -0.000148 -0.000066 -0.000169 --0.000087 -0.000018 -0.000138 --0.000055 0.000002 -0.000124 --0.000039 0.000006 -0.000119 --0.000024 0.000007 -0.000118 -0.000003 0.000016 -0.000111 -0.000047 0.000030 -0.000097 -0.000062 0.000044 -0.000117 -0.000048 0.000115 -0.000076 +-0.000088 -0.000018 -0.000138 +-0.000056 0.000002 -0.000124 +-0.000040 0.000006 -0.000120 +-0.000024 0.000007 -0.000119 +0.000002 0.000015 -0.000112 +0.000046 0.000029 -0.000098 +0.000060 0.000042 -0.000119 +0.000047 0.000115 -0.000077 -0.000033 0.000107 -0.000075 --0.000084 0.000014 -0.000131 --0.000084 -0.000070 -0.000193 --0.000075 -0.000081 -0.000201 --0.000066 -0.000047 -0.000168 --0.000058 -0.000022 -0.000142 +-0.000085 0.000014 -0.000131 +-0.000085 -0.000069 -0.000193 +-0.000076 -0.000080 -0.000201 +-0.000067 -0.000046 -0.000168 +-0.000058 -0.000022 -0.000143 -0.000054 -0.000016 -0.000134 --0.000051 -0.000021 -0.000137 --0.000037 -0.000029 -0.000147 -0.000008 -0.000016 -0.000147 --0.000031 0.000030 -0.000108 -0.000006 0.000166 0.000025 --0.000003 0.000172 0.000032 -0.000003 0.000027 -0.000113 -0.000022 -0.000082 -0.000223 -0.000002 -0.000084 -0.000222 --0.000034 -0.000052 -0.000184 --0.000054 -0.000032 -0.000159 --0.000066 -0.000026 -0.000151 --0.000079 -0.000033 -0.000157 --0.000093 -0.000053 -0.000180 --0.000083 -0.000056 -0.000187 --0.000171 0.000012 -0.000117 --0.000075 0.000095 0.000078 -0.000063 0.000104 0.000095 -0.000148 0.000022 -0.000117 -0.000131 -0.000034 -0.000244 -0.000057 -0.000033 -0.000224 --0.000006 -0.000023 -0.000187 --0.000046 -0.000020 -0.000165 --0.000074 -0.000020 -0.000157 --0.000102 -0.000023 -0.000164 --0.000140 -0.000031 -0.000186 --0.000179 -0.000034 -0.000205 --0.000170 0.000002 -0.000119 --0.000075 -0.000067 0.000076 -0.000062 -0.000068 0.000093 -0.000147 0.000013 -0.000119 -0.000129 0.000060 -0.000245 -0.000055 0.000044 -0.000225 --0.000006 0.000018 -0.000186 --0.000043 0.000002 -0.000161 --0.000072 -0.000004 -0.000153 --0.000104 -0.000002 -0.000160 --0.000142 0.000013 -0.000183 --0.000179 0.000030 -0.000204 --0.000028 -0.000021 -0.000112 -0.000010 -0.000142 0.000019 --0.000003 -0.000142 0.000030 -0.000001 0.000002 -0.000114 -0.000016 0.000103 -0.000228 --0.000001 0.000089 -0.000223 --0.000027 0.000040 -0.000176 --0.000043 0.000013 -0.000148 --0.000061 0.000007 -0.000140 --0.000083 0.000014 -0.000147 --0.000103 0.000035 -0.000169 --0.000090 0.000045 -0.000182 -0.000039 -0.000066 -0.000094 -0.000044 -0.000115 -0.000068 --0.000032 -0.000097 -0.000064 --0.000086 -0.000005 -0.000119 --0.000080 0.000068 -0.000183 --0.000051 0.000055 -0.000174 --0.000030 0.000018 -0.000135 --0.000032 0.000006 -0.000119 +-0.000052 -0.000021 -0.000137 +-0.000039 -0.000030 -0.000148 +0.000006 -0.000018 -0.000148 +-0.000036 0.000027 -0.000113 +0.000002 0.000166 0.000023 +-0.000006 0.000173 0.000033 +0.000000 0.000029 -0.000110 +0.000019 -0.000080 -0.000221 +-0.000000 -0.000083 -0.000221 +-0.000036 -0.000052 -0.000184 +-0.000055 -0.000032 -0.000159 +-0.000067 -0.000026 -0.000151 +-0.000081 -0.000034 -0.000158 +-0.000096 -0.000054 -0.000181 +-0.000088 -0.000058 -0.000191 +-0.000182 0.000010 -0.000125 +-0.000085 0.000095 0.000073 +0.000056 0.000105 0.000098 +0.000141 0.000023 -0.000110 +0.000125 -0.000033 -0.000239 +0.000054 -0.000032 -0.000222 +-0.000008 -0.000022 -0.000187 +-0.000048 -0.000020 -0.000165 +-0.000077 -0.000020 -0.000158 +-0.000105 -0.000023 -0.000165 +-0.000145 -0.000032 -0.000189 +-0.000187 -0.000036 -0.000210 +-0.000181 0.000003 -0.000128 +-0.000084 -0.000067 0.000071 +0.000055 -0.000069 0.000096 +0.000140 0.000012 -0.000112 +0.000124 0.000059 -0.000241 +0.000051 0.000044 -0.000224 +-0.000008 0.000018 -0.000186 +-0.000045 0.000002 -0.000162 +-0.000075 -0.000004 -0.000154 +-0.000107 -0.000001 -0.000161 +-0.000147 0.000014 -0.000186 +-0.000188 0.000031 -0.000210 +-0.000034 -0.000019 -0.000117 +0.000006 -0.000142 0.000016 +-0.000006 -0.000143 0.000031 +-0.000002 0.000000 -0.000111 +0.000013 0.000101 -0.000225 +-0.000004 0.000088 -0.000222 +-0.000029 0.000040 -0.000176 +-0.000044 0.000013 -0.000148 +-0.000062 0.000007 -0.000140 +-0.000085 0.000014 -0.000147 +-0.000107 0.000036 -0.000171 +-0.000095 0.000048 -0.000185 +0.000038 -0.000065 -0.000096 +0.000043 -0.000115 -0.000069 +-0.000033 -0.000098 -0.000064 +-0.000087 -0.000006 -0.000119 +-0.000081 0.000067 -0.000182 +-0.000052 0.000054 -0.000174 +-0.000031 0.000018 -0.000136 +-0.000033 0.000006 -0.000119 -0.000045 0.000006 -0.000116 --0.000058 0.000011 -0.000120 --0.000060 0.000013 -0.000126 --0.000025 -0.000009 -0.000118 --0.000027 -0.000107 -0.000031 --0.000017 -0.000109 -0.000050 --0.000044 -0.000065 -0.000071 --0.000079 -0.000021 -0.000082 --0.000062 -0.000011 -0.000084 --0.000016 -0.000024 -0.000071 --0.000001 -0.000015 -0.000074 --0.000012 -0.000001 -0.000087 --0.000028 0.000004 -0.000092 --0.000040 0.000003 -0.000091 --0.000046 -0.000012 -0.000081 --0.000042 -0.000055 -0.000052 +-0.000059 0.000011 -0.000120 +-0.000062 0.000014 -0.000126 +-0.000027 -0.000007 -0.000120 +-0.000027 -0.000107 -0.000032 +-0.000017 -0.000109 -0.000051 +-0.000045 -0.000065 -0.000072 +-0.000080 -0.000021 -0.000082 +-0.000062 -0.000012 -0.000084 +-0.000017 -0.000024 -0.000071 +-0.000001 -0.000016 -0.000074 +-0.000013 -0.000001 -0.000087 +-0.000029 0.000005 -0.000093 +-0.000041 0.000003 -0.000092 +-0.000046 -0.000011 -0.000081 +-0.000043 -0.000054 -0.000053 -0.000110 -0.000094 0.000036 --0.000120 -0.000110 0.000081 +-0.000120 -0.000110 0.000080 -0.000086 -0.000068 0.000081 --0.000031 -0.000045 0.000078 +-0.000031 -0.000046 0.000077 0.000026 -0.000062 0.000068 -0.000046 -0.000050 0.000017 -0.000026 -0.000015 -0.000040 +0.000045 -0.000050 0.000017 +0.000025 -0.000015 -0.000040 0.000002 0.000006 -0.000069 -0.000016 0.000009 -0.000078 --0.000032 0.000004 -0.000075 +-0.000032 0.000005 -0.000075 -0.000048 -0.000009 -0.000060 -0.000075 -0.000043 -0.000024 -0.000131 -0.000011 0.000050 @@ -689,8 +689,8 @@ LOOKUP_TABLE default 0.000027 0.000011 -0.000038 0.000005 0.000015 -0.000065 -0.000012 0.000016 -0.000073 --0.000028 0.000013 -0.000070 --0.000049 0.000008 -0.000056 +-0.000029 0.000013 -0.000070 +-0.000049 0.000008 -0.000057 -0.000081 0.000000 -0.000025 -0.000107 0.000072 0.000026 -0.000120 0.000069 0.000073 @@ -698,122 +698,122 @@ LOOKUP_TABLE default -0.000030 0.000016 0.000074 0.000021 0.000053 0.000063 0.000034 0.000059 0.000011 -0.000014 0.000035 -0.000043 +0.000013 0.000035 -0.000043 -0.000005 0.000020 -0.000069 -0.000015 0.000019 -0.000077 --0.000026 0.000021 -0.000074 --0.000041 0.000026 -0.000060 +-0.000026 0.000021 -0.000075 +-0.000041 0.000026 -0.000061 -0.000069 0.000044 -0.000029 -0.000029 0.000090 -0.000046 -0.000022 0.000068 -0.000075 --0.000040 0.000020 -0.000100 --0.000077 -0.000004 -0.000104 --0.000074 0.000016 -0.000092 --0.000041 0.000043 -0.000071 +-0.000040 0.000020 -0.000101 +-0.000077 -0.000004 -0.000105 +-0.000074 0.000017 -0.000093 +-0.000041 0.000043 -0.000072 -0.000024 0.000036 -0.000074 --0.000024 0.000021 -0.000086 +-0.000024 0.000021 -0.000087 -0.000026 0.000016 -0.000091 -0.000025 0.000020 -0.000088 --0.000025 0.000035 -0.000077 --0.000029 0.000065 -0.000055 -0.000054 0.000060 -0.000113 -0.000042 0.000058 -0.000136 +-0.000025 0.000034 -0.000077 +-0.000029 0.000064 -0.000056 +0.000054 0.000059 -0.000114 +0.000042 0.000058 -0.000137 -0.000028 0.000035 -0.000137 --0.000095 -0.000010 -0.000148 --0.000122 -0.000043 -0.000174 --0.000102 -0.000028 -0.000160 --0.000065 -0.000005 -0.000128 --0.000046 0.000002 -0.000115 +-0.000096 -0.000009 -0.000149 +-0.000122 -0.000042 -0.000174 +-0.000102 -0.000027 -0.000160 +-0.000066 -0.000004 -0.000129 +-0.000047 0.000002 -0.000115 -0.000040 0.000002 -0.000111 --0.000032 0.000003 -0.000109 --0.000015 0.000013 -0.000107 -0.000018 0.000037 -0.000102 --0.000001 0.000062 -0.000128 -0.000003 0.000174 -0.000106 --0.000026 0.000177 -0.000106 +-0.000032 0.000003 -0.000110 +-0.000016 0.000013 -0.000107 +0.000017 0.000036 -0.000103 +-0.000001 0.000061 -0.000129 +0.000003 0.000174 -0.000107 +-0.000026 0.000177 -0.000107 -0.000038 0.000055 -0.000136 --0.000030 -0.000038 -0.000160 +-0.000030 -0.000037 -0.000160 -0.000033 -0.000052 -0.000157 -0.000041 -0.000035 -0.000137 --0.000047 -0.000020 -0.000119 +-0.000046 -0.000020 -0.000119 -0.000055 -0.000018 -0.000112 --0.000063 -0.000021 -0.000113 +-0.000063 -0.000022 -0.000113 -0.000061 -0.000024 -0.000121 --0.000036 -0.000010 -0.000132 --0.000185 0.000025 -0.000130 --0.000089 0.000229 -0.000056 -0.000055 0.000249 -0.000053 -0.000150 0.000039 -0.000135 -0.000141 -0.000089 -0.000185 -0.000068 -0.000079 -0.000175 +-0.000037 -0.000010 -0.000133 +-0.000188 0.000024 -0.000134 +-0.000092 0.000229 -0.000060 +0.000054 0.000250 -0.000054 +0.000149 0.000039 -0.000133 +0.000140 -0.000089 -0.000184 +0.000067 -0.000078 -0.000175 0.000001 -0.000052 -0.000152 -0.000042 -0.000036 -0.000134 -0.000073 -0.000032 -0.000125 -0.000106 -0.000039 -0.000128 --0.000146 -0.000059 -0.000145 --0.000188 -0.000072 -0.000162 --0.000483 0.000000 -0.000134 --0.000271 0.000127 -0.000017 -0.000199 0.000143 -0.000009 -0.000460 0.000015 -0.000138 -0.000361 -0.000056 -0.000202 -0.000173 -0.000042 -0.000179 -0.000052 -0.000028 -0.000154 --0.000026 -0.000024 -0.000138 --0.000088 -0.000025 -0.000130 --0.000151 -0.000029 -0.000133 --0.000241 -0.000040 -0.000152 --0.000386 -0.000052 -0.000176 --0.000487 -0.000003 -0.000134 --0.000275 -0.000123 -0.000016 -0.000196 -0.000137 -0.000008 -0.000459 -0.000010 -0.000137 -0.000361 0.000056 -0.000201 -0.000173 0.000037 -0.000179 -0.000053 0.000015 -0.000152 --0.000023 0.000002 -0.000134 --0.000086 -0.000002 -0.000126 --0.000153 0.000001 -0.000129 --0.000245 0.000017 -0.000149 --0.000388 0.000039 -0.000175 --0.000195 -0.000035 -0.000124 --0.000097 -0.000233 -0.000049 -0.000051 -0.000253 -0.000044 -0.000150 -0.000043 -0.000125 -0.000143 0.000082 -0.000177 -0.000073 0.000066 -0.000167 -0.000013 0.000031 -0.000138 +-0.000147 -0.000059 -0.000145 +-0.000190 -0.000073 -0.000164 +-0.000492 -0.000000 -0.000142 +-0.000280 0.000127 -0.000026 +0.000193 0.000144 -0.000008 +0.000456 0.000015 -0.000131 +0.000357 -0.000055 -0.000199 +0.000171 -0.000042 -0.000179 +0.000051 -0.000028 -0.000154 +-0.000027 -0.000024 -0.000138 +-0.000089 -0.000025 -0.000130 +-0.000153 -0.000029 -0.000133 +-0.000244 -0.000040 -0.000153 +-0.000391 -0.000052 -0.000179 +-0.000496 -0.000003 -0.000142 +-0.000284 -0.000123 -0.000025 +0.000190 -0.000137 -0.000007 +0.000455 -0.000010 -0.000130 +0.000357 0.000056 -0.000198 +0.000171 0.000037 -0.000178 +0.000052 0.000015 -0.000152 +-0.000024 0.000002 -0.000134 +-0.000087 -0.000002 -0.000126 +-0.000155 0.000001 -0.000130 +-0.000247 0.000017 -0.000149 +-0.000394 0.000039 -0.000178 +-0.000198 -0.000034 -0.000128 +-0.000099 -0.000233 -0.000053 +0.000049 -0.000253 -0.000044 +0.000149 -0.000043 -0.000123 +0.000142 0.000082 -0.000176 +0.000072 0.000066 -0.000167 +0.000012 0.000031 -0.000138 -0.000028 0.000012 -0.000119 --0.000067 0.000010 -0.000112 --0.000111 0.000017 -0.000115 --0.000160 0.000035 -0.000131 --0.000202 0.000052 -0.000150 --0.000030 -0.000088 -0.000094 --0.000013 -0.000192 -0.000079 --0.000033 -0.000194 -0.000077 +-0.000068 0.000010 -0.000112 +-0.000112 0.000017 -0.000116 +-0.000161 0.000035 -0.000131 +-0.000205 0.000052 -0.000152 +-0.000031 -0.000088 -0.000095 +-0.000013 -0.000192 -0.000081 +-0.000033 -0.000194 -0.000078 -0.000033 -0.000072 -0.000107 --0.000015 0.000018 -0.000132 +-0.000015 0.000018 -0.000131 -0.000005 0.000024 -0.000121 --0.000005 0.000009 -0.000099 +-0.000005 0.000009 -0.000100 -0.000022 0.000005 -0.000093 --0.000047 0.000010 -0.000093 +-0.000047 0.000010 -0.000094 -0.000070 0.000013 -0.000095 -0.000084 0.000009 -0.000096 -0.000071 -0.000014 -0.000098 -0.000034 -0.000105 -0.000042 --0.000034 -0.000151 -0.000050 +-0.000034 -0.000151 -0.000051 -0.000057 -0.000145 -0.000060 --0.000063 -0.000085 -0.000064 +-0.000063 -0.000085 -0.000065 -0.000038 -0.000037 -0.000063 --0.000010 -0.000022 -0.000054 --0.000001 -0.000008 -0.000060 --0.000014 0.000005 -0.000072 --0.000032 0.000011 -0.000078 +-0.000010 -0.000023 -0.000055 +-0.000001 -0.000009 -0.000060 +-0.000014 0.000005 -0.000073 +-0.000032 0.000011 -0.000079 -0.000045 0.000009 -0.000078 --0.000051 -0.000008 -0.000070 --0.000047 -0.000048 -0.000052 --0.000057 -0.000069 -0.000004 --0.000063 -0.000103 0.000017 +-0.000051 -0.000007 -0.000070 +-0.000047 -0.000047 -0.000053 +-0.000056 -0.000069 -0.000005 +-0.000062 -0.000103 0.000017 -0.000066 -0.000104 0.000020 -0.000057 -0.000074 0.000020 -0.000027 -0.000045 0.000014 @@ -825,18 +825,18 @@ LOOKUP_TABLE default -0.000038 -0.000004 -0.000059 -0.000046 -0.000030 -0.000037 -0.000058 -0.000008 0.000001 --0.000066 -0.000019 0.000048 +-0.000066 -0.000019 0.000047 -0.000068 -0.000022 0.000074 -0.000053 -0.000012 0.000074 --0.000027 -0.000001 0.000046 --0.000010 0.000007 -0.000003 +-0.000026 -0.000001 0.000046 +-0.000010 0.000007 -0.000004 -0.000008 0.000013 -0.000041 --0.000012 0.000017 -0.000058 +-0.000012 0.000017 -0.000059 -0.000018 0.000017 -0.000066 -0.000025 0.000014 -0.000065 --0.000034 0.000009 -0.000055 --0.000046 0.000002 -0.000036 --0.000054 0.000051 -0.000011 +-0.000034 0.000009 -0.000056 +-0.000046 0.000003 -0.000036 +-0.000054 0.000051 -0.000012 -0.000061 0.000062 0.000010 -0.000064 0.000060 0.000014 -0.000057 0.000051 0.000014 @@ -847,892 +847,892 @@ LOOKUP_TABLE default -0.000020 0.000017 -0.000071 -0.000023 0.000019 -0.000070 -0.000030 0.000024 -0.000061 --0.000041 0.000035 -0.000041 --0.000026 0.000089 -0.000051 +-0.000041 0.000035 -0.000042 +-0.000026 0.000089 -0.000052 -0.000033 0.000103 -0.000066 --0.000055 0.000093 -0.000077 --0.000068 0.000064 -0.000078 +-0.000055 0.000093 -0.000078 +-0.000067 0.000064 -0.000079 -0.000056 0.000045 -0.000071 -0.000036 0.000043 -0.000061 --0.000025 0.000031 -0.000065 --0.000025 0.000017 -0.000076 --0.000027 0.000012 -0.000081 --0.000027 0.000016 -0.000080 --0.000026 0.000031 -0.000072 +-0.000024 0.000031 -0.000066 +-0.000025 0.000017 -0.000077 +-0.000027 0.000011 -0.000081 +-0.000026 0.000016 -0.000080 +-0.000026 0.000031 -0.000073 -0.000027 0.000059 -0.000058 -0.000016 0.000086 -0.000104 -0.000003 0.000125 -0.000116 +0.000016 0.000085 -0.000104 +0.000004 0.000125 -0.000117 -0.000045 0.000119 -0.000118 -0.000074 0.000059 -0.000123 -0.000075 0.000011 -0.000130 --0.000061 0.000002 -0.000120 --0.000042 0.000006 -0.000102 +-0.000060 0.000002 -0.000120 +-0.000041 0.000006 -0.000102 -0.000036 0.000003 -0.000096 -0.000039 -0.000001 -0.000095 -0.000039 0.000001 -0.000094 -0.000030 0.000016 -0.000092 -0.000009 0.000045 -0.000092 --0.000020 0.000076 -0.000125 --0.000010 0.000194 -0.000160 --0.000030 0.000201 -0.000165 --0.000035 0.000079 -0.000136 --0.000017 -0.000017 -0.000108 --0.000015 -0.000036 -0.000099 --0.000026 -0.000026 -0.000093 --0.000038 -0.000017 -0.000085 +-0.000019 0.000077 -0.000127 +-0.000009 0.000194 -0.000162 +-0.000030 0.000201 -0.000166 +-0.000034 0.000079 -0.000135 +-0.000016 -0.000017 -0.000108 +-0.000014 -0.000036 -0.000099 +-0.000025 -0.000027 -0.000093 +-0.000037 -0.000017 -0.000085 -0.000052 -0.000016 -0.000082 --0.000066 -0.000020 -0.000081 --0.000069 -0.000021 -0.000082 --0.000052 -0.000003 -0.000095 --0.000201 0.000033 -0.000128 --0.000101 0.000240 -0.000215 -0.000049 0.000262 -0.000230 -0.000150 0.000052 -0.000149 -0.000148 -0.000078 -0.000090 -0.000080 -0.000069 -0.000088 -0.000013 -0.000046 -0.000094 --0.000035 -0.000033 -0.000090 --0.000071 -0.000030 -0.000084 --0.000109 -0.000037 -0.000081 --0.000155 -0.000056 -0.000077 --0.000203 -0.000067 -0.000080 --0.000502 -0.000002 -0.000118 --0.000286 0.000125 -0.000250 -0.000188 0.000141 -0.000275 -0.000455 0.000013 -0.000149 -0.000363 -0.000057 -0.000073 -0.000182 -0.000043 -0.000081 -0.000061 -0.000030 -0.000090 --0.000022 -0.000025 -0.000088 --0.000087 -0.000026 -0.000083 --0.000154 -0.000029 -0.000079 --0.000249 -0.000041 -0.000072 --0.000401 -0.000054 -0.000064 --0.000507 -0.000015 -0.000114 --0.000292 -0.000138 -0.000246 -0.000185 -0.000154 -0.000271 -0.000454 -0.000028 -0.000146 -0.000364 0.000041 -0.000070 -0.000184 0.000024 -0.000078 -0.000064 0.000007 -0.000086 --0.000018 -0.000002 -0.000083 --0.000085 -0.000006 -0.000078 --0.000157 -0.000002 -0.000074 --0.000254 0.000013 -0.000068 --0.000406 0.000031 -0.000061 --0.000215 -0.000052 -0.000117 --0.000112 -0.000257 -0.000204 -0.000044 -0.000280 -0.000218 -0.000151 -0.000071 -0.000137 -0.000153 0.000059 -0.000078 -0.000089 0.000049 -0.000076 -0.000026 0.000022 -0.000079 --0.000021 0.000008 -0.000075 --0.000066 0.000008 -0.000072 --0.000114 0.000015 -0.000069 --0.000169 0.000032 -0.000063 --0.000219 0.000043 -0.000066 --0.000042 -0.000094 -0.000101 --0.000025 -0.000211 -0.000138 --0.000037 -0.000218 -0.000143 --0.000030 -0.000097 -0.000113 --0.000004 -0.000001 -0.000085 -0.000006 0.000018 -0.000073 --0.000002 0.000011 -0.000067 +-0.000065 -0.000020 -0.000081 +-0.000068 -0.000021 -0.000082 +-0.000050 -0.000003 -0.000095 +-0.000197 0.000034 -0.000132 +-0.000097 0.000240 -0.000220 +0.000052 0.000262 -0.000230 +0.000153 0.000052 -0.000147 +0.000150 -0.000078 -0.000089 +0.000082 -0.000069 -0.000088 +0.000015 -0.000046 -0.000094 +-0.000034 -0.000033 -0.000090 +-0.000070 -0.000030 -0.000084 +-0.000107 -0.000037 -0.000081 +-0.000153 -0.000056 -0.000077 +-0.000200 -0.000066 -0.000081 +-0.000492 -0.000002 -0.000126 +-0.000277 0.000125 -0.000258 +0.000195 0.000141 -0.000273 +0.000461 0.000013 -0.000142 +0.000368 -0.000058 -0.000070 +0.000185 -0.000043 -0.000080 +0.000063 -0.000030 -0.000090 +-0.000020 -0.000025 -0.000088 +-0.000085 -0.000025 -0.000083 +-0.000152 -0.000029 -0.000079 +-0.000245 -0.000041 -0.000073 +-0.000394 -0.000053 -0.000067 +-0.000497 -0.000016 -0.000123 +-0.000282 -0.000138 -0.000255 +0.000192 -0.000154 -0.000270 +0.000460 -0.000027 -0.000139 +0.000369 0.000041 -0.000066 +0.000187 0.000025 -0.000077 +0.000066 0.000007 -0.000086 +-0.000016 -0.000002 -0.000083 +-0.000083 -0.000006 -0.000078 +-0.000154 -0.000002 -0.000074 +-0.000251 0.000012 -0.000068 +-0.000399 0.000030 -0.000064 +-0.000211 -0.000053 -0.000121 +-0.000108 -0.000257 -0.000208 +0.000047 -0.000280 -0.000218 +0.000153 -0.000070 -0.000135 +0.000156 0.000059 -0.000077 +0.000091 0.000049 -0.000076 +0.000028 0.000022 -0.000080 +-0.000020 0.000008 -0.000075 +-0.000064 0.000008 -0.000072 +-0.000113 0.000015 -0.000069 +-0.000167 0.000031 -0.000063 +-0.000216 0.000042 -0.000067 +-0.000041 -0.000094 -0.000102 +-0.000024 -0.000211 -0.000140 +-0.000036 -0.000218 -0.000143 +-0.000029 -0.000096 -0.000112 +-0.000004 -0.000000 -0.000085 +0.000007 0.000018 -0.000074 +-0.000001 0.000011 -0.000068 -0.000021 0.000008 -0.000067 --0.000047 0.000012 -0.000069 --0.000071 0.000015 -0.000068 --0.000086 0.000012 -0.000065 --0.000077 -0.000012 -0.000070 --0.000022 -0.000091 -0.000071 --0.000029 -0.000149 -0.000081 +-0.000046 0.000011 -0.000069 +-0.000070 0.000015 -0.000068 +-0.000085 0.000012 -0.000065 +-0.000075 -0.000012 -0.000071 +-0.000021 -0.000091 -0.000072 +-0.000029 -0.000149 -0.000082 -0.000057 -0.000153 -0.000085 -0.000063 -0.000094 -0.000080 --0.000043 -0.000035 -0.000068 --0.000023 -0.000008 -0.000057 --0.000015 0.000005 -0.000057 +-0.000043 -0.000035 -0.000069 +-0.000022 -0.000008 -0.000058 +-0.000014 0.000005 -0.000057 -0.000021 0.000012 -0.000063 --0.000034 0.000015 -0.000066 --0.000043 0.000013 -0.000067 --0.000045 -0.000001 -0.000066 --0.000035 -0.000034 -0.000065 --0.000030 -0.000052 -0.000049 --0.000041 -0.000087 -0.000039 --0.000059 -0.000097 -0.000035 +-0.000033 0.000015 -0.000067 +-0.000043 0.000012 -0.000068 +-0.000044 -0.000001 -0.000067 +-0.000034 -0.000035 -0.000066 +-0.000030 -0.000053 -0.000050 +-0.000040 -0.000087 -0.000039 +-0.000058 -0.000097 -0.000036 -0.000064 -0.000068 -0.000035 --0.000049 -0.000030 -0.000035 +-0.000048 -0.000029 -0.000035 -0.000031 -0.000006 -0.000041 -0.000022 0.000008 -0.000052 -0.000021 0.000015 -0.000060 --0.000025 0.000016 -0.000064 +-0.000024 0.000016 -0.000064 -0.000028 0.000011 -0.000065 --0.000029 -0.000001 -0.000064 --0.000028 -0.000022 -0.000059 +-0.000028 -0.000001 -0.000064 +-0.000028 -0.000022 -0.000060 -0.000033 -0.000006 -0.000043 --0.000041 -0.000016 -0.000021 +-0.000040 -0.000016 -0.000021 -0.000056 -0.000018 -0.000007 -0.000064 -0.000009 -0.000007 --0.000052 0.000002 -0.000018 --0.000035 0.000009 -0.000037 --0.000026 0.000014 -0.000051 --0.000022 0.000017 -0.000059 --0.000021 0.000017 -0.000064 --0.000022 0.000015 -0.000065 --0.000025 0.000010 -0.000062 +-0.000052 0.000002 -0.000019 +-0.000034 0.000009 -0.000037 +-0.000025 0.000014 -0.000051 +-0.000022 0.000017 -0.000060 +-0.000020 0.000017 -0.000064 +-0.000021 0.000015 -0.000065 +-0.000025 0.000010 -0.000063 -0.000029 0.000003 -0.000057 -0.000029 0.000038 -0.000052 -0.000040 0.000050 -0.000041 -0.000057 0.000058 -0.000037 --0.000063 0.000050 -0.000037 +-0.000063 0.000050 -0.000038 -0.000052 0.000033 -0.000039 --0.000039 0.000024 -0.000046 --0.000031 0.000020 -0.000056 +-0.000038 0.000024 -0.000046 +-0.000031 0.000020 -0.000057 -0.000026 0.000016 -0.000064 --0.000022 0.000016 -0.000067 --0.000021 0.000018 -0.000068 +-0.000022 0.000016 -0.000068 +-0.000020 0.000018 -0.000068 -0.000021 0.000022 -0.000067 -0.000024 0.000028 -0.000062 --0.000014 0.000076 -0.000074 --0.000029 0.000102 -0.000080 --0.000056 0.000103 -0.000085 --0.000067 0.000074 -0.000085 --0.000060 0.000045 -0.000077 --0.000047 0.000031 -0.000067 --0.000036 0.000020 -0.000066 --0.000031 0.000011 -0.000070 --0.000029 0.000009 -0.000073 +-0.000014 0.000076 -0.000075 +-0.000029 0.000102 -0.000081 +-0.000055 0.000103 -0.000085 +-0.000066 0.000074 -0.000085 +-0.000059 0.000045 -0.000078 +-0.000047 0.000031 -0.000068 +-0.000035 0.000020 -0.000066 +-0.000030 0.000011 -0.000070 +-0.000028 0.000009 -0.000073 -0.000025 0.000013 -0.000074 --0.000020 0.000026 -0.000073 --0.000015 0.000048 -0.000072 -0.000004 0.000090 -0.000104 --0.000009 0.000143 -0.000117 --0.000049 0.000142 -0.000118 +-0.000020 0.000026 -0.000074 +-0.000015 0.000048 -0.000073 +0.000005 0.000090 -0.000105 +-0.000008 0.000143 -0.000118 +-0.000048 0.000142 -0.000119 -0.000070 0.000082 -0.000114 -0.000063 0.000029 -0.000105 --0.000049 0.000008 -0.000092 --0.000036 0.000003 -0.000080 --0.000034 0.000001 -0.000077 +-0.000048 0.000008 -0.000092 +-0.000035 0.000003 -0.000080 +-0.000033 0.000001 -0.000077 -0.000038 -0.000002 -0.000078 --0.000040 -0.000001 -0.000079 --0.000032 0.000013 -0.000080 --0.000014 0.000042 -0.000087 -0.000008 0.000088 -0.000132 -0.000003 0.000181 -0.000192 --0.000049 0.000185 -0.000196 --0.000071 0.000094 -0.000141 --0.000043 -0.000000 -0.000077 --0.000023 -0.000032 -0.000052 --0.000028 -0.000023 -0.000053 --0.000038 -0.000014 -0.000056 --0.000048 -0.000013 -0.000055 --0.000058 -0.000018 -0.000051 --0.000058 -0.000023 -0.000049 --0.000031 0.000003 -0.000071 --0.000072 0.000051 -0.000133 --0.000027 0.000197 -0.000282 --0.000018 0.000211 -0.000299 -0.000009 0.000068 -0.000156 -0.000047 -0.000046 -0.000040 -0.000036 -0.000057 -0.000025 --0.000004 -0.000037 -0.000042 --0.000037 -0.000025 -0.000049 --0.000062 -0.000023 -0.000047 --0.000086 -0.000030 -0.000040 --0.000114 -0.000049 -0.000026 --0.000118 -0.000045 -0.000034 --0.000212 0.000004 -0.000116 --0.000109 0.000087 -0.000328 -0.000044 0.000097 -0.000359 -0.000148 0.000016 -0.000151 -0.000148 -0.000039 -0.000017 -0.000084 -0.000036 -0.000019 -0.000019 -0.000026 -0.000037 --0.000033 -0.000022 -0.000045 --0.000072 -0.000022 -0.000043 --0.000110 -0.000026 -0.000036 --0.000160 -0.000035 -0.000020 --0.000213 -0.000040 -0.000014 --0.000216 -0.000031 -0.000114 --0.000112 -0.000111 -0.000326 -0.000042 -0.000120 -0.000356 -0.000148 -0.000039 -0.000149 -0.000150 0.000015 -0.000015 -0.000087 0.000011 -0.000017 -0.000022 -0.000002 -0.000035 --0.000028 -0.000009 -0.000042 --0.000070 -0.000012 -0.000041 --0.000112 -0.000009 -0.000033 --0.000164 0.000003 -0.000018 --0.000217 0.000010 -0.000012 --0.000084 -0.000072 -0.000126 --0.000036 -0.000218 -0.000276 --0.000021 -0.000231 -0.000293 -0.000010 -0.000088 -0.000151 -0.000053 0.000025 -0.000034 -0.000046 0.000036 -0.000020 -0.000007 0.000015 -0.000036 --0.000026 0.000003 -0.000042 --0.000057 0.000003 -0.000042 --0.000091 0.000009 -0.000034 --0.000126 0.000025 -0.000019 --0.000131 0.000022 -0.000027 --0.000009 -0.000101 -0.000123 --0.000009 -0.000195 -0.000184 --0.000054 -0.000199 -0.000188 --0.000067 -0.000108 -0.000132 --0.000032 -0.000014 -0.000069 --0.000007 0.000020 -0.000043 --0.000011 0.000014 -0.000045 --0.000026 0.000009 -0.000049 --0.000044 0.000011 -0.000050 --0.000062 0.000015 -0.000046 --0.000070 0.000017 -0.000042 --0.000049 -0.000013 -0.000062 --0.000011 -0.000087 -0.000103 --0.000026 -0.000136 -0.000116 --0.000057 -0.000139 -0.000117 --0.000069 -0.000094 -0.000106 --0.000055 -0.000038 -0.000081 --0.000035 -0.000003 -0.000061 --0.000025 0.000009 -0.000056 --0.000027 0.000013 -0.000057 --0.000033 0.000013 -0.000059 --0.000038 0.000012 -0.000060 --0.000034 0.000002 -0.000064 --0.000021 -0.000031 -0.000079 --0.000024 -0.000049 -0.000086 --0.000037 -0.000077 -0.000086 --0.000054 -0.000085 -0.000085 --0.000063 -0.000063 -0.000082 --0.000057 -0.000028 -0.000072 --0.000043 -0.000004 -0.000064 --0.000032 0.000008 -0.000062 --0.000026 0.000014 -0.000062 --0.000025 0.000015 -0.000063 --0.000025 0.000011 -0.000066 --0.000022 -0.000001 -0.000071 --0.000020 -0.000021 -0.000080 --0.000028 -0.000005 -0.000080 --0.000038 -0.000013 -0.000076 --0.000051 -0.000014 -0.000071 --0.000063 -0.000007 -0.000069 --0.000059 0.000003 -0.000067 --0.000045 0.000009 -0.000065 +-0.000039 -0.000001 -0.000079 +-0.000031 0.000013 -0.000080 +-0.000013 0.000042 -0.000088 +0.000011 0.000090 -0.000134 +0.000005 0.000181 -0.000193 +-0.000047 0.000184 -0.000196 +-0.000069 0.000093 -0.000140 +-0.000041 -0.000001 -0.000077 +-0.000021 -0.000032 -0.000052 +-0.000026 -0.000024 -0.000054 +-0.000036 -0.000014 -0.000056 +-0.000046 -0.000013 -0.000055 +-0.000056 -0.000018 -0.000052 +-0.000056 -0.000022 -0.000050 +-0.000029 0.000005 -0.000073 +-0.000066 0.000054 -0.000137 +-0.000022 0.000197 -0.000285 +-0.000013 0.000210 -0.000298 +0.000014 0.000066 -0.000153 +0.000051 -0.000048 -0.000037 +0.000040 -0.000058 -0.000024 +-0.000002 -0.000037 -0.000042 +-0.000035 -0.000025 -0.000049 +-0.000059 -0.000022 -0.000048 +-0.000083 -0.000029 -0.000041 +-0.000109 -0.000047 -0.000028 +-0.000112 -0.000042 -0.000038 +-0.000199 0.000006 -0.000125 +-0.000098 0.000088 -0.000333 +0.000053 0.000096 -0.000356 +0.000156 0.000015 -0.000145 +0.000155 -0.000040 -0.000013 +0.000089 -0.000037 -0.000018 +0.000022 -0.000026 -0.000037 +-0.000030 -0.000022 -0.000045 +-0.000069 -0.000022 -0.000044 +-0.000106 -0.000026 -0.000037 +-0.000153 -0.000035 -0.000023 +-0.000203 -0.000038 -0.000020 +-0.000204 -0.000033 -0.000123 +-0.000102 -0.000111 -0.000331 +0.000051 -0.000119 -0.000354 +0.000156 -0.000038 -0.000142 +0.000157 0.000016 -0.000010 +0.000091 0.000011 -0.000016 +0.000025 -0.000002 -0.000035 +-0.000025 -0.000009 -0.000042 +-0.000066 -0.000012 -0.000041 +-0.000108 -0.000009 -0.000034 +-0.000158 0.000002 -0.000020 +-0.000208 0.000009 -0.000018 +-0.000078 -0.000075 -0.000131 +-0.000031 -0.000218 -0.000279 +-0.000017 -0.000230 -0.000292 +0.000014 -0.000086 -0.000148 +0.000057 0.000027 -0.000032 +0.000049 0.000037 -0.000019 +0.000009 0.000015 -0.000036 +-0.000024 0.000003 -0.000042 +-0.000055 0.000002 -0.000042 +-0.000088 0.000009 -0.000035 +-0.000121 0.000024 -0.000021 +-0.000125 0.000019 -0.000031 +-0.000006 -0.000102 -0.000125 +-0.000007 -0.000195 -0.000185 +-0.000053 -0.000199 -0.000188 +-0.000066 -0.000107 -0.000132 +-0.000030 -0.000012 -0.000069 +-0.000005 0.000020 -0.000043 +-0.000009 0.000015 -0.000045 +-0.000025 0.000009 -0.000049 +-0.000043 0.000010 -0.000050 +-0.000060 0.000015 -0.000047 +-0.000068 0.000016 -0.000043 +-0.000047 -0.000014 -0.000063 +-0.000010 -0.000088 -0.000104 +-0.000025 -0.000136 -0.000117 +-0.000056 -0.000138 -0.000117 +-0.000068 -0.000094 -0.000106 +-0.000054 -0.000037 -0.000081 +-0.000034 -0.000002 -0.000061 +-0.000024 0.000009 -0.000056 +-0.000026 0.000013 -0.000058 +-0.000032 0.000013 -0.000059 +-0.000037 0.000012 -0.000060 +-0.000033 0.000001 -0.000065 +-0.000020 -0.000032 -0.000080 +-0.000023 -0.000050 -0.000087 +-0.000037 -0.000077 -0.000087 +-0.000053 -0.000084 -0.000085 +-0.000062 -0.000062 -0.000082 +-0.000056 -0.000028 -0.000073 +-0.000042 -0.000004 -0.000065 +-0.000031 0.000009 -0.000062 +-0.000025 0.000014 -0.000062 +-0.000024 0.000015 -0.000064 +-0.000024 0.000010 -0.000067 +-0.000021 -0.000001 -0.000072 +-0.000019 -0.000021 -0.000080 +-0.000027 -0.000006 -0.000080 +-0.000037 -0.000013 -0.000076 +-0.000051 -0.000014 -0.000072 +-0.000062 -0.000007 -0.000069 +-0.000058 0.000003 -0.000067 +-0.000044 0.000010 -0.000065 -0.000034 0.000014 -0.000065 --0.000027 0.000017 -0.000065 --0.000022 0.000017 -0.000067 --0.000019 0.000014 -0.000070 +-0.000026 0.000017 -0.000065 +-0.000021 0.000017 -0.000067 +-0.000018 0.000014 -0.000070 -0.000018 0.000010 -0.000074 --0.000021 0.000003 -0.000078 --0.000024 0.000036 -0.000084 --0.000037 0.000046 -0.000082 --0.000053 0.000053 -0.000081 --0.000062 0.000047 -0.000079 --0.000059 0.000032 -0.000074 +-0.000020 0.000003 -0.000079 +-0.000023 0.000036 -0.000084 +-0.000037 0.000046 -0.000083 +-0.000052 0.000053 -0.000081 +-0.000061 0.000047 -0.000079 +-0.000058 0.000032 -0.000074 -0.000049 0.000023 -0.000069 --0.000039 0.000019 -0.000067 --0.000030 0.000016 -0.000067 --0.000023 0.000015 -0.000068 --0.000018 0.000017 -0.000071 --0.000016 0.000021 -0.000075 --0.000016 0.000027 -0.000081 --0.000012 0.000071 -0.000095 --0.000030 0.000094 -0.000100 +-0.000038 0.000019 -0.000067 +-0.000029 0.000016 -0.000067 +-0.000022 0.000015 -0.000068 +-0.000017 0.000017 -0.000071 +-0.000015 0.000021 -0.000076 +-0.000016 0.000028 -0.000081 +-0.000011 0.000071 -0.000096 +-0.000029 0.000094 -0.000100 -0.000052 0.000096 -0.000101 --0.000064 0.000074 -0.000098 --0.000064 0.000047 -0.000086 --0.000055 0.000027 -0.000074 --0.000043 0.000016 -0.000068 --0.000034 0.000010 -0.000067 --0.000028 0.000010 -0.000067 --0.000022 0.000014 -0.000070 --0.000014 0.000024 -0.000076 --0.000009 0.000043 -0.000085 -0.000006 0.000091 -0.000114 --0.000012 0.000134 -0.000128 --0.000051 0.000132 -0.000128 --0.000074 0.000088 -0.000116 --0.000069 0.000037 -0.000093 --0.000052 0.000007 -0.000072 --0.000041 0.000001 -0.000064 --0.000037 -0.000000 -0.000063 --0.000037 -0.000002 -0.000063 --0.000034 -0.000001 -0.000065 --0.000024 0.000009 -0.000070 --0.000006 0.000039 -0.000087 -0.000030 0.000086 -0.000131 -0.000005 0.000125 -0.000171 --0.000054 0.000123 -0.000171 --0.000091 0.000085 -0.000133 --0.000079 0.000026 -0.000071 --0.000052 -0.000011 -0.000032 --0.000042 -0.000012 -0.000031 --0.000042 -0.000005 -0.000038 --0.000043 -0.000004 -0.000040 --0.000043 -0.000008 -0.000036 --0.000030 -0.000005 -0.000039 -0.000005 0.000027 -0.000071 -0.000013 0.000052 -0.000129 -0.000007 0.000109 -0.000224 --0.000048 0.000112 -0.000230 --0.000073 0.000057 -0.000139 --0.000047 -0.000004 -0.000044 --0.000029 -0.000026 -0.000010 --0.000036 -0.000021 -0.000017 --0.000046 -0.000014 -0.000025 --0.000052 -0.000011 -0.000028 --0.000055 -0.000015 -0.000023 --0.000051 -0.000021 -0.000017 --0.000025 -0.000005 -0.000042 --0.000023 0.000006 -0.000119 --0.000011 0.000038 -0.000240 --0.000032 0.000041 -0.000253 --0.000037 0.000011 -0.000133 --0.000019 -0.000014 -0.000034 --0.000016 -0.000019 -0.000010 --0.000029 -0.000017 -0.000014 --0.000046 -0.000017 -0.000021 --0.000057 -0.000017 -0.000023 --0.000063 -0.000018 -0.000019 --0.000064 -0.000020 -0.000015 --0.000051 -0.000016 -0.000035 --0.000026 -0.000034 -0.000120 --0.000014 -0.000062 -0.000242 --0.000033 -0.000064 -0.000254 --0.000036 -0.000034 -0.000134 --0.000017 -0.000010 -0.000035 --0.000012 -0.000007 -0.000012 --0.000025 -0.000010 -0.000016 --0.000041 -0.000015 -0.000023 --0.000055 -0.000018 -0.000025 --0.000065 -0.000017 -0.000021 --0.000068 -0.000013 -0.000017 --0.000055 -0.000013 -0.000036 -0.000003 -0.000075 -0.000132 --0.000001 -0.000131 -0.000228 --0.000051 -0.000132 -0.000234 --0.000071 -0.000077 -0.000144 --0.000041 -0.000017 -0.000048 --0.000019 0.000005 -0.000015 --0.000024 -0.000002 -0.000021 --0.000035 -0.000008 -0.000030 --0.000047 -0.000009 -0.000032 --0.000060 -0.000006 -0.000026 --0.000062 -0.000002 -0.000021 --0.000037 -0.000019 -0.000046 -0.000014 -0.000099 -0.000137 --0.000007 -0.000140 -0.000177 --0.000059 -0.000138 -0.000178 --0.000086 -0.000099 -0.000140 --0.000067 -0.000039 -0.000078 --0.000036 -0.000001 -0.000040 --0.000024 0.000003 -0.000037 --0.000030 0.000000 -0.000043 --0.000039 0.000002 -0.000042 --0.000047 0.000005 -0.000039 --0.000042 -0.000001 -0.000042 --0.000012 -0.000037 -0.000077 --0.000006 -0.000085 -0.000127 --0.000028 -0.000109 -0.000137 +-0.000063 0.000074 -0.000098 +-0.000063 0.000046 -0.000086 +-0.000054 0.000027 -0.000074 +-0.000042 0.000016 -0.000068 +-0.000033 0.000010 -0.000067 +-0.000027 0.000010 -0.000068 +-0.000021 0.000014 -0.000070 +-0.000013 0.000024 -0.000076 +-0.000008 0.000044 -0.000086 +0.000007 0.000091 -0.000114 +-0.000011 0.000134 -0.000129 +-0.000050 0.000132 -0.000128 +-0.000073 0.000088 -0.000117 +-0.000068 0.000036 -0.000093 +-0.000051 0.000007 -0.000072 +-0.000039 0.000000 -0.000064 +-0.000036 -0.000000 -0.000063 +-0.000036 -0.000001 -0.000064 +-0.000033 -0.000000 -0.000065 +-0.000023 0.000010 -0.000070 +-0.000004 0.000040 -0.000088 +0.000032 0.000087 -0.000133 +0.000007 0.000125 -0.000172 +-0.000052 0.000123 -0.000171 +-0.000089 0.000084 -0.000132 +-0.000076 0.000024 -0.000070 +-0.000049 -0.000012 -0.000031 +-0.000039 -0.000013 -0.000030 +-0.000040 -0.000005 -0.000038 +-0.000041 -0.000004 -0.000040 +-0.000041 -0.000007 -0.000038 +-0.000027 -0.000004 -0.000041 +0.000008 0.000029 -0.000074 +0.000017 0.000054 -0.000133 +0.000010 0.000110 -0.000225 +-0.000045 0.000111 -0.000229 +-0.000069 0.000056 -0.000137 +-0.000044 -0.000006 -0.000041 +-0.000026 -0.000027 -0.000009 +-0.000033 -0.000021 -0.000016 +-0.000044 -0.000014 -0.000026 +-0.000049 -0.000011 -0.000029 +-0.000052 -0.000014 -0.000024 +-0.000047 -0.000020 -0.000020 +-0.000020 -0.000003 -0.000046 +-0.000017 0.000007 -0.000125 +-0.000007 0.000038 -0.000243 +-0.000028 0.000040 -0.000251 +-0.000032 0.000010 -0.000128 +-0.000015 -0.000015 -0.000030 +-0.000012 -0.000020 -0.000009 +-0.000026 -0.000017 -0.000013 +-0.000043 -0.000017 -0.000021 +-0.000054 -0.000017 -0.000023 +-0.000059 -0.000018 -0.000020 +-0.000059 -0.000019 -0.000018 +-0.000046 -0.000015 -0.000040 +-0.000021 -0.000035 -0.000126 +-0.000010 -0.000063 -0.000245 +-0.000029 -0.000063 -0.000252 +-0.000032 -0.000033 -0.000130 +-0.000013 -0.000009 -0.000032 +-0.000009 -0.000006 -0.000010 +-0.000022 -0.000010 -0.000015 +-0.000039 -0.000014 -0.000023 +-0.000052 -0.000018 -0.000026 +-0.000062 -0.000017 -0.000022 +-0.000064 -0.000013 -0.000020 +-0.000050 -0.000015 -0.000041 +0.000006 -0.000077 -0.000136 +0.000002 -0.000131 -0.000229 +-0.000049 -0.000131 -0.000233 +-0.000068 -0.000075 -0.000141 +-0.000037 -0.000015 -0.000046 +-0.000016 0.000006 -0.000013 +-0.000021 -0.000001 -0.000021 +-0.000032 -0.000008 -0.000031 +-0.000044 -0.000009 -0.000032 +-0.000057 -0.000006 -0.000028 +-0.000058 -0.000004 -0.000024 +-0.000033 -0.000022 -0.000050 +0.000015 -0.000101 -0.000139 +-0.000005 -0.000140 -0.000178 +-0.000058 -0.000137 -0.000177 +-0.000085 -0.000098 -0.000139 +-0.000066 -0.000038 -0.000077 +-0.000034 0.000001 -0.000039 +-0.000022 0.000004 -0.000037 +-0.000028 0.000000 -0.000043 +-0.000037 0.000001 -0.000043 +-0.000045 0.000004 -0.000040 +-0.000039 -0.000002 -0.000044 +-0.000010 -0.000039 -0.000079 +-0.000005 -0.000086 -0.000128 +-0.000028 -0.000109 -0.000138 -0.000056 -0.000110 -0.000136 --0.000072 -0.000090 -0.000125 --0.000068 -0.000050 -0.000098 --0.000047 -0.000013 -0.000071 --0.000030 0.000004 -0.000059 --0.000028 0.000007 -0.000057 --0.000031 0.000008 -0.000056 --0.000031 0.000007 -0.000057 --0.000023 -0.000006 -0.000068 --0.000008 -0.000042 -0.000097 --0.000025 -0.000047 -0.000117 --0.000040 -0.000064 -0.000127 +-0.000072 -0.000089 -0.000125 +-0.000067 -0.000049 -0.000098 +-0.000045 -0.000012 -0.000071 +-0.000029 0.000004 -0.000059 +-0.000026 0.000007 -0.000057 +-0.000029 0.000008 -0.000057 +-0.000030 0.000006 -0.000058 +-0.000021 -0.000007 -0.000069 +-0.000007 -0.000043 -0.000098 +-0.000024 -0.000048 -0.000118 +-0.000039 -0.000064 -0.000128 -0.000052 -0.000071 -0.000128 --0.000061 -0.000060 -0.000122 +-0.000060 -0.000059 -0.000122 -0.000059 -0.000033 -0.000108 --0.000047 -0.000008 -0.000089 --0.000034 0.000005 -0.000075 --0.000027 0.000011 -0.000069 --0.000023 0.000012 -0.000068 --0.000021 0.000007 -0.000071 --0.000018 -0.000005 -0.000082 --0.000016 -0.000025 -0.000100 --0.000030 -0.000005 -0.000113 --0.000040 -0.000009 -0.000125 --0.000050 -0.000010 -0.000129 --0.000060 -0.000006 -0.000124 +-0.000046 -0.000008 -0.000089 +-0.000033 0.000006 -0.000075 +-0.000026 0.000011 -0.000069 +-0.000022 0.000011 -0.000068 +-0.000020 0.000007 -0.000072 +-0.000017 -0.000005 -0.000083 +-0.000016 -0.000026 -0.000101 +-0.000030 -0.000005 -0.000114 +-0.000039 -0.000009 -0.000125 +-0.000049 -0.000010 -0.000129 +-0.000059 -0.000006 -0.000124 -0.000058 0.000001 -0.000111 -0.000046 0.000008 -0.000094 -0.000035 0.000013 -0.000082 -0.000027 0.000016 -0.000075 --0.000021 0.000016 -0.000073 --0.000017 0.000013 -0.000077 --0.000017 0.000009 -0.000086 --0.000021 0.000002 -0.000099 --0.000026 0.000035 -0.000110 +-0.000020 0.000016 -0.000074 +-0.000016 0.000013 -0.000078 +-0.000016 0.000009 -0.000087 +-0.000021 0.000002 -0.000100 +-0.000026 0.000035 -0.000111 -0.000039 0.000043 -0.000119 --0.000051 0.000049 -0.000120 --0.000059 0.000046 -0.000115 +-0.000050 0.000049 -0.000120 +-0.000058 0.000046 -0.000115 -0.000058 0.000034 -0.000105 -0.000050 0.000024 -0.000091 --0.000040 0.000020 -0.000080 --0.000030 0.000017 -0.000074 --0.000022 0.000017 -0.000073 --0.000016 0.000018 -0.000077 --0.000014 0.000022 -0.000086 --0.000017 0.000029 -0.000098 --0.000013 0.000069 -0.000110 --0.000032 0.000081 -0.000115 --0.000051 0.000082 -0.000113 --0.000063 0.000071 -0.000107 --0.000067 0.000052 -0.000095 --0.000059 0.000032 -0.000081 --0.000045 0.000019 -0.000071 --0.000035 0.000014 -0.000066 --0.000027 0.000013 -0.000066 --0.000019 0.000017 -0.000069 --0.000010 0.000028 -0.000080 --0.000005 0.000048 -0.000096 -0.000011 0.000088 -0.000118 --0.000014 0.000107 -0.000128 --0.000050 0.000104 -0.000126 --0.000078 0.000084 -0.000115 --0.000082 0.000049 -0.000088 --0.000064 0.000017 -0.000062 --0.000046 0.000006 -0.000054 --0.000038 0.000005 -0.000054 --0.000034 0.000004 -0.000054 --0.000028 0.000004 -0.000055 --0.000013 0.000017 -0.000066 -0.000007 0.000050 -0.000092 -0.000029 0.000064 -0.000102 --0.000002 0.000071 -0.000119 --0.000045 0.000067 -0.000117 --0.000082 0.000056 -0.000097 --0.000094 0.000032 -0.000061 --0.000082 0.000009 -0.000030 --0.000064 0.000005 -0.000025 --0.000050 0.000008 -0.000034 --0.000038 0.000008 -0.000037 --0.000025 0.000009 -0.000038 --0.000002 0.000019 -0.000047 -0.000025 0.000041 -0.000071 -0.000029 0.000036 -0.000098 -0.000004 0.000046 -0.000140 --0.000045 0.000044 -0.000140 --0.000080 0.000033 -0.000096 --0.000085 0.000012 -0.000044 --0.000076 -0.000004 -0.000016 --0.000068 -0.000008 -0.000012 --0.000058 -0.000005 -0.000019 --0.000045 -0.000002 -0.000025 --0.000028 -0.000001 -0.000026 --0.000004 0.000001 -0.000029 -0.000021 0.000015 -0.000051 -0.000024 0.000005 -0.000095 -0.000005 0.000011 -0.000150 --0.000044 0.000011 -0.000153 --0.000076 0.000006 -0.000094 --0.000078 -0.000001 -0.000038 --0.000070 -0.000008 -0.000015 --0.000064 -0.000010 -0.000009 --0.000059 -0.000012 -0.000014 --0.000048 -0.000012 -0.000019 --0.000031 -0.000011 -0.000021 --0.000009 -0.000009 -0.000025 -0.000013 -0.000003 -0.000046 -0.000022 -0.000026 -0.000097 -0.000002 -0.000028 -0.000153 --0.000044 -0.000025 -0.000155 --0.000076 -0.000020 -0.000097 --0.000076 -0.000014 -0.000042 --0.000067 -0.000012 -0.000017 --0.000061 -0.000012 -0.000012 --0.000054 -0.000016 -0.000018 --0.000046 -0.000019 -0.000024 --0.000033 -0.000020 -0.000025 --0.000013 -0.000020 -0.000029 -0.000010 -0.000021 -0.000049 -0.000019 -0.000058 -0.000107 --0.000003 -0.000066 -0.000150 --0.000048 -0.000061 -0.000151 --0.000078 -0.000050 -0.000107 --0.000078 -0.000030 -0.000054 --0.000066 -0.000016 -0.000026 --0.000054 -0.000017 -0.000025 --0.000044 -0.000020 -0.000032 --0.000039 -0.000020 -0.000035 --0.000033 -0.000021 -0.000036 --0.000017 -0.000027 -0.000041 -0.000007 -0.000041 -0.000062 -0.000007 -0.000083 -0.000124 --0.000016 -0.000089 -0.000139 --0.000052 -0.000084 -0.000138 --0.000077 -0.000073 -0.000119 --0.000080 -0.000049 -0.000082 --0.000060 -0.000027 -0.000054 --0.000039 -0.000020 -0.000049 --0.000032 -0.000017 -0.000050 --0.000032 -0.000013 -0.000048 --0.000030 -0.000014 -0.000048 --0.000019 -0.000029 -0.000061 -0.000001 -0.000058 -0.000093 --0.000018 -0.000079 -0.000138 --0.000037 -0.000085 -0.000141 --0.000055 -0.000085 -0.000137 --0.000066 -0.000078 -0.000130 --0.000066 -0.000057 -0.000114 --0.000050 -0.000033 -0.000094 --0.000031 -0.000014 -0.000076 --0.000025 -0.000005 -0.000065 --0.000026 -0.000002 -0.000062 --0.000024 -0.000006 -0.000065 --0.000015 -0.000024 -0.000083 --0.000010 -0.000056 -0.000115 --0.000037 -0.000045 -0.000145 --0.000049 -0.000056 -0.000161 +-0.000039 0.000020 -0.000080 +-0.000029 0.000017 -0.000074 +-0.000021 0.000017 -0.000073 +-0.000015 0.000018 -0.000077 +-0.000013 0.000023 -0.000086 +-0.000016 0.000029 -0.000099 +-0.000013 0.000069 -0.000111 +-0.000032 0.000082 -0.000115 +-0.000050 0.000082 -0.000113 +-0.000062 0.000071 -0.000107 +-0.000066 0.000051 -0.000095 +-0.000058 0.000031 -0.000081 +-0.000044 0.000019 -0.000071 +-0.000034 0.000014 -0.000067 +-0.000026 0.000013 -0.000066 +-0.000018 0.000017 -0.000070 +-0.000009 0.000028 -0.000080 +-0.000005 0.000048 -0.000097 +0.000012 0.000089 -0.000119 +-0.000013 0.000107 -0.000128 +-0.000049 0.000103 -0.000126 +-0.000077 0.000083 -0.000115 +-0.000080 0.000048 -0.000088 +-0.000062 0.000016 -0.000062 +-0.000044 0.000005 -0.000054 +-0.000037 0.000005 -0.000054 +-0.000033 0.000004 -0.000054 +-0.000027 0.000005 -0.000056 +-0.000011 0.000018 -0.000067 +0.000009 0.000051 -0.000093 +0.000030 0.000064 -0.000104 +-0.000001 0.000071 -0.000120 +-0.000044 0.000066 -0.000117 +-0.000081 0.000055 -0.000096 +-0.000092 0.000031 -0.000059 +-0.000080 0.000008 -0.000029 +-0.000062 0.000004 -0.000025 +-0.000048 0.000008 -0.000034 +-0.000036 0.000008 -0.000038 +-0.000023 0.000010 -0.000040 +-0.000000 0.000020 -0.000049 +0.000027 0.000042 -0.000073 +0.000031 0.000037 -0.000101 +0.000006 0.000046 -0.000141 +-0.000043 0.000043 -0.000139 +-0.000078 0.000032 -0.000094 +-0.000083 0.000011 -0.000042 +-0.000073 -0.000005 -0.000014 +-0.000066 -0.000008 -0.000011 +-0.000056 -0.000005 -0.000019 +-0.000043 -0.000002 -0.000025 +-0.000025 -0.000001 -0.000027 +-0.000001 0.000002 -0.000031 +0.000023 0.000016 -0.000054 +0.000027 0.000005 -0.000098 +0.000007 0.000011 -0.000152 +-0.000042 0.000011 -0.000152 +-0.000074 0.000006 -0.000091 +-0.000075 -0.000002 -0.000036 +-0.000067 -0.000008 -0.000013 +-0.000062 -0.000010 -0.000009 +-0.000057 -0.000012 -0.000014 +-0.000046 -0.000012 -0.000020 +-0.000028 -0.000011 -0.000023 +-0.000006 -0.000009 -0.000028 +0.000016 -0.000003 -0.000050 +0.000024 -0.000026 -0.000101 +0.000004 -0.000028 -0.000155 +-0.000043 -0.000025 -0.000154 +-0.000074 -0.000020 -0.000094 +-0.000073 -0.000014 -0.000039 +-0.000065 -0.000011 -0.000016 +-0.000058 -0.000012 -0.000012 +-0.000052 -0.000016 -0.000018 +-0.000043 -0.000019 -0.000024 +-0.000030 -0.000020 -0.000027 +-0.000010 -0.000020 -0.000032 +0.000013 -0.000022 -0.000053 +0.000021 -0.000059 -0.000110 +-0.000002 -0.000066 -0.000151 +-0.000047 -0.000061 -0.000150 +-0.000076 -0.000049 -0.000105 +-0.000076 -0.000029 -0.000052 +-0.000063 -0.000015 -0.000024 +-0.000052 -0.000017 -0.000024 +-0.000042 -0.000020 -0.000032 +-0.000037 -0.000020 -0.000036 +-0.000030 -0.000022 -0.000038 +-0.000015 -0.000028 -0.000044 +0.000009 -0.000042 -0.000066 +0.000008 -0.000084 -0.000126 +-0.000015 -0.000089 -0.000140 +-0.000051 -0.000084 -0.000138 +-0.000076 -0.000073 -0.000118 +-0.000078 -0.000048 -0.000080 +-0.000058 -0.000026 -0.000053 +-0.000038 -0.000020 -0.000048 +-0.000030 -0.000017 -0.000050 +-0.000030 -0.000014 -0.000049 +-0.000028 -0.000015 -0.000050 +-0.000016 -0.000030 -0.000064 +0.000003 -0.000059 -0.000095 +-0.000017 -0.000080 -0.000139 +-0.000037 -0.000086 -0.000142 +-0.000054 -0.000085 -0.000137 +-0.000065 -0.000077 -0.000130 +-0.000065 -0.000057 -0.000114 +-0.000049 -0.000033 -0.000093 +-0.000030 -0.000014 -0.000075 +-0.000024 -0.000005 -0.000065 +-0.000025 -0.000002 -0.000062 +-0.000022 -0.000006 -0.000066 +-0.000014 -0.000025 -0.000084 +-0.000009 -0.000056 -0.000116 +-0.000036 -0.000045 -0.000145 +-0.000048 -0.000056 -0.000162 -0.000054 -0.000064 -0.000165 --0.000057 -0.000058 -0.000159 --0.000052 -0.000039 -0.000146 --0.000041 -0.000019 -0.000120 --0.000029 -0.000003 -0.000094 --0.000023 0.000006 -0.000079 --0.000020 0.000006 -0.000075 --0.000019 0.000001 -0.000080 --0.000017 -0.000012 -0.000096 --0.000022 -0.000031 -0.000120 --0.000041 -0.000004 -0.000144 +-0.000056 -0.000058 -0.000159 +-0.000052 -0.000039 -0.000145 +-0.000040 -0.000018 -0.000120 +-0.000029 -0.000002 -0.000094 +-0.000022 0.000006 -0.000080 +-0.000019 0.000006 -0.000076 +-0.000018 0.000001 -0.000081 +-0.000016 -0.000013 -0.000097 +-0.000022 -0.000031 -0.000121 +-0.000041 -0.000004 -0.000145 -0.000047 -0.000007 -0.000171 -0.000051 -0.000008 -0.000185 --0.000056 -0.000005 -0.000180 +-0.000055 -0.000005 -0.000180 -0.000050 -0.000000 -0.000159 -0.000038 0.000006 -0.000127 --0.000029 0.000011 -0.000101 --0.000022 0.000014 -0.000087 --0.000018 0.000014 -0.000082 --0.000017 0.000012 -0.000087 --0.000020 0.000007 -0.000100 --0.000030 0.000001 -0.000120 --0.000037 0.000035 -0.000136 --0.000047 0.000041 -0.000151 +-0.000028 0.000011 -0.000101 +-0.000021 0.000014 -0.000087 +-0.000017 0.000014 -0.000083 +-0.000016 0.000011 -0.000087 +-0.000019 0.000006 -0.000101 +-0.000029 0.000001 -0.000120 +-0.000037 0.000035 -0.000137 +-0.000046 0.000041 -0.000152 -0.000052 0.000048 -0.000155 -0.000055 0.000047 -0.000150 --0.000051 0.000036 -0.000138 --0.000043 0.000028 -0.000118 --0.000034 0.000023 -0.000096 --0.000026 0.000020 -0.000083 --0.000020 0.000019 -0.000080 --0.000016 0.000021 -0.000084 --0.000016 0.000025 -0.000097 --0.000024 0.000031 -0.000115 --0.000021 0.000068 -0.000121 --0.000037 0.000070 -0.000120 --0.000051 0.000070 -0.000116 --0.000060 0.000065 -0.000110 +-0.000050 0.000036 -0.000138 +-0.000042 0.000028 -0.000118 +-0.000034 0.000023 -0.000097 +-0.000025 0.000019 -0.000084 +-0.000019 0.000019 -0.000080 +-0.000015 0.000021 -0.000085 +-0.000015 0.000025 -0.000098 +-0.000024 0.000031 -0.000116 +-0.000020 0.000068 -0.000122 +-0.000036 0.000070 -0.000121 +-0.000050 0.000070 -0.000116 +-0.000059 0.000065 -0.000110 -0.000064 0.000055 -0.000103 --0.000058 0.000043 -0.000095 --0.000043 0.000030 -0.000082 --0.000032 0.000021 -0.000071 --0.000024 0.000018 -0.000068 --0.000016 0.000023 -0.000073 --0.000008 0.000037 -0.000088 --0.000010 0.000056 -0.000109 -0.000008 0.000077 -0.000107 --0.000016 0.000078 -0.000107 --0.000047 0.000073 -0.000105 --0.000073 0.000066 -0.000097 --0.000087 0.000051 -0.000079 --0.000077 0.000033 -0.000061 --0.000054 0.000022 -0.000054 --0.000039 0.000018 -0.000053 --0.000031 0.000014 -0.000053 --0.000020 0.000017 -0.000056 --0.000003 0.000035 -0.000072 -0.000011 0.000062 -0.000096 -0.000036 0.000033 -0.000060 -0.000004 0.000030 -0.000064 --0.000037 0.000023 -0.000062 --0.000075 0.000016 -0.000051 --0.000103 0.000010 -0.000034 --0.000109 0.000004 -0.000021 --0.000090 0.000009 -0.000027 --0.000062 0.000015 -0.000039 --0.000036 0.000017 -0.000045 --0.000011 0.000020 -0.000049 -0.000016 0.000028 -0.000054 -0.000038 0.000034 -0.000057 -0.000038 0.000017 -0.000061 -0.000007 0.000016 -0.000077 --0.000038 0.000012 -0.000074 --0.000078 0.000009 -0.000053 --0.000100 0.000003 -0.000030 --0.000105 -0.000004 -0.000017 --0.000094 -0.000005 -0.000018 --0.000070 -0.000001 -0.000027 --0.000041 0.000003 -0.000035 --0.000010 0.000006 -0.000039 -0.000021 0.000008 -0.000041 -0.000042 0.000012 -0.000046 -0.000039 0.000004 -0.000064 -0.000010 0.000005 -0.000086 --0.000040 0.000006 -0.000085 --0.000082 0.000006 -0.000056 --0.000099 0.000002 -0.000030 --0.000100 -0.000003 -0.000020 --0.000090 -0.000007 -0.000019 --0.000070 -0.000008 -0.000025 --0.000043 -0.000009 -0.000032 --0.000012 -0.000008 -0.000036 -0.000019 -0.000005 -0.000039 -0.000039 0.000000 -0.000046 -0.000038 -0.000011 -0.000063 -0.000009 -0.000005 -0.000086 --0.000041 -0.000000 -0.000085 --0.000081 0.000000 -0.000057 --0.000097 -0.000001 -0.000031 --0.000099 -0.000003 -0.000020 --0.000089 -0.000007 -0.000020 --0.000066 -0.000014 -0.000028 --0.000041 -0.000019 -0.000035 --0.000013 -0.000020 -0.000039 -0.000016 -0.000018 -0.000042 -0.000038 -0.000015 -0.000047 -0.000032 -0.000031 -0.000066 -0.000002 -0.000024 -0.000083 +-0.000057 0.000043 -0.000095 +-0.000042 0.000030 -0.000082 +-0.000031 0.000021 -0.000071 +-0.000023 0.000019 -0.000069 +-0.000015 0.000023 -0.000074 +-0.000007 0.000038 -0.000089 +-0.000009 0.000057 -0.000110 +0.000009 0.000078 -0.000108 +-0.000016 0.000078 -0.000108 +-0.000046 0.000073 -0.000105 +-0.000072 0.000065 -0.000097 +-0.000086 0.000050 -0.000079 +-0.000075 0.000032 -0.000061 +-0.000052 0.000022 -0.000054 +-0.000037 0.000017 -0.000054 +-0.000029 0.000014 -0.000053 +-0.000018 0.000018 -0.000057 +-0.000002 0.000036 -0.000073 +0.000013 0.000063 -0.000097 +0.000037 0.000034 -0.000061 +0.000005 0.000030 -0.000065 +-0.000036 0.000023 -0.000062 +-0.000074 0.000016 -0.000050 +-0.000102 0.000010 -0.000033 +-0.000107 0.000004 -0.000020 +-0.000089 0.000009 -0.000026 +-0.000060 0.000015 -0.000039 +-0.000034 0.000017 -0.000046 +-0.000009 0.000021 -0.000050 +0.000017 0.000029 -0.000055 +0.000040 0.000035 -0.000059 +0.000039 0.000017 -0.000063 +0.000008 0.000016 -0.000078 +-0.000037 0.000012 -0.000074 +-0.000077 0.000009 -0.000052 +-0.000099 0.000002 -0.000028 +-0.000104 -0.000005 -0.000016 +-0.000093 -0.000005 -0.000018 +-0.000068 -0.000001 -0.000027 +-0.000039 0.000003 -0.000036 +-0.000009 0.000006 -0.000041 +0.000022 0.000009 -0.000043 +0.000043 0.000013 -0.000049 +0.000040 0.000004 -0.000066 +0.000011 0.000006 -0.000087 +-0.000039 0.000006 -0.000084 +-0.000080 0.000006 -0.000054 +-0.000097 0.000002 -0.000029 +-0.000098 -0.000003 -0.000019 +-0.000088 -0.000007 -0.000018 +-0.000068 -0.000008 -0.000025 +-0.000041 -0.000009 -0.000033 +-0.000010 -0.000008 -0.000038 +0.000020 -0.000005 -0.000042 +0.000040 0.000000 -0.000049 +0.000040 -0.000011 -0.000066 +0.000010 -0.000006 -0.000088 +-0.000040 -0.000000 -0.000085 +-0.000080 0.000000 -0.000055 +-0.000096 -0.000001 -0.000029 +-0.000098 -0.000003 -0.000019 +-0.000087 -0.000007 -0.000019 +-0.000065 -0.000014 -0.000028 +-0.000039 -0.000019 -0.000036 +-0.000011 -0.000020 -0.000041 +0.000018 -0.000018 -0.000045 +0.000039 -0.000015 -0.000049 +0.000033 -0.000031 -0.000069 +0.000003 -0.000024 -0.000084 -0.000040 -0.000016 -0.000082 --0.000076 -0.000012 -0.000061 --0.000096 -0.000010 -0.000036 --0.000098 -0.000009 -0.000024 --0.000081 -0.000017 -0.000030 --0.000056 -0.000024 -0.000040 --0.000035 -0.000025 -0.000046 --0.000015 -0.000028 -0.000050 -0.000008 -0.000033 -0.000053 -0.000030 -0.000035 -0.000057 -0.000007 -0.000063 -0.000092 --0.000012 -0.000050 -0.000089 +-0.000075 -0.000012 -0.000060 +-0.000095 -0.000009 -0.000035 +-0.000097 -0.000008 -0.000023 +-0.000080 -0.000017 -0.000030 +-0.000054 -0.000024 -0.000041 +-0.000033 -0.000026 -0.000047 +-0.000013 -0.000029 -0.000051 +0.000010 -0.000033 -0.000056 +0.000032 -0.000035 -0.000059 +0.000008 -0.000063 -0.000093 +-0.000012 -0.000050 -0.000090 -0.000043 -0.000040 -0.000089 --0.000070 -0.000034 -0.000079 --0.000087 -0.000030 -0.000060 --0.000079 -0.000033 -0.000055 --0.000054 -0.000036 -0.000062 --0.000037 -0.000030 -0.000063 --0.000027 -0.000025 -0.000061 --0.000017 -0.000029 -0.000065 --0.000007 -0.000044 -0.000076 -0.000004 -0.000061 -0.000090 --0.000039 -0.000081 -0.000140 --0.000046 -0.000073 -0.000133 +-0.000069 -0.000034 -0.000078 +-0.000086 -0.000030 -0.000059 +-0.000077 -0.000033 -0.000055 +-0.000053 -0.000036 -0.000062 +-0.000035 -0.000030 -0.000063 +-0.000025 -0.000026 -0.000062 +-0.000016 -0.000030 -0.000066 +-0.000005 -0.000044 -0.000078 +0.000005 -0.000062 -0.000092 +-0.000038 -0.000082 -0.000141 +-0.000045 -0.000073 -0.000133 -0.000052 -0.000063 -0.000124 -0.000058 -0.000057 -0.000119 --0.000055 -0.000056 -0.000118 --0.000039 -0.000055 -0.000116 --0.000024 -0.000039 -0.000100 --0.000020 -0.000021 -0.000081 --0.000020 -0.000015 -0.000075 --0.000018 -0.000020 -0.000079 --0.000018 -0.000039 -0.000097 --0.000027 -0.000066 -0.000125 --0.000067 -0.000055 -0.000173 --0.000072 -0.000064 -0.000199 --0.000061 -0.000063 -0.000203 --0.000046 -0.000059 -0.000200 --0.000027 -0.000053 -0.000190 --0.000014 -0.000039 -0.000159 --0.000013 -0.000018 -0.000119 --0.000014 -0.000003 -0.000094 --0.000015 -0.000001 -0.000086 --0.000018 -0.000007 -0.000092 --0.000025 -0.000020 -0.000109 --0.000044 -0.000038 -0.000136 --0.000068 -0.000003 -0.000177 --0.000073 -0.000007 -0.000227 +-0.000054 -0.000056 -0.000117 +-0.000038 -0.000055 -0.000116 +-0.000023 -0.000039 -0.000099 +-0.000019 -0.000021 -0.000082 +-0.000019 -0.000015 -0.000075 +-0.000017 -0.000020 -0.000080 +-0.000017 -0.000039 -0.000099 +-0.000027 -0.000067 -0.000126 +-0.000067 -0.000055 -0.000174 +-0.000072 -0.000064 -0.000200 +-0.000060 -0.000063 -0.000203 +-0.000046 -0.000059 -0.000199 +-0.000026 -0.000053 -0.000190 +-0.000013 -0.000039 -0.000159 +-0.000012 -0.000018 -0.000119 +-0.000013 -0.000003 -0.000094 +-0.000015 -0.000001 -0.000087 +-0.000017 -0.000007 -0.000093 +-0.000024 -0.000020 -0.000110 +-0.000044 -0.000038 -0.000137 +-0.000067 -0.000003 -0.000177 +-0.000073 -0.000007 -0.000228 -0.000062 -0.000009 -0.000254 -0.000043 -0.000008 -0.000251 --0.000023 -0.000003 -0.000220 +-0.000023 -0.000003 -0.000219 -0.000013 0.000003 -0.000166 --0.000013 0.000008 -0.000123 --0.000013 0.000012 -0.000100 --0.000013 0.000012 -0.000092 --0.000017 0.000009 -0.000097 --0.000029 0.000005 -0.000112 --0.000048 0.000001 -0.000135 --0.000064 0.000047 -0.000164 --0.000068 0.000050 -0.000189 --0.000059 0.000048 -0.000193 --0.000047 0.000046 -0.000190 +-0.000012 0.000008 -0.000123 +-0.000012 0.000012 -0.000101 +-0.000013 0.000012 -0.000093 +-0.000017 0.000009 -0.000098 +-0.000028 0.000005 -0.000113 +-0.000048 0.000000 -0.000136 +-0.000063 0.000047 -0.000165 +-0.000068 0.000050 -0.000190 +-0.000059 0.000048 -0.000194 +-0.000046 0.000046 -0.000190 -0.000029 0.000047 -0.000180 --0.000018 0.000043 -0.000153 +-0.000017 0.000042 -0.000153 -0.000018 0.000032 -0.000117 -0.000018 0.000023 -0.000095 --0.000016 0.000021 -0.000088 --0.000016 0.000024 -0.000093 --0.000024 0.000028 -0.000107 --0.000043 0.000037 -0.000131 --0.000035 0.000074 -0.000127 --0.000041 0.000063 -0.000116 +-0.000015 0.000021 -0.000089 +-0.000015 0.000024 -0.000094 +-0.000024 0.000028 -0.000108 +-0.000043 0.000037 -0.000132 +-0.000035 0.000075 -0.000127 +-0.000041 0.000063 -0.000117 -0.000049 0.000052 -0.000105 --0.000058 0.000048 -0.000100 --0.000058 0.000053 -0.000104 --0.000047 0.000060 -0.000110 --0.000035 0.000048 -0.000098 --0.000028 0.000032 -0.000081 --0.000021 0.000026 -0.000076 --0.000014 0.000032 -0.000082 --0.000013 0.000046 -0.000097 --0.000024 0.000066 -0.000117 -0.000012 0.000060 -0.000079 --0.000007 0.000046 -0.000067 +-0.000057 0.000048 -0.000100 +-0.000057 0.000053 -0.000104 +-0.000046 0.000059 -0.000110 +-0.000034 0.000048 -0.000098 +-0.000027 0.000032 -0.000081 +-0.000020 0.000026 -0.000076 +-0.000013 0.000032 -0.000083 +-0.000012 0.000047 -0.000098 +-0.000023 0.000066 -0.000118 +0.000013 0.000060 -0.000080 +-0.000007 0.000046 -0.000068 -0.000040 0.000036 -0.000067 --0.000070 0.000030 -0.000061 --0.000093 0.000029 -0.000051 --0.000091 0.000034 -0.000052 --0.000065 0.000036 -0.000060 --0.000043 0.000030 -0.000060 --0.000028 0.000025 -0.000060 --0.000013 0.000030 -0.000065 -0.000002 0.000046 -0.000078 -0.000011 0.000062 -0.000088 -0.000060 0.000001 -0.000028 -0.000029 -0.000019 -0.000016 +-0.000069 0.000030 -0.000061 +-0.000093 0.000029 -0.000050 +-0.000090 0.000034 -0.000052 +-0.000064 0.000035 -0.000059 +-0.000042 0.000029 -0.000061 +-0.000027 0.000025 -0.000061 +-0.000011 0.000030 -0.000066 +0.000003 0.000046 -0.000079 +0.000012 0.000063 -0.000089 +0.000060 0.000001 -0.000029 +0.000029 -0.000019 -0.000017 -0.000026 -0.000032 -0.000016 --0.000082 -0.000038 -0.000012 --0.000126 -0.000034 -0.000006 --0.000137 -0.000020 -0.000015 +-0.000081 -0.000038 -0.000011 +-0.000125 -0.000034 -0.000006 +-0.000137 -0.000021 -0.000014 -0.000111 0.000001 -0.000038 --0.000072 0.000015 -0.000055 --0.000035 0.000020 -0.000062 --0.000004 0.000024 -0.000064 -0.000026 0.000027 -0.000061 -0.000053 0.000021 -0.000049 -0.000053 0.000002 -0.000038 -0.000021 -0.000006 -0.000034 +-0.000071 0.000015 -0.000055 +-0.000035 0.000020 -0.000063 +-0.000003 0.000024 -0.000065 +0.000027 0.000027 -0.000063 +0.000053 0.000021 -0.000051 +0.000054 0.000002 -0.000040 +0.000021 -0.000006 -0.000035 -0.000031 -0.000013 -0.000031 --0.000082 -0.000015 -0.000024 --0.000116 -0.000015 -0.000020 --0.000126 -0.000013 -0.000025 --0.000110 -0.000006 -0.000038 --0.000077 0.000002 -0.000049 --0.000039 0.000007 -0.000055 --0.000003 0.000010 -0.000058 -0.000030 0.000010 -0.000055 -0.000053 0.000008 -0.000047 -0.000051 0.000006 -0.000043 -0.000021 0.000007 -0.000042 +-0.000081 -0.000015 -0.000023 +-0.000115 -0.000015 -0.000019 +-0.000125 -0.000013 -0.000024 +-0.000109 -0.000006 -0.000037 +-0.000076 0.000002 -0.000049 +-0.000039 0.000007 -0.000056 +-0.000002 0.000010 -0.000059 +0.000031 0.000010 -0.000057 +0.000054 0.000008 -0.000049 +0.000052 0.000006 -0.000045 +0.000021 0.000007 -0.000043 -0.000034 0.000007 -0.000039 --0.000085 0.000008 -0.000030 --0.000113 0.000004 -0.000025 --0.000118 -0.000000 -0.000030 --0.000105 -0.000004 -0.000040 --0.000077 -0.000006 -0.000049 --0.000040 -0.000006 -0.000054 --0.000003 -0.000005 -0.000056 -0.000029 -0.000003 -0.000054 -0.000050 0.000002 -0.000048 -0.000053 0.000006 -0.000040 -0.000022 0.000018 -0.000039 +-0.000084 0.000007 -0.000029 +-0.000112 0.000004 -0.000024 +-0.000118 -0.000000 -0.000029 +-0.000104 -0.000004 -0.000039 +-0.000076 -0.000006 -0.000049 +-0.000040 -0.000006 -0.000055 +-0.000002 -0.000005 -0.000058 +0.000030 -0.000003 -0.000056 +0.000051 0.000002 -0.000051 +0.000054 0.000006 -0.000043 +0.000023 0.000018 -0.000040 -0.000034 0.000027 -0.000036 --0.000085 0.000027 -0.000028 --0.000114 0.000020 -0.000023 --0.000120 0.000011 -0.000028 +-0.000084 0.000027 -0.000026 +-0.000113 0.000020 -0.000021 +-0.000119 0.000011 -0.000027 -0.000104 -0.000001 -0.000040 -0.000073 -0.000012 -0.000051 --0.000038 -0.000018 -0.000057 --0.000004 -0.000019 -0.000059 -0.000027 -0.000015 -0.000056 -0.000050 -0.000007 -0.000048 -0.000057 0.000003 -0.000034 -0.000026 0.000027 -0.000027 +-0.000037 -0.000018 -0.000058 +-0.000003 -0.000019 -0.000061 +0.000028 -0.000016 -0.000059 +0.000051 -0.000007 -0.000051 +0.000057 0.000003 -0.000035 +0.000027 0.000027 -0.000027 -0.000030 0.000042 -0.000027 --0.000083 0.000044 -0.000020 --0.000121 0.000035 -0.000013 --0.000128 0.000018 -0.000022 --0.000102 -0.000006 -0.000044 --0.000065 -0.000021 -0.000059 --0.000033 -0.000026 -0.000065 --0.000006 -0.000029 -0.000067 -0.000021 -0.000029 -0.000064 -0.000048 -0.000020 -0.000052 -0.000037 -0.000026 -0.000049 -0.000024 0.000016 -0.000023 +-0.000083 0.000044 -0.000019 +-0.000120 0.000036 -0.000012 +-0.000127 0.000018 -0.000021 +-0.000101 -0.000006 -0.000043 +-0.000064 -0.000021 -0.000059 +-0.000033 -0.000026 -0.000066 +-0.000005 -0.000029 -0.000068 +0.000022 -0.000029 -0.000066 +0.000048 -0.000020 -0.000054 +0.000037 -0.000026 -0.000050 +0.000025 0.000016 -0.000023 -0.000025 0.000039 -0.000025 --0.000083 0.000044 -0.000023 --0.000120 0.000030 -0.000015 --0.000112 -0.000007 -0.000040 --0.000074 -0.000030 -0.000068 --0.000046 -0.000032 -0.000076 --0.000026 -0.000030 -0.000077 --0.000010 -0.000034 -0.000079 -0.000004 -0.000044 -0.000080 -0.000020 -0.000048 -0.000075 --0.000040 -0.000076 -0.000122 +-0.000083 0.000044 -0.000022 +-0.000120 0.000030 -0.000014 +-0.000111 -0.000007 -0.000039 +-0.000074 -0.000030 -0.000067 +-0.000045 -0.000032 -0.000076 +-0.000025 -0.000030 -0.000078 +-0.000009 -0.000035 -0.000080 +0.000004 -0.000044 -0.000082 +0.000021 -0.000048 -0.000077 +-0.000040 -0.000076 -0.000123 -0.000030 -0.000037 -0.000095 --0.000039 0.000008 -0.000076 +-0.000038 0.000008 -0.000076 -0.000067 0.000013 -0.000075 --0.000066 -0.000024 -0.000091 --0.000037 -0.000058 -0.000116 --0.000021 -0.000049 -0.000112 --0.000019 -0.000030 -0.000096 --0.000017 -0.000024 -0.000089 --0.000016 -0.000029 -0.000091 --0.000021 -0.000044 -0.000102 --0.000035 -0.000068 -0.000119 --0.000120 -0.000078 -0.000197 +-0.000065 -0.000024 -0.000090 +-0.000036 -0.000058 -0.000116 +-0.000020 -0.000049 -0.000112 +-0.000018 -0.000030 -0.000097 +-0.000016 -0.000025 -0.000090 +-0.000015 -0.000029 -0.000093 +-0.000021 -0.000044 -0.000103 +-0.000035 -0.000068 -0.000120 +-0.000119 -0.000078 -0.000197 -0.000126 -0.000075 -0.000242 -0.000083 -0.000033 -0.000244 --0.000022 -0.000029 -0.000243 -0.000030 -0.000066 -0.000240 -0.000041 -0.000066 -0.000195 +-0.000022 -0.000029 -0.000242 +0.000030 -0.000066 -0.000239 +0.000041 -0.000066 -0.000194 0.000018 -0.000033 -0.000139 --0.000000 -0.000011 -0.000108 --0.000010 -0.000008 -0.000098 --0.000020 -0.000013 -0.000100 --0.000040 -0.000024 -0.000113 --0.000077 -0.000047 -0.000143 +0.000000 -0.000011 -0.000108 +-0.000009 -0.000008 -0.000099 +-0.000020 -0.000013 -0.000101 +-0.000040 -0.000024 -0.000114 +-0.000077 -0.000047 -0.000144 -0.000139 -0.000006 -0.000214 --0.000171 -0.000012 -0.000318 +-0.000171 -0.000012 -0.000319 -0.000114 -0.000015 -0.000369 0.000007 -0.000014 -0.000368 0.000075 -0.000009 -0.000318 0.000059 -0.000002 -0.000212 -0.000023 0.000005 -0.000138 -0.000003 0.000010 -0.000110 --0.000007 0.000010 -0.000101 --0.000021 0.000007 -0.000103 --0.000047 0.000004 -0.000115 --0.000086 -0.000001 -0.000141 --0.000115 0.000066 -0.000190 +0.000024 0.000005 -0.000138 +0.000004 0.000010 -0.000110 +-0.000006 0.000010 -0.000102 +-0.000021 0.000007 -0.000104 +-0.000046 0.000004 -0.000115 +-0.000085 -0.000001 -0.000142 +-0.000114 0.000066 -0.000190 -0.000123 0.000057 -0.000236 --0.000083 0.000011 -0.000239 +-0.000083 0.000011 -0.000240 -0.000023 0.000009 -0.000238 0.000026 0.000053 -0.000232 0.000033 0.000063 -0.000186 -0.000009 0.000041 -0.000134 +0.000010 0.000041 -0.000134 -0.000006 0.000026 -0.000106 --0.000011 0.000024 -0.000097 --0.000018 0.000026 -0.000099 --0.000038 0.000030 -0.000111 --0.000073 0.000044 -0.000138 --0.000036 0.000071 -0.000115 --0.000025 0.000030 -0.000084 +-0.000010 0.000024 -0.000098 +-0.000018 0.000026 -0.000100 +-0.000038 0.000030 -0.000112 +-0.000073 0.000044 -0.000139 +-0.000036 0.000071 -0.000116 +-0.000025 0.000030 -0.000085 -0.000035 -0.000020 -0.000059 -0.000070 -0.000025 -0.000057 -0.000073 0.000018 -0.000077 --0.000048 0.000058 -0.000107 +-0.000047 0.000058 -0.000107 -0.000033 0.000054 -0.000106 -0.000027 0.000038 -0.000092 -0.000019 0.000033 -0.000087 --0.000013 0.000038 -0.000089 --0.000016 0.000049 -0.000099 --0.000030 0.000067 -0.000113 -0.000043 0.000026 -0.000041 +-0.000013 0.000038 -0.000090 +-0.000016 0.000049 -0.000100 +-0.000030 0.000067 -0.000114 +0.000043 0.000026 -0.000042 0.000032 -0.000017 -0.000009 -0.000021 -0.000042 -0.000010 --0.000085 -0.000047 -0.000008 +-0.000084 -0.000047 -0.000008 -0.000129 -0.000033 -0.000001 --0.000125 0.000005 -0.000029 --0.000087 0.000029 -0.000061 --0.000054 0.000031 -0.000071 --0.000029 0.000031 -0.000073 --0.000008 0.000035 -0.000076 -0.000009 0.000045 -0.000078 -0.000025 0.000048 -0.000071 +-0.000124 0.000005 -0.000029 +-0.000086 0.000029 -0.000060 +-0.000053 0.000031 -0.000071 +-0.000028 0.000031 -0.000074 +-0.000007 0.000035 -0.000077 +0.000010 0.000045 -0.000079 +0.000026 0.000049 -0.000072 diff --git a/testsuite/python/minimize_energy.py b/testsuite/python/minimize_energy.py index af6bf92c76a..7e51068c1bd 100644 --- a/testsuite/python/minimize_energy.py +++ b/testsuite/python/minimize_energy.py @@ -26,6 +26,10 @@ class test_minimize_energy(ut.TestCase): system = espressomd.System(box_l=[10.0, 10.0, 10.0]) + test_rotation = espressomd.has_features(("ROTATION", "DIPOLES")) + if test_rotation: + from espressomd.constraints import HomogeneousMagneticField + @classmethod def setUpClass(cls): np.random.seed(42) @@ -46,6 +50,9 @@ def setUp(self): self.system.non_bonded_inter[0, 0].lennard_jones.set_params( epsilon=self.lj_eps, sigma=self.lj_sig, cutoff=self.lj_cut, shift="auto") + if self.test_rotation: + self.system.constraints.add( + self.HomogeneousMagneticField(H=[-0.5, 0, 0])) def tearDown(self): self.system.part.clear() @@ -53,21 +60,32 @@ def tearDown(self): def test_relaxation(self): for i in range(self.n_part): - self.system.part.add( + p = self.system.part.add( id=i, pos=np.random.random(3) * self.system.box_l) - + if self.test_rotation: + p.dip = np.random.random(3) + p.dipm = 1 + p.rotation = (1, 1, 1) + # Remove external magnetic field + self.assertNotAlmostEqual( self.system.analysis.energy()["total"], 0, places=10) self.system.integrator.set_steepest_descent( - f_max=0.0, gamma=0.1, max_displacement=0.005) + f_max=0.0, gamma=0.1, max_displacement=0.05) - self.system.integrator.run(200) + self.system.integrator.run(500) + self.system.constraints.clear() + + # Check self.assertAlmostEqual( self.system.analysis.energy()["total"], 0, places=10) np.testing.assert_allclose(np.copy(self.system.part[:].f), 0.) - + if self.test_rotation: + np.testing.assert_allclose(np.copy(self.system.part[:].dip), + np.hstack((-np.ones((self.n_part, 1)), np.zeros((self.n_part, 1)), np.zeros((self.n_part, 1)))), atol=1E-9) + def test_rescaling(self): self.system.part.add(pos=[5., 5., 4.9], type=0) self.system.part.add(pos=[5., 5., 5.1], type=0)