From 00ebe9a3e8ae22aae3e474cc69f4b2f51f270f65 Mon Sep 17 00:00:00 2001 From: Sachith Dunatunga Date: Mon, 9 Dec 2024 08:31:57 -0800 Subject: [PATCH 01/74] Squashed version of Will's commits. --- examples/granular/README_MDR.md | 46 + examples/granular/in.avicelTableting200 | 184 + examples/granular/in.avicelTableting20000 | 184 + .../granular/in.mpfem.triaxial12particles | 100 + .../granular/in.mpfem.triaxial14particles | 164 + examples/granular/spheres.data | 23 + examples/granular/spheres200.data | 211 + examples/granular/spheres20000.data | 20011 ++++++++++++++++ examples/granular/spheresSTLgeneration.data | 21 + src/GRANULAR/fix_wall_gran.cpp | 1 + src/GRANULAR/fix_wall_gran.h | 9 +- src/GRANULAR/fix_wall_gran_region.cpp | 6 + src/GRANULAR/fix_wall_gran_region.h | 20 +- src/GRANULAR/gran_sub_mod_normal.cpp | 770 + src/GRANULAR/gran_sub_mod_normal.h | 15 + src/GRANULAR/gran_sub_mod_rolling.cpp | 5 +- src/GRANULAR/granular_model.cpp | 2 +- src/GRANULAR/granular_model.h | 3 + src/GRANULAR/pair_granular.cpp | 90 + src/GRANULAR/pair_granular.h | 38 +- src/SRD/fix_srd.cpp | 18 +- src/csv_writer.h | 25 + src/fix_ave_chunk.cpp | 4 + src/fix_ave_chunk.h | 2 +- src/fix_mdr_mean_surf_disp.cpp | 539 + src/fix_mdr_mean_surf_disp.h | 46 + src/fix_mdr_radius_update.cpp | 384 + src/fix_mdr_radius_update.h | 66 + src/variable.cpp | 24 +- src/verlet.cpp | 2 +- 30 files changed, 22983 insertions(+), 30 deletions(-) create mode 100644 examples/granular/README_MDR.md create mode 100644 examples/granular/in.avicelTableting200 create mode 100644 examples/granular/in.avicelTableting20000 create mode 100644 examples/granular/in.mpfem.triaxial12particles create mode 100644 examples/granular/in.mpfem.triaxial14particles create mode 100644 examples/granular/spheres.data create mode 100644 examples/granular/spheres200.data create mode 100644 examples/granular/spheres20000.data create mode 100644 examples/granular/spheresSTLgeneration.data create mode 100644 src/csv_writer.h create mode 100644 src/fix_mdr_mean_surf_disp.cpp create mode 100644 src/fix_mdr_mean_surf_disp.h create mode 100644 src/fix_mdr_radius_update.cpp create mode 100644 src/fix_mdr_radius_update.h diff --git a/examples/granular/README_MDR.md b/examples/granular/README_MDR.md new file mode 100644 index 0000000000..74083cef47 --- /dev/null +++ b/examples/granular/README_MDR.md @@ -0,0 +1,46 @@ +# Building the executable: +------------------------------------------------------------------------------- + +CMAKE may be used to build the executable, below is a short shell script that builds a fresh version of the executable. + + #!/bin/bash + + rm -r build + mkdir build; cd build + cmake ../cmake + PKGS="-D PKG_GRANULAR=on -D PKG_VTK=on -D PKG_SRD=on -D PKG_MPI=on" + cmake -C ../cmake/presets/most.cmake -C ../cmake/presets/nolib.cmake $PKGS ../cmake + cmake --build . -- -j 10 + +The GRANULAR package allows DEM simulation in LAMMPS and the VTK package allows creation of VTK files for viewing in paraview. The SRD package is for fluid coupling and the MPI is for parallelization. There are various other ways to build the lammps executable if you are interested: https://docs.lammps.org/Build.html. + + +# Running the code: +------------------------------------------------------------------------------- + +In the sims directory of the code base there is a folder called avicelTableting. Inside there is an input file called in.avicelTableting200. This input file defines a tableting simulation that is composed of die filling, compaction, release, and ejection. The geometry of the simulation is modeled after a real compaction simulator die. The material properties that are set roughly represent Avicel PH102. To run this simulation in serial, navigate inside the avicelTableting folder and run the following command: + + (path to lmp executable) < in.avicelTableting200 + +The simulation consists of 200 particles and takes ~10 minutes to run on a 2021 M1 Max. To generate a new packing with particles of different radii or distribution you can use the matlab script within generatePackings called generateCylinderPacking.m. It allows you to define the cylinder size, number of desired particles, minimum radius, and maximum radius. It will then generate a packing called spheres.data that is saved in the avicelTableting folder. If you change the distribution of the particle packing make sure to update the following items in the input script: + + neighbor - should be ~1.5x greater than the max radius Rmax. + timestep - dt = 0.35*sqrt{m/k} = 0.35*sqrt{(rho*4/3*pi*Rmin^3)/(kappa*Rmin)}. + variable atomRadius - specified value in front of prefactor should match Rmin from generateCylinderPacking.m. + +Once running the program should output three files a dump file and two csv files. The dump file can be used in Ovito for visualization. If you desire vtk files for visualization in Paraview create a folder called post and uncomment the dump command in in.avicelTableting. The generated csv files contain the upper punch displacement force relation and particle stress information. + +Plots of the axial stress and radial stress versus displacement can be generated using the matlab script avicelTabletingPlotStresses.m. The script will work even while the simulation is in the middle of running and is a good way to check on the status of the simulation. + +The other input script in the folder is in.avicelTableting20000 this 20,000 particle simulation is the exact one presented in Zunker et al., 2024 and is most efficiently run in parallel with the following command: + + mpirun --np 4 (path to lmp executable) -in in.avicelTableting20000 + +Anticipate this simulation to take longer to run, on a 2021 M1 Max running in parallel on 4 processors the simulation took 28 hours to complete. + +Also within the sims directory is the MPFEM folder, which contains two small simulations involving the compaction of 14 monodisperse particles and 12 tridisperse particles as described in Zunker et al., 2024. The input files for these simulations can then be run using the following commands: + + (path to lmp executable) < in.triaxial14particles + (path to lmp executable) < in.triaxial12particles + +The outputs of each of these simulations are a dump file and a .csv containing the measured forces in each principal direction. To visualize the measured stresses you can run the Matlab script macro_stresses.m. This will plot stresses for both the LAMMPS results and data from corresponding FEM simulations. The Abaqus 2022 input files for the monodisperse and tridisperse FEM are included in the folder as MPFEM.inp and MPFEM_diff_radii.inp, respectively. For convenience, the principal stress output data for these FEM simulations is already included in the folder as fem.mat and fem_diff_radii.mat. \ No newline at end of file diff --git a/examples/granular/in.avicelTableting200 b/examples/granular/in.avicelTableting200 new file mode 100644 index 0000000000..8fe3251d78 --- /dev/null +++ b/examples/granular/in.avicelTableting200 @@ -0,0 +1,184 @@ +############################### SIMULATION SETTINGS ################################################### + +atom_style sphere 1 +atom_modify map array +comm_modify vel yes +units si +newton off +neighbor 1.0e-3 bin +neigh_modify every 10 delay 2000 check no +timestep 1.35e-7 +#processors 2 2 1 + +######################### SIMULATION BOUNDING BOX, INTEGRATION, AND, GRAVITY ########################### + +boundary f f f +read_data spheres200.data + +######################################### ADD DIE AND ATOM PARAMETERIZATION ############################################## + +variable atomRadius equal 0.44e-3*1.25 +variable atomDiameter equal 2*${atomRadius} +variable atomDensity equal 1560 +variable atomMassAvg equal ${atomDensity}*4.0/3.0*PI*${atomRadius}^3.0 +variable dieRadius equal 4e-3 +variable dieHeight equal 1e-2 + +########################### PARTICLE MATERIAL PROPERTIES AND FORCE MODEL ############################### + +pair_style granular +# mdr = E, nu, Y, gamma, psi_b, CoR +# linear_history = k_t, x_gamma,t, mu_s +variable YoungsModulus equal 5e9 +variable YieldStress equal 1.9e8 +variable PoissonsRatio equal 0.4 +variable SurfaceEnergy equal 2000 +variable SurfaceEnergyWall equal 0.0 +variable CoR equal 0.5 +variable psi_b equal 0.5 +variable beta equal -ln(${CoR})/sqrt(ln(${CoR})^2+PI^2) +variable kt equal 2/7*${YoungsModulus}*${atomRadius} +variable kt_wall equal 2/7*${YoungsModulus}*${atomRadius} +variable xgammat equal 0.0 #${beta}*sqrt(${atomMassAvg}*${YoungsModulus}*${atomRadius}) +variable mu_s equal 0.7 +variable mu_s_wall equal 0.1 +variable mu_roll equal 0.6 +variable k_roll equal 2.25*${mu_roll}*${mu_roll}*${YoungsModulus}*${atomRadius} +variable gamma_roll equal 0.0 #${beta}*sqrt(${atomMassAvg}*${YoungsModulus}*${atomRadius}) + +pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} damping none tangential linear_history ${kt} ${xgammat} ${mu_s} rolling sds ${k_roll} ${gamma_roll} ${mu_roll} +#pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none +#pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_nohistory 0.0 0.0 damping none + +######################################### ADD DIE AND PUNCH WALLS ################################################ + +variable disp_upper equal 0.0 +variable disp_lower equal 0.0 +variable disp_xPlanePos equal 0.0 +variable disp_xPlaneNeg equal 0.0 + +variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} damping none tangential linear_history ${kt_wall} ${xgammat} ${mu_s_wall} rolling sds ${k_roll} ${gamma_roll} ${mu_roll}" +#variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none" +#variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} tangential linear_nohistory 0.0 0.0 damping none" + +variable dieHeight2 equal 2*${dieHeight} + +region lowerPunch plane 0 0 0 0 0 1 side in units box move NULL NULL v_disp_lower units box +region upperPunch plane 0 0 ${dieHeight} 0 0 -1 side in move NULL NULL v_disp_upper units box +region die cylinder z 0 0 ${dieRadius} 0 ${dieHeight2} side in units box +variable dieRadiusPlus equal ${dieRadius}*1.05 +variable dieRadiusPlusNeg equal -${dieRadiusPlus} +region xPlanePos plane ${dieRadiusPlus} 0 0 -1 0 0 side in units box move v_disp_xPlanePos NULL NULL units box +region xPlaneNeg plane ${dieRadiusPlusNeg} 0 0 1 0 0 side in units box move v_disp_xPlaneNeg NULL NULL units box + +fix lowerPunch all wall/gran/region ${wall_contact_string} region lowerPunch contacts +fix upperPunch all wall/gran/region ${wall_contact_string} region upperPunch contacts +fix die all wall/gran/region ${wall_contact_string} region die contacts +fix xPlanePos all wall/gran/region ${wall_contact_string} region xPlanePos contacts +fix xPlaneNeg all wall/gran/region ${wall_contact_string} region xPlaneNeg contacts + +compute avgPunchForce all reduce sum f_upperPunch[4] +variable avgPunchForce equal c_avgPunchForce +compute avgLowerPunchForce all reduce sum f_lowerPunch[4] +variable avgLowerPunchForce equal c_avgLowerPunchForce +compute fractureForce all reduce sum f_xPlanePos[2] +variable fractureForce equal c_fractureForce + +fix print1 all print 1 "${disp_upper} ${avgPunchForce} ${avgLowerPunchForce} ${fractureForce}" file upperPunchDispForce.csv screen no +fix printSTL all print 1 "${disp_upper} ${disp_lower}" file punch_disp_STL_generation.csv screen no + +##################################### INSERT PARTICLES #################################################### + +fix 1 all nve/sphere +fix grav all gravity 9.81 vector 0 0 -1 + +######################################## SCREEN OUTPUT #################################################### + +#variable ax atom fx/mass +#variable ay atom fy/mass +#variable az atom fz/mass +#variable aMag atom sqrt(v_ax*v_ax+v_ay*v_ay+v_az*v_az) +#variable force atom sqrt(fx^2+fy^2+fz^2) +#compute aMagAvg all reduce ave v_aMag +#variable forceToAccelRatio atom v_force/(mass*v_aMag) + +compute 1 all erotate/sphere +thermo_style custom dt step atoms ke vol v_disp_upper #c_aMagAvg +thermo 100 +thermo_modify lost ignore norm no + +##################################### SET UP DUMP OUTPUTS #################################################### + +compute ke all ke/atom +variable output_rate equal round(1e-3/dt) +#variable output_rate equal 10 + +#dumpĀ 1 all custom 1 uniaxialCompression id type f_plane_yz_neg[*] +#variable az_upperPunch atom f_upperPunch[7] +#variable afz_upperPunch atom f_upperPunch[4] +#fix log all print 1 "${delta} ${fx_neg}" file uniaxialCompression.csv title "del,fx_yz_neg" screen no + +run 0 + +compute sigmaxx all property/atom d_sigmaxx +compute sigmayy all property/atom d_sigmayy +compute sigmazz all property/atom d_sigmazz +compute Velas all property/atom d_Velas +compute adhesive_length all property/atom d_adhesive_length + +compute sigmaxx_ave all reduce ave c_sigmaxx +compute sigmayy_ave all reduce ave c_sigmayy +compute sigmazz_ave all reduce ave c_sigmazz +compute Velas_sum all reduce sum c_Velas +compute adhesive_length_ave all reduce ave c_adhesive_length + +variable sxx_ave equal c_sigmaxx_ave +variable syy_ave equal c_sigmayy_ave +variable szz_ave equal c_sigmazz_ave +variable Vparticles equal c_Velas_sum +variable adh_length_ave equal c_adhesive_length_ave + +fix log all print 1 "${sxx_ave} ${syy_ave} ${szz_ave} ${Vparticles} ${adh_length_ave}" file avgStresses.csv screen no +dump dumpParticles all custom ${output_rate} avicelTableting.dump id type mass diameter x y z vx vy vz fx fy fz c_ke c_sigmaxx c_sigmayy c_sigmazz #v_aMag v_force v_forceToAccelRatio +#dump dumpParticlesVTK all vtk ${output_rate} post/particles_*.vtk id x y z fx fy fz vx vy vz c_ke radius c_sigmaxx c_sigmayy c_sigmazz + +######################################### RUN SIMULATION ########################################## + +variable upper_punch_stroke equal 0.6733*${dieHeight} # 0.6733 +variable vel_upper equal 0.25 + +variable settling_steps equal round(0.02/dt) +variable compression_steps equal 2*round(${upper_punch_stroke}/${vel_upper}/dt) +variable ejection_steps equal ${compression_steps} +variable free_float_steps equal round(0.02/dt) +variable total_steps equal ${settling_steps}+${compression_steps}+${ejection_steps}+${free_float_steps} + +print "Total steps = ${total_steps}" + +##### SETTLING ##### + +run ${settling_steps} + +##### Compression & Release ##### + +variable punch_frequency equal PI/2/(dt*${compression_steps}/2) +variable disp_upper equal -${upper_punch_stroke}*sin(${punch_frequency}*elapsed*dt) +variable short_release equal round(${compression_steps}*1.0) +run ${short_release} # 189170 upto # + +##### EJECTION ##### + +variable punch_frequency equal PI/2/(dt*${ejection_steps}) +variable disp_lower equal ${dieHeight}*sin(${punch_frequency}*elapsed*dt) +variable disp_upper equal 0.9*v_disp_lower +run ${ejection_steps} + +##### FREE FLOAT ##### + +variable disp_lower equal ${dieHeight} +variable disp_upper equal ${dieHeight}*0.9 +variable max_disp equal ${dieRadius}*0.75 +#variable disp_xPlanePos equal -${max_disp}*elapsed/${free_float_steps} +#variable disp_xPlaneNeg equal -v_disp_xPlanePos +run ${free_float_steps} + diff --git a/examples/granular/in.avicelTableting20000 b/examples/granular/in.avicelTableting20000 new file mode 100644 index 0000000000..51e6dd5699 --- /dev/null +++ b/examples/granular/in.avicelTableting20000 @@ -0,0 +1,184 @@ +############################### SIMULATION SETTINGS ################################################### + +atom_style sphere 1 +atom_modify map array +comm_modify vel yes +units si +newton off +neighbor 0.22e-3 bin +neigh_modify every 10 delay 2000 check no +timestep 0.3e-7 +processors 2 2 1 + +######################### SIMULATION BOUNDING BOX, INTEGRATION, AND, GRAVITY ########################### + +boundary f f f +read_data spheres.data + +######################################### ADD DIE AND ATOM PARAMETERIZATION ############################################## + +variable atomRadius equal 0.0961e-3*1.25 +variable atomDiameter equal 2*${atomRadius} +variable atomDensity equal 1560 +variable atomMassAvg equal ${atomDensity}*4.0/3.0*PI*${atomRadius}^3.0 +variable dieRadius equal 4e-3 +variable dieHeight equal 1e-2 + +########################### PARTICLE MATERIAL PROPERTIES AND FORCE MODEL ############################### + +pair_style granular +# mdr = E, nu, Y, gamma, psi_b, CoR +# linear_history = k_t, x_gamma,t, mu_s +variable YoungsModulus equal 5e9 +variable YieldStress equal 1.9e8 +variable PoissonsRatio equal 0.4 +variable SurfaceEnergy equal 450 +variable SurfaceEnergyWall equal 0.0 +variable CoR equal 0.5 +variable psi_b equal 0.5 +variable beta equal -ln(${CoR})/sqrt(ln(${CoR})^2+PI^2) +variable kt equal 2/7*${YoungsModulus}*${atomRadius} +variable kt_wall equal 2/7*${YoungsModulus}*${atomRadius} +variable xgammat equal 0.0 #${beta}*sqrt(${atomMassAvg}*${YoungsModulus}*${atomRadius}) +variable mu_s equal 0.7 +variable mu_s_wall equal 0.1 +variable mu_roll equal 0.6 +variable k_roll equal 2.25*${mu_roll}*${mu_roll}*${YoungsModulus}*${atomRadius} +variable gamma_roll equal 0.0 #${beta}*sqrt(${atomMassAvg}*${YoungsModulus}*${atomRadius}) + +pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} damping none tangential linear_history ${kt} ${xgammat} ${mu_s} rolling sds ${k_roll} ${gamma_roll} ${mu_roll} +#pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none +#pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_nohistory 0.0 0.0 damping none + +######################################### ADD DIE AND PUNCH WALLS ################################################ + +variable disp_upper equal 0.0 +variable disp_lower equal 0.0 +variable disp_xPlanePos equal 0.0 +variable disp_xPlaneNeg equal 0.0 + +variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} damping none tangential linear_history ${kt_wall} ${xgammat} ${mu_s_wall} rolling sds ${k_roll} ${gamma_roll} ${mu_roll}" +#variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none" +#variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} tangential linear_nohistory 0.0 0.0 damping none" + +variable dieHeight2 equal 2*${dieHeight} + +region lowerPunch plane 0 0 0 0 0 1 side in units box move NULL NULL v_disp_lower units box +region upperPunch plane 0 0 ${dieHeight} 0 0 -1 side in move NULL NULL v_disp_upper units box +region die cylinder z 0 0 ${dieRadius} 0 ${dieHeight2} side in units box +variable dieRadiusPlus equal ${dieRadius}*1.05 +variable dieRadiusPlusNeg equal -${dieRadiusPlus} +region xPlanePos plane ${dieRadiusPlus} 0 0 -1 0 0 side in units box move v_disp_xPlanePos NULL NULL units box +region xPlaneNeg plane ${dieRadiusPlusNeg} 0 0 1 0 0 side in units box move v_disp_xPlaneNeg NULL NULL units box + +fix lowerPunch all wall/gran/region ${wall_contact_string} region lowerPunch contacts +fix upperPunch all wall/gran/region ${wall_contact_string} region upperPunch contacts +fix die all wall/gran/region ${wall_contact_string} region die contacts +fix xPlanePos all wall/gran/region ${wall_contact_string} region xPlanePos contacts +fix xPlaneNeg all wall/gran/region ${wall_contact_string} region xPlaneNeg contacts + +compute avgPunchForce all reduce sum f_upperPunch[4] +variable avgPunchForce equal c_avgPunchForce +compute avgLowerPunchForce all reduce sum f_lowerPunch[4] +variable avgLowerPunchForce equal c_avgLowerPunchForce +compute fractureForce all reduce sum f_xPlanePos[2] +variable fractureForce equal c_fractureForce + +fix print1 all print 1 "${disp_upper} ${avgPunchForce} ${avgLowerPunchForce} ${fractureForce}" file upperPunchDispForce.csv screen no +fix printSTL all print 1 "${disp_upper} ${disp_lower}" file punch_disp_STL_generation.csv screen no + +##################################### INSERT PARTICLES #################################################### + +fix 1 all nve/sphere +fix grav all gravity 9.81 vector 0 0 -1 + +######################################## SCREEN OUTPUT #################################################### + +#variable ax atom fx/mass +#variable ay atom fy/mass +#variable az atom fz/mass +#variable aMag atom sqrt(v_ax*v_ax+v_ay*v_ay+v_az*v_az) +#variable force atom sqrt(fx^2+fy^2+fz^2) +#compute aMagAvg all reduce ave v_aMag +#variable forceToAccelRatio atom v_force/(mass*v_aMag) + +compute 1 all erotate/sphere +thermo_style custom dt step atoms ke vol v_disp_upper #c_aMagAvg +thermo 100 +thermo_modify lost ignore norm no + +##################################### SET UP DUMP OUTPUTS #################################################### + +compute ke all ke/atom +variable output_rate equal round(1e-4/dt) +#variable output_rate equal 10 + +#dumpĀ 1 all custom 1 uniaxialCompression id type f_plane_yz_neg[*] +#variable az_upperPunch atom f_upperPunch[7] +#variable afz_upperPunch atom f_upperPunch[4] +#fix log all print 1 "${delta} ${fx_neg}" file uniaxialCompression.csv title "del,fx_yz_neg" screen no + +run 0 + +compute sigmaxx all property/atom d_sigmaxx +compute sigmayy all property/atom d_sigmayy +compute sigmazz all property/atom d_sigmazz +compute Velas all property/atom d_Velas +compute adhesive_length all property/atom d_adhesive_length + +compute sigmaxx_ave all reduce ave c_sigmaxx +compute sigmayy_ave all reduce ave c_sigmayy +compute sigmazz_ave all reduce ave c_sigmazz +compute Velas_sum all reduce sum c_Velas +compute adhesive_length_ave all reduce ave c_adhesive_length + +variable sxx_ave equal c_sigmaxx_ave +variable syy_ave equal c_sigmayy_ave +variable szz_ave equal c_sigmazz_ave +variable Vparticles equal c_Velas_sum +variable adh_length_ave equal c_adhesive_length_ave + +fix log all print 1 "${sxx_ave} ${syy_ave} ${szz_ave} ${Vparticles} ${adh_length_ave}" file avgStresses.csv screen no +dump dumpParticles all custom ${output_rate} avicelTableting.dump id type mass diameter x y z vx vy vz fx fy fz c_ke c_sigmaxx c_sigmayy c_sigmazz #v_aMag v_force v_forceToAccelRatio +#dump dumpParticlesVTK all vtk ${output_rate} post/particles_*.vtk id x y z fx fy fz vx vy vz c_ke radius c_sigmaxx c_sigmayy c_sigmazz + +######################################### RUN SIMULATION ########################################## + +variable upper_punch_stroke equal 0.6905*${dieHeight} # 0.6733 +variable vel_upper equal 0.25 + +variable settling_steps equal round(0.02/dt) +variable compression_steps equal 2*round(${upper_punch_stroke}/${vel_upper}/dt) +variable ejection_steps equal ${compression_steps} +variable free_float_steps equal round(0.02/dt) +variable total_steps equal ${settling_steps}+${compression_steps}+${ejection_steps}+${free_float_steps} + +print "Total steps = ${total_steps}" + +##### SETTLING ##### + +run ${settling_steps} + +##### Compression & Release ##### + +variable punch_frequency equal PI/2/(dt*${compression_steps}/2) +variable disp_upper equal -${upper_punch_stroke}*sin(${punch_frequency}*elapsed*dt) +variable short_release equal round(${compression_steps}*1.0) +run ${short_release} # 189170 upto # + +##### EJECTION ##### + +variable punch_frequency equal PI/2/(dt*${ejection_steps}) +variable disp_lower equal ${dieHeight}*sin(${punch_frequency}*elapsed*dt) +variable disp_upper equal 0.9*v_disp_lower +run ${ejection_steps} + +##### FREE FLOAT ##### + +variable disp_lower equal ${dieHeight} +variable disp_upper equal ${dieHeight}*0.9 +variable max_disp equal ${dieRadius}*0.75 +#variable disp_xPlanePos equal -${max_disp}*elapsed/${free_float_steps} +#variable disp_xPlaneNeg equal -v_disp_xPlanePos +run ${free_float_steps} + diff --git a/examples/granular/in.mpfem.triaxial12particles b/examples/granular/in.mpfem.triaxial12particles new file mode 100644 index 0000000000..8c417086bc --- /dev/null +++ b/examples/granular/in.mpfem.triaxial12particles @@ -0,0 +1,100 @@ +############################### SIMULATION SETTINGS ################################################### + +atom_style sphere +atom_modify map array +comm_modify vel yes +units si +newton off +neighbor 2 bin +neigh_modify delay 0 +timestep 1e-6 + +######################### SIMULATION BOUNDING BOX, INTEGRATION, AND, GRAVITY ########################### + +boundary f f f +read_data spheres.data +fix integr all nve/sphere + +########################### PARTICLE MATERIAL PROPERTIES AND FORCE MODEL ############################### + +variable atomRadius equal 0.5 + +pair_style granular +# mdr = E, nu, Y, gamma, psi_b, CoR +# linear_history = k_t, x_gamma,t, mu_s +variable YoungsModulus equal 1e9 +variable PoissonsRatio equal 0.3 +variable YieldStress equal 50e6 +variable SurfaceEnergy equal 0.0 +variable psi_b equal 0.5 +variable CoR equal 0.5 +variable kt equal 2/7*${YoungsModulus}*${atomRadius} +variable xgammat equal 0.0 +variable mu_s equal 0.5 + +pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none + +######################################### ADD IN PLANES ################################################ + +variable boxWidth equal 3 +variable halfBoxWidth equal ${boxWidth}/2 + +variable plane_disp equal 0.0 +variable plane_disp_neg equal 0.0 + +region plane_yz_pos plane ${halfBoxWidth} 0 0 -1 0 0 side in move v_plane_disp_neg NULL NULL units box +region plane_yz_neg plane -${halfBoxWidth} 0 0 1 0 0 side in move v_plane_disp NULL NULL units box +region plane_xz_pos plane 0 ${halfBoxWidth} 0 0 -1 0 side in move NULL v_plane_disp_neg NULL units box +region plane_xz_neg plane 0 -${halfBoxWidth} 0 0 1 0 side in move NULL v_plane_disp NULL units box +region plane_xy_pos plane 0 0 ${halfBoxWidth} 0 0 -1 side in move NULL NULL v_plane_disp_neg units box +region plane_xy_neg plane 0 0 -${halfBoxWidth} 0 0 1 side in move NULL NULL v_plane_disp units box + +variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none" + +fix plane_yz_pos all wall/gran/region ${wall_contact_string} region plane_yz_pos contacts +fix plane_yz_neg all wall/gran/region ${wall_contact_string} region plane_yz_neg contacts +fix plane_xz_pos all wall/gran/region ${wall_contact_string} region plane_xz_pos contacts +fix plane_xz_neg all wall/gran/region ${wall_contact_string} region plane_xz_neg contacts +fix plane_xy_pos all wall/gran/region ${wall_contact_string} region plane_xy_pos contacts +fix plane_xy_neg all wall/gran/region ${wall_contact_string} region plane_xy_neg contacts + +compute plane_xy_neg_force all reduce sum f_plane_xy_neg[4] +variable plane_xy_neg_force equal c_plane_xy_neg_force + +compute plane_xz_neg_force all reduce sum f_plane_xz_neg[3] +variable plane_xz_neg_force equal c_plane_xz_neg_force + +compute plane_yz_neg_force all reduce sum f_plane_yz_neg[2] +variable plane_yz_neg_force equal c_plane_yz_neg_force + +fix print1 all print 1 "${plane_disp} ${plane_xy_neg_force} ${plane_xz_neg_force} ${plane_yz_neg_force}" file lammps_macro_force_disp_diff_radii.csv screen no + +######################################## SCREEN OUTPUT #################################################### + +compute 1 all erotate/sphere +thermo_style custom dt step atoms ke c_1 vol +thermo 100 +thermo_modify lost ignore norm no + +##################################### DEFINE WALL MOVEMENT ################################################# + +variable disp_max equal 0.499 +variable ddisp equal 0.00001 +variable compression_steps equal round(${disp_max}/${ddisp}) +variable output_rate equal round(${compression_steps}/100) + +##################################### SET UP DUMP OUTPUTS #################################################### + +#dump dmp all vtk ${output_rate} post/triaxial12particles_*.vtk id type mass x y z vx vy vz fx fy fz radius +dump dumpParticles all custom ${output_rate} triaxial12particles.dump id type mass x y z vx vy vz fx fy fz radius + +#################################### COMPRESS THE PARTICLES ################################################## + +run 0 + +variable plane_disp equal ${ddisp}*elapsed +variable plane_disp_neg equal -${ddisp}*elapsed + +run ${compression_steps} + +#################################### UNCOMPRESS THE PARTICLES ################################################ diff --git a/examples/granular/in.mpfem.triaxial14particles b/examples/granular/in.mpfem.triaxial14particles new file mode 100644 index 0000000000..13c7b2232b --- /dev/null +++ b/examples/granular/in.mpfem.triaxial14particles @@ -0,0 +1,164 @@ +############################### SIMULATION SETTINGS ################################################### + +atom_style sphere 1 +atom_modify map array +comm_modify vel yes +units si +newton off +neighbor 2 bin +neigh_modify delay 0 +timestep 1e-6 +#processors 1 2 1 + +######################### SIMULATION BOUNDING BOX, INTEGRATION, AND, GRAVITY ########################### + +boundary f f f +region box block -100 100 -100 100 -100 100 units box +create_box 2 box +fix integr all nve/sphere + +########################### PARTICLE MATERIAL PROPERTIES AND FORCE MODEL ############################### + +variable atomRadius equal 0.5 + +pair_style granular +# mdr = E, nu, Y, gamma, psi_b, CoR +# linear_history = k_t, x_gamma,t, mu_s +variable YoungsModulus equal 1e9 +variable PoissonsRatio equal 0.3 +variable YieldStress equal 50e6 +variable SurfaceEnergy equal 0.0 +variable psi_b equal 0.5 +variable CoR equal 0.5 +variable kt equal 2/7*${YoungsModulus}*${atomRadius} +variable xgammat equal 0.0 +variable mu_s equal 0.5 + +pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none + +######################################### ADD IN PLANES ################################################ + +variable boxWidth equal 3 +variable halfBoxWidth equal ${boxWidth}/2 + +variable plane_disp equal 0.0 +variable plane_disp_neg equal 0.0 + +region plane_yz_pos plane ${halfBoxWidth} 0 0 -1 0 0 side in move v_plane_disp_neg NULL NULL units box +region plane_yz_neg plane -${halfBoxWidth} 0 0 1 0 0 side in move v_plane_disp NULL NULL units box +region plane_xz_pos plane 0 ${halfBoxWidth} 0 0 -1 0 side in move NULL v_plane_disp_neg NULL units box +region plane_xz_neg plane 0 -${halfBoxWidth} 0 0 1 0 side in move NULL v_plane_disp NULL units box +region plane_xy_pos plane 0 0 ${halfBoxWidth} 0 0 -1 side in move NULL NULL v_plane_disp_neg units box +region plane_xy_neg plane 0 0 -${halfBoxWidth} 0 0 1 side in move NULL NULL v_plane_disp units box + +variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none" + +fix plane_yz_pos all wall/gran/region ${wall_contact_string} region plane_yz_pos contacts +fix plane_yz_neg all wall/gran/region ${wall_contact_string} region plane_yz_neg contacts +fix plane_xz_pos all wall/gran/region ${wall_contact_string} region plane_xz_pos contacts +fix plane_xz_neg all wall/gran/region ${wall_contact_string} region plane_xz_neg contacts +fix plane_xy_pos all wall/gran/region ${wall_contact_string} region plane_xy_pos contacts +fix plane_xy_neg all wall/gran/region ${wall_contact_string} region plane_xy_neg contacts + +compute plane_xy_neg_force all reduce sum f_plane_xy_neg[4] +variable plane_xy_neg_force equal c_plane_xy_neg_force + +compute plane_xz_neg_force all reduce sum f_plane_xz_neg[3] +variable plane_xz_neg_force equal c_plane_xz_neg_force + +compute plane_yz_neg_force all reduce sum f_plane_yz_neg[2] +variable plane_yz_neg_force equal c_plane_yz_neg_force + +fix print1 all print 1 "${plane_disp} ${plane_xy_neg_force} ${plane_xz_neg_force} ${plane_yz_neg_force}" file lammps_macro_force_disp.csv screen no + +##################################### INSERT PARTICLES #################################################### + +# PARTICLE PROPERTIES +variable d equal 1 +variable den equal 1000 + +create_atoms 1 single -0.1682 0.1113 0.1492 units box +group atomOne id 1 +set atom 1 diameter ${d} density ${den} + +create_atoms 1 single 0.6234 -0.5134 0.4198 units box +group atomTwo id 2 +set atom 2 diameter ${d} density ${den} + +create_atoms 1 single 0.8958 0.8304 0.1353 units box +group atomThree id 3 +set atom 3 diameter ${d} density ${den} + +create_atoms 1 single -0.1058 -0.9321 -0.2803 units box +group atomFour id 4 +set atom 4 diameter ${d} density ${den} + +create_atoms 1 single -0.7816 0.5089 -0.5358 units box +group atomFive id 5 +set atom 5 diameter ${d} density ${den} + +create_atoms 1 single 0.09169 -0.1675 -0.9413 units box +group atomSix id 6 +set atom 6 diameter ${d} density ${den} + +create_atoms 1 single -0.8324 -0.6242 -0.9531 units box +group atomSeven id 7 +set atom 7 diameter ${d} density ${den} + +create_atoms 1 single -0.8994 -0.6587 0.9025 units box +group atomEight id 8 +set atom 8 diameter ${d} density ${den} + +create_atoms 1 single -0.08605 0.8565 0.8629 units box +group atomNine id 9 +set atom 9 diameter ${d} density ${den} + +create_atoms 1 single 0.7989 0.8445 -0.9942 units box +group atomTen id 10 +set atom 10 diameter ${d} density ${den} + +create_atoms 1 single 0.9317 -0.8971 -0.8523 units box +group atomEleven id 11 +set atom 11 diameter ${d} density ${den} + +create_atoms 1 single -0.979 0.3867 0.7977 units box +group atomTwelve id 12 +set atom 12 diameter ${d} density ${den} + +create_atoms 1 single 0.9926 0.2609 0.9693 units box +group atomThirteen id 13 +set atom 13 diameter ${d} density ${den} + +create_atoms 1 single 0.9814 0.01161 -0.4335 units box +group atomFourteen id 14 +set atom 14 diameter ${d} density ${den} + +######################################## SCREEN OUTPUT #################################################### + +compute 1 all erotate/sphere +thermo_style custom dt step atoms ke c_1 vol +thermo 100 +thermo_modify lost ignore norm no + +##################################### DEFINE WALL MOVEMENT ################################################# + +variable disp_max equal 0.45 +variable ddisp equal 0.00001 +variable compression_steps equal round(${disp_max}/${ddisp}) +variable output_rate equal round(${compression_steps}/100) + +##################################### SET UP DUMP OUTPUTS #################################################### + +#dump dmp all vtk ${output_rate} post/triaxial14particles_*.vtk id type mass x y z vx vy vz fx fy fz radius +dump dumpParticles all custom ${output_rate} triaxial14particles.dump id type mass x y z vx vy vz fx fy fz radius + +#################################### COMPRESS THE PARTICLES ################################################## + +run 0 + +variable plane_disp equal ${ddisp}*elapsed +variable plane_disp_neg equal -${ddisp}*elapsed + +run ${compression_steps} + +#################################### UNCOMPRESS THE PARTICLES ################################################ diff --git a/examples/granular/spheres.data b/examples/granular/spheres.data new file mode 100644 index 0000000000..b4f07511ac --- /dev/null +++ b/examples/granular/spheres.data @@ -0,0 +1,23 @@ +#LAMMPS data file created by matlab. +12 atoms + +1 atom types + +-10.0000000000 10.0000000000 xlo xhi +-10.0000000000 10.0000000000 ylo yhi +-10.0000000000 10.0000000000 zlo zhi + +Atoms + +1 1 0.8000000000 1000.0000000000 0.0717535226 -0.2092222842 0.3662146798 +2 1 1.2000000000 1000.0000000000 -0.8233763986 -0.7426114800 -0.8263932264 +3 1 0.8000000000 1000.0000000000 -1.0685863278 -0.4494609702 0.2196698078 +4 1 0.8000000000 1000.0000000000 0.5829432471 -1.0098803839 -0.7607543861 +5 1 0.8000000000 1000.0000000000 -0.8658471132 0.6951192569 0.0107556658 +6 1 1.2000000000 1000.0000000000 0.3966456126 0.7215053869 -0.7540113087 +7 1 1.2000000000 1000.0000000000 0.7316242921 0.8996483982 0.6751483031 +8 1 1.0000000000 1000.0000000000 0.6267527768 -0.8419367233 0.6964197101 +9 1 0.8000000000 1000.0000000000 -0.0409043189 -0.1452314035 -1.0102948313 +10 1 0.8000000000 1000.0000000000 -0.9495107709 0.6760151650 -0.9220534482 +11 1 1.0000000000 1000.0000000000 -0.7488486472 0.2188003421 0.7892021020 +12 1 1.2000000000 1000.0000000000 0.8968590780 -0.2350366437 -0.2006719701 diff --git a/examples/granular/spheres200.data b/examples/granular/spheres200.data new file mode 100644 index 0000000000..f39724477d --- /dev/null +++ b/examples/granular/spheres200.data @@ -0,0 +1,211 @@ +#LAMMPS data file created by matlab. +200 atoms + +1 atom types + +-0.005000 0.005000 xlo xhi +-0.005000 0.005000 ylo yhi +-0.001000 0.020000 zlo zhi + +Atoms + +1 1 0.001206 1560.000000 -0.000938 0.000556 0.000883 +2 1 0.000953 1560.000000 -0.002626 -0.000145 0.002778 +3 1 0.001035 1560.000000 -0.000434 0.000172 0.008458 +4 1 0.001225 1560.000000 -0.003126 -0.000604 0.004986 +5 1 0.001119 1560.000000 0.000772 0.002972 0.002568 +6 1 0.001243 1560.000000 -0.000363 0.001184 0.004927 +7 1 0.001173 1560.000000 0.000218 0.000243 0.005475 +8 1 0.000937 1560.000000 0.000033 0.000029 0.003141 +9 1 0.001055 1560.000000 -0.001660 0.001975 0.008611 +10 1 0.000938 1560.000000 -0.001818 0.002352 0.002534 +11 1 0.000990 1560.000000 0.001592 0.000435 0.004416 +12 1 0.000927 1560.000000 -0.001659 -0.000004 0.005901 +13 1 0.001272 1560.000000 0.002972 0.000553 0.007291 +14 1 0.001226 1560.000000 0.002090 0.000983 0.001406 +15 1 0.000957 1560.000000 0.002241 -0.001608 0.001304 +16 1 0.001020 1560.000000 -0.001944 0.001290 0.002030 +17 1 0.001289 1560.000000 -0.002256 -0.001173 0.003474 +18 1 0.000998 1560.000000 0.000771 0.002127 0.000906 +19 1 0.000927 1560.000000 0.000186 0.000567 0.001207 +20 1 0.001095 1560.000000 -0.000937 -0.003179 0.008173 +21 1 0.001006 1560.000000 -0.001736 0.000751 0.004618 +22 1 0.001037 1560.000000 0.000784 0.001844 0.002380 +23 1 0.001297 1560.000000 0.000234 -0.001597 0.008560 +24 1 0.001017 1560.000000 0.002454 -0.000505 0.001171 +25 1 0.001110 1560.000000 -0.000803 -0.000415 0.003714 +26 1 0.001192 1560.000000 0.002283 0.000648 0.003048 +27 1 0.000992 1560.000000 -0.000065 -0.000545 0.007062 +28 1 0.001116 1560.000000 0.002174 -0.001463 0.005830 +29 1 0.001258 1560.000000 0.001602 0.001853 0.007246 +30 1 0.001055 1560.000000 -0.001535 -0.002770 0.007196 +31 1 0.000958 1560.000000 -0.000438 -0.000260 0.004709 +32 1 0.001188 1560.000000 0.000339 -0.000355 0.009171 +33 1 0.001166 1560.000000 0.002513 -0.001215 0.004434 +34 1 0.000907 1560.000000 0.001905 -0.000373 0.004921 +35 1 0.001245 1560.000000 -0.000091 -0.002620 0.004150 +36 1 0.001302 1560.000000 0.003292 0.000184 0.005377 +37 1 0.001305 1560.000000 0.002099 0.001261 0.008939 +38 1 0.000988 1560.000000 0.003274 0.000136 0.003667 +39 1 0.000892 1560.000000 0.001798 -0.002104 0.008610 +40 1 0.001247 1560.000000 -0.003058 -0.000575 0.000948 +41 1 0.000900 1560.000000 -0.000258 -0.000469 0.001478 +42 1 0.000945 1560.000000 -0.001434 -0.001711 0.004610 +43 1 0.000977 1560.000000 -0.001410 0.002808 0.004963 +44 1 0.000930 1560.000000 -0.002110 -0.001362 0.006749 +45 1 0.000931 1560.000000 0.001256 -0.000876 0.000844 +46 1 0.000901 1560.000000 0.000899 -0.001189 0.005316 +47 1 0.000940 1560.000000 -0.002189 -0.000047 0.007240 +48 1 0.001217 1560.000000 -0.000108 -0.001333 0.002257 +49 1 0.001088 1560.000000 0.001364 -0.000594 0.002789 +50 1 0.001143 1560.000000 -0.000311 -0.001425 0.006092 +51 1 0.001054 1560.000000 0.002262 0.002312 0.004315 +52 1 0.001016 1560.000000 -0.000724 0.000741 0.003295 +53 1 0.001051 1560.000000 0.000527 -0.001987 0.003307 +54 1 0.000905 1560.000000 0.000827 0.001457 0.005868 +55 1 0.001195 1560.000000 -0.001176 -0.000645 0.000798 +56 1 0.001253 1560.000000 0.002583 -0.001847 0.003310 +57 1 0.000982 1560.000000 0.001551 -0.002803 0.005076 +58 1 0.000945 1560.000000 -0.000481 0.000354 0.007220 +59 1 0.001040 1560.000000 -0.002736 0.001076 0.008769 +60 1 0.000917 1560.000000 0.000826 -0.001887 0.006449 +61 1 0.000914 1560.000000 -0.001171 -0.001592 0.007266 +62 1 0.000959 1560.000000 0.000834 -0.002671 0.007105 +63 1 0.000990 1560.000000 -0.000251 -0.001327 0.004339 +64 1 0.001220 1560.000000 0.001384 0.002896 0.005874 +65 1 0.000949 1560.000000 -0.001340 -0.000608 0.007496 +66 1 0.001306 1560.000000 0.002187 0.002068 0.002629 +67 1 0.001206 1560.000000 0.000148 0.001506 0.008517 +68 1 0.001123 1560.000000 0.001288 -0.000303 0.006613 +69 1 0.001151 1560.000000 -0.000876 0.001549 0.001740 +70 1 0.001315 1560.000000 -0.001902 -0.002590 0.001344 +71 1 0.000927 1560.000000 0.002285 -0.000866 0.006900 +72 1 0.001279 1560.000000 -0.000165 0.002689 0.007449 +73 1 0.000910 1560.000000 0.001009 0.001054 0.005049 +74 1 0.001148 1560.000000 -0.002229 -0.001285 0.008736 +75 1 0.001067 1560.000000 -0.000261 -0.002945 0.002157 +76 1 0.000993 1560.000000 -0.001641 0.002272 0.007601 +77 1 0.001228 1560.000000 0.001939 -0.000214 0.008903 +78 1 0.001076 1560.000000 0.000767 0.001172 0.003556 +79 1 0.001105 1560.000000 -0.000561 0.002493 0.004214 +80 1 0.001195 1560.000000 0.002694 -0.000817 0.007949 +81 1 0.001239 1560.000000 -0.000968 -0.003145 0.006096 +82 1 0.001083 1560.000000 -0.000808 0.001813 0.006396 +83 1 0.000923 1560.000000 0.000632 -0.001437 0.001310 +84 1 0.000981 1560.000000 -0.001842 0.002774 0.006508 +85 1 0.000998 1560.000000 -0.002775 0.001616 0.001453 +86 1 0.000979 1560.000000 -0.002520 0.001715 0.007741 +87 1 0.001002 1560.000000 -0.001465 -0.001931 0.006048 +88 1 0.000958 1560.000000 0.003264 0.000707 0.001189 +89 1 0.001052 1560.000000 -0.001314 -0.000701 0.002721 +90 1 0.001096 1560.000000 0.001154 0.002129 0.004403 +91 1 0.001104 1560.000000 0.002118 0.001977 0.000794 +92 1 0.001263 1560.000000 -0.001499 -0.002764 0.003441 +93 1 0.001086 1560.000000 -0.001096 0.002514 0.001154 +94 1 0.000895 1560.000000 0.001130 0.000029 0.001045 +95 1 0.000964 1560.000000 0.000905 -0.003200 0.000542 +96 1 0.000898 1560.000000 -0.000868 0.003148 0.008306 +97 1 0.000907 1560.000000 -0.001406 0.001144 0.007862 +98 1 0.001176 1560.000000 0.001246 -0.001074 0.004327 +99 1 0.001148 1560.000000 0.001512 -0.002739 0.003346 +100 1 0.000922 1560.000000 0.001470 -0.000036 0.007695 +101 1 0.001031 1560.000000 -0.002751 0.000928 0.004124 +102 1 0.001030 1560.000000 -0.000177 -0.002370 0.005374 +103 1 0.000915 1560.000000 0.000824 0.000521 0.007070 +104 1 0.001085 1560.000000 -0.002281 -0.000023 0.009123 +105 1 0.001004 1560.000000 -0.000167 0.002610 0.008905 +106 1 0.001060 1560.000000 -0.000389 -0.002220 0.007688 +107 1 0.000920 1560.000000 -0.000483 0.003231 0.006505 +108 1 0.001122 1560.000000 0.001781 -0.001547 0.002237 +109 1 0.001172 1560.000000 -0.002650 0.000830 0.005429 +110 1 0.001137 1560.000000 -0.000030 -0.003246 0.001024 +111 1 0.001315 1560.000000 0.001470 -0.001735 0.007580 +112 1 0.001245 1560.000000 0.000481 -0.003067 0.006025 +113 1 0.000904 1560.000000 0.000632 -0.000184 0.002010 +114 1 0.000883 1560.000000 -0.001828 0.002191 0.003819 +115 1 0.000974 1560.000000 0.002167 0.001616 0.006226 +116 1 0.001150 1560.000000 0.000871 -0.002731 0.002136 +117 1 0.001312 1560.000000 -0.000326 -0.001971 0.001000 +118 1 0.000914 1560.000000 0.001020 0.000810 0.002086 +119 1 0.001136 1560.000000 -0.000101 -0.003277 0.007246 +120 1 0.000991 1560.000000 -0.001944 0.000576 0.003215 +121 1 0.001216 1560.000000 -0.000913 -0.001165 0.008857 +122 1 0.001045 1560.000000 -0.003110 0.001062 0.002973 +123 1 0.000918 1560.000000 0.000348 0.000365 0.004046 +124 1 0.001279 1560.000000 -0.000884 0.003087 0.002268 +125 1 0.001065 1560.000000 -0.002238 0.001309 0.006452 +126 1 0.001012 1560.000000 -0.002059 -0.001354 0.001935 +127 1 0.001142 1560.000000 -0.003011 0.000567 0.001739 +128 1 0.000921 1560.000000 0.001764 0.002804 0.008177 +129 1 0.001151 1560.000000 -0.003105 -0.000384 0.006602 +130 1 0.000967 1560.000000 0.000932 0.000588 0.008823 +131 1 0.000908 1560.000000 -0.001873 -0.001947 0.007825 +132 1 0.000923 1560.000000 -0.002993 0.000883 0.007425 +133 1 0.001171 1560.000000 0.003310 -0.000405 0.006558 +134 1 0.000977 1560.000000 -0.000098 -0.000180 0.000492 +135 1 0.000938 1560.000000 -0.000706 -0.000129 0.006085 +136 1 0.001008 1560.000000 -0.000256 0.002333 0.000550 +137 1 0.001073 1560.000000 0.000534 -0.000055 0.008080 +138 1 0.000890 1560.000000 0.000351 0.001695 0.007195 +139 1 0.000973 1560.000000 0.002593 0.001907 0.005394 +140 1 0.001176 1560.000000 -0.001862 -0.000534 0.004494 +141 1 0.001306 1560.000000 -0.000951 0.001053 0.009299 +142 1 0.001103 1560.000000 -0.001937 -0.002711 0.008485 +143 1 0.001262 1560.000000 -0.002947 -0.001470 0.007682 +144 1 0.000914 1560.000000 0.002047 0.000811 0.005504 +145 1 0.000954 1560.000000 0.001935 -0.002349 0.006632 +146 1 0.001003 1560.000000 0.000766 -0.002635 0.008483 +147 1 0.001137 1560.000000 0.000102 0.003195 0.004922 +148 1 0.001006 1560.000000 -0.001982 0.001014 0.000685 +149 1 0.001255 1560.000000 -0.000718 0.001939 0.003056 +150 1 0.001057 1560.000000 -0.001189 -0.001717 0.003045 +151 1 0.001228 1560.000000 0.001581 0.002926 0.003510 +152 1 0.001052 1560.000000 -0.002172 0.001949 0.004831 +153 1 0.000979 1560.000000 -0.001817 0.000291 0.002048 +154 1 0.001286 1560.000000 -0.002647 -0.001839 0.004620 +155 1 0.001085 1560.000000 -0.000081 0.000850 0.002139 +156 1 0.000990 1560.000000 -0.000081 0.002105 0.005587 +157 1 0.001043 1560.000000 0.001636 -0.000112 0.001860 +158 1 0.001309 1560.000000 0.003216 -0.000851 0.002791 +159 1 0.000913 1560.000000 0.000608 0.003148 0.006565 +160 1 0.000919 1560.000000 0.000536 -0.003106 0.003249 +161 1 0.000943 1560.000000 0.003145 -0.000528 0.008915 +162 1 0.000993 1560.000000 -0.002811 -0.000099 0.008110 +163 1 0.001125 1560.000000 0.001415 -0.002271 0.000643 +164 1 0.000919 1560.000000 -0.001406 0.000223 0.006781 +165 1 0.001040 1560.000000 0.000690 0.003193 0.008329 +166 1 0.001055 1560.000000 0.001075 0.002584 0.009093 +167 1 0.001176 1560.000000 0.000851 0.003176 0.000591 +168 1 0.001003 1560.000000 -0.001462 0.001511 0.005544 +169 1 0.001126 1560.000000 -0.000077 0.003324 0.001347 +170 1 0.001068 1560.000000 0.003110 0.000810 0.008495 +171 1 0.001011 1560.000000 -0.001661 0.000117 0.008201 +172 1 0.001066 1560.000000 -0.000359 -0.003279 0.009094 +173 1 0.001303 1560.000000 0.003066 0.001188 0.004082 +174 1 0.000983 1560.000000 0.000354 0.002261 0.003558 +175 1 0.001137 1560.000000 0.002860 -0.001571 0.009180 +176 1 0.001070 1560.000000 0.001246 -0.001279 0.009104 +177 1 0.000886 1560.000000 0.002271 -0.000316 0.003675 +178 1 0.000983 1560.000000 -0.001987 -0.002490 0.005377 +179 1 0.000939 1560.000000 0.000601 -0.000861 0.003477 +180 1 0.001177 1560.000000 0.001522 0.002902 0.001690 +181 1 0.001036 1560.000000 -0.001200 -0.002874 0.004750 +182 1 0.000898 1560.000000 -0.001705 -0.001140 0.005503 +183 1 0.001315 1560.000000 0.002732 0.001766 0.007885 +184 1 0.001318 1560.000000 -0.002909 -0.001610 0.005936 +185 1 0.001218 1560.000000 0.003213 0.000884 0.002316 +186 1 0.001234 1560.000000 -0.002394 -0.002298 0.002575 +187 1 0.001160 1560.000000 -0.003313 -0.000065 0.003625 +188 1 0.001022 1560.000000 -0.003096 -0.001048 0.002151 +189 1 0.000966 1560.000000 0.001891 -0.002093 0.004404 +190 1 0.001048 1560.000000 -0.002367 0.002338 0.000697 +191 1 0.000995 1560.000000 -0.001204 -0.001912 0.002030 +192 1 0.001136 1560.000000 -0.001152 -0.002402 0.009223 +193 1 0.001083 1560.000000 -0.002588 -0.001768 0.000753 +194 1 0.000946 1560.000000 -0.001338 -0.000741 0.006527 +195 1 0.000943 1560.000000 -0.000073 0.003254 0.003663 +196 1 0.001059 1560.000000 0.000087 0.000958 0.006388 +197 1 0.001131 1560.000000 0.001030 0.001019 0.000752 +198 1 0.001257 1560.000000 -0.001365 0.002946 0.009266 +199 1 0.000891 1560.000000 -0.000445 -0.000273 0.002382 +200 1 0.001055 1560.000000 0.001781 0.000748 0.006583 diff --git a/examples/granular/spheres20000.data b/examples/granular/spheres20000.data new file mode 100644 index 0000000000..a1a7d6b456 --- /dev/null +++ b/examples/granular/spheres20000.data @@ -0,0 +1,20011 @@ +#LAMMPS data file created by matlab. +20000 atoms + +1 atom types + +-0.005000 0.005000 xlo xhi +-0.005000 0.005000 ylo yhi +-0.001000 0.020000 zlo zhi + +Atoms + +1 1 0.000249 1560.000000 0.000469 -0.000120 0.008380 +2 1 0.000260 1560.000000 -0.001811 0.000425 0.004090 +3 1 0.000225 1560.000000 -0.001371 0.000426 0.002952 +4 1 0.000252 1560.000000 0.000928 -0.000089 0.004118 +5 1 0.000210 1560.000000 0.000208 0.000384 0.000842 +6 1 0.000218 1560.000000 -0.002456 -0.000587 0.003834 +7 1 0.000201 1560.000000 -0.000278 0.003459 0.003445 +8 1 0.000231 1560.000000 -0.002123 0.003188 0.004799 +9 1 0.000268 1560.000000 -0.000338 -0.001557 0.007382 +10 1 0.000244 1560.000000 0.002537 0.002151 0.005999 +11 1 0.000264 1560.000000 -0.002812 0.001089 0.005793 +12 1 0.000270 1560.000000 0.000534 -0.001644 0.004376 +13 1 0.000202 1560.000000 -0.000821 -0.002210 0.000606 +14 1 0.000233 1560.000000 -0.003602 -0.000655 0.005498 +15 1 0.000200 1560.000000 -0.003513 0.000848 0.009759 +16 1 0.000213 1560.000000 -0.000957 0.002385 0.006657 +17 1 0.000258 1560.000000 -0.002657 -0.001653 0.002864 +18 1 0.000255 1560.000000 0.003288 0.000715 0.008901 +19 1 0.000249 1560.000000 -0.002116 0.001063 0.009030 +20 1 0.000196 1560.000000 -0.001865 -0.001067 0.008442 +21 1 0.000228 1560.000000 0.001349 0.002014 0.000518 +22 1 0.000209 1560.000000 0.003156 -0.000420 0.007538 +23 1 0.000259 1560.000000 0.003818 -0.000308 0.005761 +24 1 0.000218 1560.000000 -0.000163 -0.002505 0.002645 +25 1 0.000232 1560.000000 0.000135 0.000677 0.007933 +26 1 0.000214 1560.000000 -0.000812 0.002556 0.006276 +27 1 0.000196 1560.000000 -0.001579 -0.001167 0.003510 +28 1 0.000263 1560.000000 0.000309 -0.000739 0.008174 +29 1 0.000283 1560.000000 0.000429 -0.000200 0.006139 +30 1 0.000210 1560.000000 -0.001097 0.001375 0.002566 +31 1 0.000206 1560.000000 0.002158 0.002163 0.009702 +32 1 0.000211 1560.000000 0.001218 0.000035 0.008695 +33 1 0.000198 1560.000000 -0.002087 0.001121 0.005737 +34 1 0.000224 1560.000000 0.002160 -0.001821 0.004330 +35 1 0.000220 1560.000000 -0.000316 -0.000717 0.004389 +36 1 0.000199 1560.000000 0.001124 0.001672 0.005800 +37 1 0.000215 1560.000000 0.000292 -0.001358 0.004571 +38 1 0.000245 1560.000000 0.001525 -0.002513 0.001746 +39 1 0.000202 1560.000000 -0.002825 -0.000332 0.003862 +40 1 0.000286 1560.000000 -0.002224 0.002820 0.008412 +41 1 0.000247 1560.000000 0.001381 -0.003093 0.002687 +42 1 0.000195 1560.000000 -0.000589 -0.001284 0.009028 +43 1 0.000201 1560.000000 -0.000757 0.001986 0.003420 +44 1 0.000283 1560.000000 0.002027 0.001763 0.004546 +45 1 0.000227 1560.000000 -0.000848 -0.002204 0.006488 +46 1 0.000266 1560.000000 0.001283 0.002198 0.009445 +47 1 0.000234 1560.000000 0.000592 -0.002949 0.008638 +48 1 0.000232 1560.000000 0.000045 -0.000255 0.004406 +49 1 0.000229 1560.000000 0.000838 -0.000849 0.002000 +50 1 0.000209 1560.000000 -0.000921 0.000408 0.009360 +51 1 0.000260 1560.000000 -0.000209 0.000741 0.000915 +52 1 0.000222 1560.000000 -0.002147 0.001598 0.001554 +53 1 0.000233 1560.000000 -0.001177 -0.000281 0.003854 +54 1 0.000222 1560.000000 -0.003516 0.000410 0.002948 +55 1 0.000209 1560.000000 -0.000075 -0.001531 0.004811 +56 1 0.000225 1560.000000 0.000655 0.003467 0.008076 +57 1 0.000280 1560.000000 -0.001197 0.001083 0.000292 +58 1 0.000200 1560.000000 0.001068 0.001637 0.000349 +59 1 0.000194 1560.000000 0.002652 0.001467 0.004444 +60 1 0.000217 1560.000000 0.002179 -0.001172 0.000294 +61 1 0.000207 1560.000000 -0.000953 -0.000834 0.004460 +62 1 0.000207 1560.000000 -0.001480 -0.000410 0.003511 +63 1 0.000279 1560.000000 -0.001087 -0.000693 0.008258 +64 1 0.000256 1560.000000 0.000170 0.001783 0.000630 +65 1 0.000220 1560.000000 -0.000007 -0.000164 0.003013 +66 1 0.000284 1560.000000 0.002626 -0.001857 0.001733 +67 1 0.000206 1560.000000 -0.000654 -0.002228 0.008058 +68 1 0.000205 1560.000000 -0.000507 0.000866 0.004436 +69 1 0.000199 1560.000000 -0.000878 0.000565 0.005079 +70 1 0.000200 1560.000000 0.000351 -0.000964 0.001926 +71 1 0.000199 1560.000000 -0.001293 -0.000398 0.004203 +72 1 0.000257 1560.000000 -0.000866 0.001680 0.002213 +73 1 0.000211 1560.000000 0.000031 -0.000000 0.004846 +74 1 0.000240 1560.000000 -0.001303 -0.001095 0.006233 +75 1 0.000215 1560.000000 -0.000248 0.001446 0.009156 +76 1 0.000264 1560.000000 0.001143 -0.000973 0.004437 +77 1 0.000219 1560.000000 -0.003333 0.001897 0.006589 +78 1 0.000218 1560.000000 -0.002367 0.000960 0.001459 +79 1 0.000230 1560.000000 -0.002140 -0.001380 0.007698 +80 1 0.000251 1560.000000 0.000366 -0.000344 0.008242 +81 1 0.000247 1560.000000 0.000501 -0.000335 0.009322 +82 1 0.000215 1560.000000 0.002009 0.000298 0.005443 +83 1 0.000283 1560.000000 -0.002926 0.000927 0.009792 +84 1 0.000215 1560.000000 -0.000843 -0.000333 0.000979 +85 1 0.000223 1560.000000 0.001897 -0.001007 0.007430 +86 1 0.000248 1560.000000 -0.001685 -0.002868 0.007402 +87 1 0.000265 1560.000000 -0.002089 -0.001441 0.000652 +88 1 0.000202 1560.000000 0.001461 -0.000936 0.009070 +89 1 0.000192 1560.000000 -0.003141 0.001371 0.000662 +90 1 0.000216 1560.000000 -0.003227 0.001709 0.003457 +91 1 0.000250 1560.000000 -0.002180 -0.000936 0.005525 +92 1 0.000213 1560.000000 -0.000780 -0.000797 0.007704 +93 1 0.000202 1560.000000 0.000574 0.000317 0.006044 +94 1 0.000207 1560.000000 0.002259 -0.002661 0.001543 +95 1 0.000205 1560.000000 0.000869 -0.001213 0.004216 +96 1 0.000247 1560.000000 0.000054 0.000679 0.001068 +97 1 0.000268 1560.000000 -0.001566 -0.003158 0.002954 +98 1 0.000259 1560.000000 -0.001234 0.002509 0.002929 +99 1 0.000221 1560.000000 -0.000526 -0.000660 0.007294 +100 1 0.000210 1560.000000 -0.002108 -0.003035 0.003977 +101 1 0.000233 1560.000000 0.000094 0.000401 0.003069 +102 1 0.000251 1560.000000 -0.000292 0.002404 0.006452 +103 1 0.000229 1560.000000 0.000037 -0.000005 0.002751 +104 1 0.000264 1560.000000 0.002193 0.002674 0.006165 +105 1 0.000206 1560.000000 -0.000165 0.000792 0.000281 +106 1 0.000249 1560.000000 -0.001911 -0.000797 0.004484 +107 1 0.000261 1560.000000 -0.001997 -0.000334 0.002014 +108 1 0.000218 1560.000000 0.000117 -0.001736 0.006276 +109 1 0.000218 1560.000000 0.000964 -0.001048 0.001134 +110 1 0.000274 1560.000000 0.000020 0.000010 0.008701 +111 1 0.000251 1560.000000 0.000583 0.000402 0.000607 +112 1 0.000288 1560.000000 0.001098 -0.001839 0.004237 +113 1 0.000201 1560.000000 0.000345 0.000635 0.001170 +114 1 0.000267 1560.000000 -0.001105 0.000192 0.008679 +115 1 0.000201 1560.000000 -0.002871 0.000514 0.008607 +116 1 0.000204 1560.000000 0.000602 -0.000058 0.004148 +117 1 0.000194 1560.000000 0.002025 -0.001347 0.003345 +118 1 0.000234 1560.000000 0.000093 -0.000334 0.006551 +119 1 0.000246 1560.000000 0.000478 0.001163 0.002303 +120 1 0.000213 1560.000000 -0.001975 -0.000529 0.004929 +121 1 0.000263 1560.000000 0.000258 -0.001969 0.006239 +122 1 0.000211 1560.000000 -0.000042 -0.000463 0.006763 +123 1 0.000218 1560.000000 0.003023 0.002183 0.006863 +124 1 0.000213 1560.000000 0.001330 0.000804 0.005343 +125 1 0.000194 1560.000000 -0.000272 0.000276 0.005329 +126 1 0.000211 1560.000000 0.000369 -0.001142 0.006245 +127 1 0.000275 1560.000000 -0.000328 -0.001813 0.007764 +128 1 0.000211 1560.000000 0.000540 0.000784 0.009356 +129 1 0.000221 1560.000000 -0.002521 -0.001368 0.003344 +130 1 0.000243 1560.000000 -0.000235 0.002439 0.004689 +131 1 0.000257 1560.000000 -0.000475 -0.000602 0.001151 +132 1 0.000208 1560.000000 0.003506 -0.001601 0.006389 +133 1 0.000240 1560.000000 -0.001836 -0.001554 0.000985 +134 1 0.000210 1560.000000 0.001135 0.000943 0.006561 +135 1 0.000210 1560.000000 -0.000394 0.001912 0.004612 +136 1 0.000273 1560.000000 0.001081 -0.001085 0.005471 +137 1 0.000252 1560.000000 0.002278 0.000292 0.008512 +138 1 0.000194 1560.000000 0.001233 0.000558 0.000467 +139 1 0.000211 1560.000000 0.002251 -0.002320 0.000173 +140 1 0.000200 1560.000000 -0.001657 -0.000886 0.002597 +141 1 0.000213 1560.000000 -0.000978 -0.000002 0.004751 +142 1 0.000201 1560.000000 0.000007 0.000337 0.008507 +143 1 0.000254 1560.000000 -0.002294 0.000403 0.003150 +144 1 0.000213 1560.000000 0.001042 0.000621 0.006025 +145 1 0.000220 1560.000000 -0.003069 0.001304 0.007319 +146 1 0.000207 1560.000000 -0.002406 0.002623 0.008512 +147 1 0.000246 1560.000000 0.000039 -0.000056 0.008359 +148 1 0.000238 1560.000000 -0.000212 -0.001271 0.002909 +149 1 0.000251 1560.000000 -0.000951 -0.000765 0.005294 +150 1 0.000239 1560.000000 -0.000184 0.002581 0.007233 +151 1 0.000219 1560.000000 0.001427 -0.001462 0.000812 +152 1 0.000279 1560.000000 -0.002353 -0.001714 0.002577 +153 1 0.000196 1560.000000 -0.000512 -0.002367 0.009109 +154 1 0.000204 1560.000000 -0.000832 -0.001318 0.004055 +155 1 0.000281 1560.000000 0.001907 0.002278 0.002727 +156 1 0.000218 1560.000000 0.000500 0.000507 0.009389 +157 1 0.000279 1560.000000 0.000231 0.003009 0.001404 +158 1 0.000212 1560.000000 -0.000318 -0.001114 0.004604 +159 1 0.000258 1560.000000 0.001008 -0.001028 0.007888 +160 1 0.000240 1560.000000 0.000159 0.001563 0.005064 +161 1 0.000239 1560.000000 0.001533 0.001103 0.008321 +162 1 0.000260 1560.000000 -0.000488 0.001972 0.006126 +163 1 0.000252 1560.000000 -0.001053 -0.001779 0.005619 +164 1 0.000215 1560.000000 -0.000771 0.000929 0.002087 +165 1 0.000217 1560.000000 -0.000384 0.002539 0.002357 +166 1 0.000226 1560.000000 -0.000655 -0.000521 0.006932 +167 1 0.000196 1560.000000 0.000452 -0.000191 0.000871 +168 1 0.000213 1560.000000 -0.000270 0.001376 0.005861 +169 1 0.000214 1560.000000 0.001340 -0.002576 0.008470 +170 1 0.000271 1560.000000 0.000639 0.003224 0.004104 +171 1 0.000200 1560.000000 0.000007 0.000010 0.005310 +172 1 0.000209 1560.000000 -0.000034 -0.001014 0.005754 +173 1 0.000288 1560.000000 -0.001923 0.001375 0.001307 +174 1 0.000224 1560.000000 0.001230 -0.001701 0.005853 +175 1 0.000194 1560.000000 0.002927 0.000097 0.004369 +176 1 0.000195 1560.000000 0.003121 0.001721 0.002774 +177 1 0.000221 1560.000000 -0.000272 0.002133 0.009051 +178 1 0.000268 1560.000000 -0.000269 0.001097 0.009115 +179 1 0.000209 1560.000000 0.000118 -0.001775 0.005648 +180 1 0.000199 1560.000000 0.002225 -0.001841 0.007023 +181 1 0.000208 1560.000000 0.001881 0.002699 0.005026 +182 1 0.000253 1560.000000 -0.000038 -0.000253 0.009645 +183 1 0.000253 1560.000000 -0.000425 -0.000639 0.000796 +184 1 0.000277 1560.000000 -0.000545 0.001022 0.007959 +185 1 0.000225 1560.000000 -0.000770 -0.002720 0.004457 +186 1 0.000255 1560.000000 -0.000025 0.001350 0.000236 +187 1 0.000200 1560.000000 -0.000821 0.000768 0.001026 +188 1 0.000285 1560.000000 -0.000307 0.000115 0.009808 +189 1 0.000198 1560.000000 -0.002294 0.000298 0.001281 +190 1 0.000220 1560.000000 -0.001090 -0.001003 0.000978 +191 1 0.000246 1560.000000 0.000537 0.003705 0.005906 +192 1 0.000277 1560.000000 -0.001667 -0.001925 0.000235 +193 1 0.000251 1560.000000 -0.000627 0.000307 0.006225 +194 1 0.000279 1560.000000 0.001730 -0.000577 0.008220 +195 1 0.000213 1560.000000 -0.003133 0.000091 0.001891 +196 1 0.000256 1560.000000 -0.002840 0.001479 0.000989 +197 1 0.000258 1560.000000 -0.001875 0.002470 0.004126 +198 1 0.000245 1560.000000 -0.001057 0.003496 0.001572 +199 1 0.000214 1560.000000 0.000030 0.000688 0.002115 +200 1 0.000272 1560.000000 -0.000289 -0.000753 0.004764 +201 1 0.000269 1560.000000 -0.001776 0.003408 0.000971 +202 1 0.000226 1560.000000 0.000763 -0.000008 0.000760 +203 1 0.000221 1560.000000 0.000459 -0.001557 0.007870 +204 1 0.000198 1560.000000 0.000588 -0.001155 0.002077 +205 1 0.000193 1560.000000 -0.002014 0.001563 0.000490 +206 1 0.000237 1560.000000 -0.001360 -0.003562 0.008615 +207 1 0.000204 1560.000000 -0.000216 -0.003156 0.009075 +208 1 0.000215 1560.000000 -0.000758 0.001862 0.005924 +209 1 0.000269 1560.000000 -0.001979 0.003229 0.009020 +210 1 0.000260 1560.000000 0.000253 0.001661 0.001142 +211 1 0.000239 1560.000000 -0.000606 -0.001207 0.005281 +212 1 0.000215 1560.000000 0.002543 0.002061 0.001306 +213 1 0.000227 1560.000000 0.000329 -0.001157 0.002566 +214 1 0.000221 1560.000000 -0.003407 0.000645 0.009682 +215 1 0.000209 1560.000000 0.002106 0.000122 0.004737 +216 1 0.000273 1560.000000 -0.001438 -0.000803 0.001200 +217 1 0.000194 1560.000000 0.001382 -0.001687 0.004273 +218 1 0.000262 1560.000000 -0.003514 -0.001219 0.006249 +219 1 0.000281 1560.000000 0.000430 0.002503 0.001923 +220 1 0.000206 1560.000000 0.000932 0.000130 0.006431 +221 1 0.000267 1560.000000 -0.001525 0.001496 0.007740 +222 1 0.000269 1560.000000 0.000784 -0.000656 0.004351 +223 1 0.000202 1560.000000 -0.001642 -0.000005 0.009149 +224 1 0.000208 1560.000000 0.002769 0.000021 0.002063 +225 1 0.000210 1560.000000 -0.000337 0.001507 0.005194 +226 1 0.000200 1560.000000 -0.001084 0.001255 0.002069 +227 1 0.000199 1560.000000 0.001088 -0.002858 0.006694 +228 1 0.000207 1560.000000 -0.000317 0.002226 0.008669 +229 1 0.000199 1560.000000 0.001585 -0.001840 0.001720 +230 1 0.000240 1560.000000 -0.000044 0.001343 0.003140 +231 1 0.000245 1560.000000 0.000132 0.000126 0.004174 +232 1 0.000204 1560.000000 -0.000961 0.001684 0.006521 +233 1 0.000220 1560.000000 -0.000848 0.000382 0.004673 +234 1 0.000275 1560.000000 0.000896 -0.000783 0.007703 +235 1 0.000238 1560.000000 0.002389 0.001830 0.001126 +236 1 0.000264 1560.000000 -0.002387 0.002151 0.006864 +237 1 0.000253 1560.000000 0.002127 -0.001229 0.002479 +238 1 0.000207 1560.000000 0.000557 0.000267 0.000365 +239 1 0.000237 1560.000000 0.001089 0.000158 0.004714 +240 1 0.000258 1560.000000 0.002352 0.001182 0.008799 +241 1 0.000231 1560.000000 -0.001156 0.000269 0.002237 +242 1 0.000268 1560.000000 0.002280 -0.000867 0.003481 +243 1 0.000233 1560.000000 -0.001035 -0.003371 0.004884 +244 1 0.000202 1560.000000 0.001820 -0.002609 0.003003 +245 1 0.000222 1560.000000 0.000186 -0.000567 0.005062 +246 1 0.000272 1560.000000 0.000305 -0.000034 0.001804 +247 1 0.000247 1560.000000 -0.000659 0.001397 0.006732 +248 1 0.000196 1560.000000 -0.001709 0.002068 0.009398 +249 1 0.000239 1560.000000 0.000560 -0.000741 0.000344 +250 1 0.000198 1560.000000 0.000977 -0.001539 0.008061 +251 1 0.000204 1560.000000 0.000327 0.000008 0.004672 +252 1 0.000276 1560.000000 -0.000424 -0.002047 0.005116 +253 1 0.000205 1560.000000 -0.001524 0.001298 0.004969 +254 1 0.000198 1560.000000 0.002470 -0.001352 0.003942 +255 1 0.000255 1560.000000 -0.001336 -0.003034 0.004611 +256 1 0.000204 1560.000000 0.001270 -0.000582 0.003671 +257 1 0.000229 1560.000000 0.000817 0.000533 0.006858 +258 1 0.000214 1560.000000 0.000797 0.000577 0.001613 +259 1 0.000241 1560.000000 -0.001571 -0.000094 0.004459 +260 1 0.000264 1560.000000 0.000572 -0.000096 0.004627 +261 1 0.000246 1560.000000 -0.000210 -0.000032 0.001735 +262 1 0.000200 1560.000000 0.001364 -0.000397 0.006898 +263 1 0.000280 1560.000000 0.002868 0.001304 0.000507 +264 1 0.000239 1560.000000 0.001848 -0.000377 0.004486 +265 1 0.000216 1560.000000 -0.000124 0.000436 0.005904 +266 1 0.000207 1560.000000 -0.000018 0.000518 0.005562 +267 1 0.000195 1560.000000 -0.001105 0.001132 0.005937 +268 1 0.000215 1560.000000 0.001856 0.000254 0.007704 +269 1 0.000195 1560.000000 -0.000253 -0.002794 0.009019 +270 1 0.000246 1560.000000 -0.001030 0.000096 0.000959 +271 1 0.000272 1560.000000 0.001902 -0.000560 0.009484 +272 1 0.000253 1560.000000 -0.000731 -0.000205 0.003454 +273 1 0.000269 1560.000000 0.002908 -0.000934 0.004936 +274 1 0.000202 1560.000000 0.000846 -0.000599 0.001115 +275 1 0.000218 1560.000000 0.002967 -0.001434 0.005794 +276 1 0.000231 1560.000000 -0.002820 -0.000058 0.006038 +277 1 0.000262 1560.000000 -0.003074 0.000145 0.006819 +278 1 0.000260 1560.000000 0.003483 -0.000933 0.002575 +279 1 0.000230 1560.000000 0.001793 -0.002592 0.003823 +280 1 0.000231 1560.000000 -0.001145 -0.002099 0.000225 +281 1 0.000257 1560.000000 -0.003265 0.000257 0.007576 +282 1 0.000227 1560.000000 -0.001636 0.001083 0.008769 +283 1 0.000202 1560.000000 0.002974 -0.000784 0.008846 +284 1 0.000212 1560.000000 -0.002581 0.001257 0.007487 +285 1 0.000234 1560.000000 0.001346 0.000290 0.000613 +286 1 0.000275 1560.000000 -0.000891 -0.000920 0.002739 +287 1 0.000208 1560.000000 0.000983 -0.003357 0.005173 +288 1 0.000230 1560.000000 -0.003404 0.001634 0.000568 +289 1 0.000220 1560.000000 0.002107 -0.001778 0.005106 +290 1 0.000201 1560.000000 -0.000677 -0.001113 0.000882 +291 1 0.000196 1560.000000 0.000010 0.000006 0.009186 +292 1 0.000261 1560.000000 -0.000158 0.000089 0.005562 +293 1 0.000247 1560.000000 0.001587 -0.002354 0.003058 +294 1 0.000238 1560.000000 -0.001575 0.000382 0.005643 +295 1 0.000219 1560.000000 0.003762 -0.000528 0.005318 +296 1 0.000247 1560.000000 -0.003299 -0.000884 0.001741 +297 1 0.000247 1560.000000 0.001898 -0.000081 0.002720 +298 1 0.000203 1560.000000 -0.001252 0.001154 0.003674 +299 1 0.000211 1560.000000 -0.001337 0.002187 0.007398 +300 1 0.000223 1560.000000 -0.001777 0.002697 0.009161 +301 1 0.000207 1560.000000 -0.000221 -0.000322 0.001353 +302 1 0.000255 1560.000000 0.000245 0.000335 0.007342 +303 1 0.000226 1560.000000 0.000106 0.000440 0.002371 +304 1 0.000208 1560.000000 0.000142 -0.001388 0.004023 +305 1 0.000235 1560.000000 -0.001912 0.003308 0.002340 +306 1 0.000224 1560.000000 0.000690 -0.000702 0.009627 +307 1 0.000283 1560.000000 -0.001258 0.000364 0.009255 +308 1 0.000197 1560.000000 0.000944 -0.000798 0.005038 +309 1 0.000236 1560.000000 -0.001010 0.002174 0.006180 +310 1 0.000220 1560.000000 0.002619 -0.000637 0.005267 +311 1 0.000231 1560.000000 0.000700 -0.000606 0.008750 +312 1 0.000194 1560.000000 -0.001452 -0.001124 0.006867 +313 1 0.000237 1560.000000 -0.001090 0.002442 0.009122 +314 1 0.000285 1560.000000 0.001307 0.002709 0.007678 +315 1 0.000193 1560.000000 0.001830 0.001400 0.001897 +316 1 0.000271 1560.000000 -0.003790 -0.000033 0.002116 +317 1 0.000242 1560.000000 0.000731 -0.003370 0.008725 +318 1 0.000233 1560.000000 -0.000094 0.000007 0.000533 +319 1 0.000269 1560.000000 -0.000031 0.000242 0.002277 +320 1 0.000219 1560.000000 0.001476 -0.002500 0.000791 +321 1 0.000217 1560.000000 0.000206 0.002364 0.009321 +322 1 0.000281 1560.000000 -0.001864 0.001781 0.004907 +323 1 0.000255 1560.000000 -0.000172 -0.000507 0.007446 +324 1 0.000206 1560.000000 -0.002741 0.000897 0.005139 +325 1 0.000266 1560.000000 0.000277 0.002188 0.004751 +326 1 0.000234 1560.000000 -0.000749 0.000935 0.004024 +327 1 0.000249 1560.000000 -0.000270 -0.000961 0.002876 +328 1 0.000222 1560.000000 0.001256 0.001177 0.004148 +329 1 0.000263 1560.000000 -0.000618 0.002557 0.007612 +330 1 0.000239 1560.000000 0.000977 0.003160 0.000855 +331 1 0.000211 1560.000000 -0.000099 0.000053 0.006126 +332 1 0.000217 1560.000000 0.003143 -0.002020 0.007748 +333 1 0.000206 1560.000000 -0.003541 0.000836 0.005474 +334 1 0.000204 1560.000000 0.003654 0.000599 0.002317 +335 1 0.000229 1560.000000 -0.000033 0.000170 0.008123 +336 1 0.000279 1560.000000 0.001792 0.000238 0.004673 +337 1 0.000265 1560.000000 -0.000786 0.003405 0.004286 +338 1 0.000264 1560.000000 0.000491 -0.000580 0.006924 +339 1 0.000223 1560.000000 0.000677 -0.002068 0.004319 +340 1 0.000282 1560.000000 0.003094 -0.001733 0.005701 +341 1 0.000252 1560.000000 -0.003847 0.000040 0.001316 +342 1 0.000244 1560.000000 0.000238 0.000077 0.009351 +343 1 0.000277 1560.000000 -0.000686 0.001453 0.005967 +344 1 0.000235 1560.000000 -0.000600 -0.000782 0.008229 +345 1 0.000203 1560.000000 -0.001910 0.001805 0.008419 +346 1 0.000208 1560.000000 0.002102 0.002702 0.004056 +347 1 0.000227 1560.000000 -0.001236 0.000184 0.000346 +348 1 0.000231 1560.000000 0.002540 0.001017 0.007365 +349 1 0.000287 1560.000000 0.000015 0.000237 0.008929 +350 1 0.000285 1560.000000 0.002420 -0.000109 0.001133 +351 1 0.000268 1560.000000 -0.000184 0.001132 0.008478 +352 1 0.000193 1560.000000 -0.000468 0.001754 0.007542 +353 1 0.000201 1560.000000 -0.001372 -0.001212 0.000771 +354 1 0.000269 1560.000000 0.000210 -0.001531 0.003476 +355 1 0.000213 1560.000000 -0.000707 0.000560 0.000486 +356 1 0.000207 1560.000000 0.000391 -0.001862 0.007317 +357 1 0.000263 1560.000000 -0.003138 0.000609 0.002062 +358 1 0.000192 1560.000000 0.000222 -0.000679 0.003748 +359 1 0.000218 1560.000000 -0.000425 0.001368 0.002455 +360 1 0.000252 1560.000000 0.000335 0.000293 0.003701 +361 1 0.000207 1560.000000 -0.000519 0.000708 0.006305 +362 1 0.000200 1560.000000 0.000943 -0.001297 0.008185 +363 1 0.000201 1560.000000 -0.000634 0.000741 0.005401 +364 1 0.000196 1560.000000 0.000371 0.001359 0.009430 +365 1 0.000195 1560.000000 0.002323 -0.001384 0.002023 +366 1 0.000281 1560.000000 -0.002562 0.000266 0.008341 +367 1 0.000206 1560.000000 -0.000184 0.002023 0.004854 +368 1 0.000269 1560.000000 0.000897 0.000557 0.008875 +369 1 0.000266 1560.000000 0.000424 -0.002808 0.007782 +370 1 0.000238 1560.000000 0.001614 -0.000984 0.000728 +371 1 0.000212 1560.000000 0.000997 -0.002037 0.006249 +372 1 0.000243 1560.000000 -0.002333 -0.000796 0.004059 +373 1 0.000204 1560.000000 -0.000806 -0.000246 0.004816 +374 1 0.000207 1560.000000 0.001415 0.002158 0.006242 +375 1 0.000286 1560.000000 -0.003098 -0.001276 0.006569 +376 1 0.000195 1560.000000 0.001783 0.002926 0.001085 +377 1 0.000195 1560.000000 -0.001135 -0.000854 0.002803 +378 1 0.000277 1560.000000 0.000320 -0.001696 0.007592 +379 1 0.000273 1560.000000 0.000769 0.000044 0.009188 +380 1 0.000259 1560.000000 -0.000059 -0.000090 0.005811 +381 1 0.000194 1560.000000 0.000501 -0.002114 0.009000 +382 1 0.000265 1560.000000 0.000180 0.002356 0.005452 +383 1 0.000242 1560.000000 0.001319 -0.001681 0.006849 +384 1 0.000253 1560.000000 -0.001989 -0.001043 0.001848 +385 1 0.000197 1560.000000 -0.002005 -0.000476 0.001024 +386 1 0.000268 1560.000000 0.001367 0.001539 0.002991 +387 1 0.000203 1560.000000 0.000970 -0.000302 0.006423 +388 1 0.000238 1560.000000 -0.000720 0.000774 0.009765 +389 1 0.000219 1560.000000 -0.000383 -0.000494 0.000495 +390 1 0.000206 1560.000000 0.000771 -0.000774 0.006966 +391 1 0.000195 1560.000000 -0.001213 0.001444 0.008684 +392 1 0.000227 1560.000000 -0.000789 -0.003470 0.000537 +393 1 0.000236 1560.000000 0.000011 -0.000646 0.007948 +394 1 0.000210 1560.000000 -0.001028 0.000120 0.007499 +395 1 0.000275 1560.000000 0.000710 -0.000915 0.004603 +396 1 0.000218 1560.000000 -0.000024 -0.000196 0.000255 +397 1 0.000243 1560.000000 0.001641 -0.002707 0.004455 +398 1 0.000277 1560.000000 -0.001819 -0.000641 0.000575 +399 1 0.000231 1560.000000 -0.000231 -0.001152 0.002579 +400 1 0.000198 1560.000000 -0.001642 -0.000892 0.004934 +401 1 0.000285 1560.000000 -0.000471 0.002843 0.005252 +402 1 0.000210 1560.000000 -0.001137 -0.001177 0.004788 +403 1 0.000261 1560.000000 -0.000331 0.000022 0.009011 +404 1 0.000218 1560.000000 0.001058 -0.001376 0.004804 +405 1 0.000235 1560.000000 -0.001121 0.003463 0.007541 +406 1 0.000226 1560.000000 -0.003273 0.001410 0.006881 +407 1 0.000196 1560.000000 0.002791 0.001881 0.001274 +408 1 0.000195 1560.000000 -0.001721 -0.003144 0.001650 +409 1 0.000255 1560.000000 0.000831 0.000749 0.004569 +410 1 0.000213 1560.000000 -0.001713 0.003014 0.008727 +411 1 0.000198 1560.000000 0.001571 -0.002311 0.004639 +412 1 0.000276 1560.000000 -0.003638 0.000905 0.007480 +413 1 0.000252 1560.000000 -0.002796 -0.001706 0.009479 +414 1 0.000254 1560.000000 -0.001729 0.000826 0.008606 +415 1 0.000204 1560.000000 -0.002172 0.001393 0.005480 +416 1 0.000208 1560.000000 0.003035 0.001220 0.003680 +417 1 0.000254 1560.000000 0.002549 0.000846 0.000208 +418 1 0.000195 1560.000000 0.000684 -0.001549 0.004221 +419 1 0.000211 1560.000000 -0.001618 -0.000721 0.001654 +420 1 0.000255 1560.000000 0.002356 -0.003012 0.009718 +421 1 0.000193 1560.000000 0.000005 -0.000008 0.009735 +422 1 0.000210 1560.000000 0.000489 0.002339 0.000387 +423 1 0.000210 1560.000000 0.000403 0.001391 0.007620 +424 1 0.000225 1560.000000 -0.001690 -0.001883 0.007198 +425 1 0.000227 1560.000000 0.002476 0.000499 0.007516 +426 1 0.000232 1560.000000 0.000442 -0.003485 0.005109 +427 1 0.000286 1560.000000 -0.000986 0.003095 0.005335 +428 1 0.000239 1560.000000 -0.000065 -0.001327 0.007788 +429 1 0.000220 1560.000000 0.000178 0.000594 0.005286 +430 1 0.000258 1560.000000 -0.000369 -0.000308 0.005793 +431 1 0.000251 1560.000000 -0.001146 0.000813 0.006293 +432 1 0.000214 1560.000000 0.000599 -0.002518 0.008558 +433 1 0.000279 1560.000000 -0.002746 0.000723 0.001055 +434 1 0.000205 1560.000000 -0.000407 0.002145 0.007470 +435 1 0.000217 1560.000000 -0.003827 -0.000270 0.007075 +436 1 0.000207 1560.000000 -0.001181 0.000541 0.006485 +437 1 0.000259 1560.000000 0.003206 0.001081 0.006145 +438 1 0.000231 1560.000000 -0.000471 -0.002798 0.004448 +439 1 0.000277 1560.000000 -0.000507 -0.002217 0.006084 +440 1 0.000286 1560.000000 -0.002340 0.001236 0.008814 +441 1 0.000234 1560.000000 -0.001366 -0.003527 0.004339 +442 1 0.000250 1560.000000 -0.000552 -0.003364 0.007217 +443 1 0.000261 1560.000000 -0.001894 -0.002127 0.008078 +444 1 0.000236 1560.000000 -0.001190 -0.002507 0.002067 +445 1 0.000260 1560.000000 -0.003038 -0.000298 0.002887 +446 1 0.000273 1560.000000 0.000233 0.000149 0.007668 +447 1 0.000270 1560.000000 0.000598 0.000321 0.004709 +448 1 0.000211 1560.000000 0.000108 -0.000475 0.000725 +449 1 0.000247 1560.000000 0.002128 -0.002531 0.003239 +450 1 0.000193 1560.000000 -0.000046 0.002651 0.008848 +451 1 0.000225 1560.000000 -0.000053 -0.000949 0.003662 +452 1 0.000192 1560.000000 0.001293 -0.000154 0.005470 +453 1 0.000198 1560.000000 0.002423 -0.001390 0.005397 +454 1 0.000221 1560.000000 0.002190 -0.000255 0.001102 +455 1 0.000267 1560.000000 0.003415 -0.000380 0.003654 +456 1 0.000197 1560.000000 0.000791 0.002259 0.002197 +457 1 0.000235 1560.000000 0.001616 0.000399 0.004485 +458 1 0.000195 1560.000000 -0.001020 -0.000408 0.007876 +459 1 0.000210 1560.000000 0.002911 -0.001916 0.002578 +460 1 0.000201 1560.000000 -0.001544 0.003432 0.006655 +461 1 0.000245 1560.000000 0.001078 -0.001579 0.005050 +462 1 0.000282 1560.000000 -0.001336 0.003298 0.009267 +463 1 0.000219 1560.000000 0.000778 -0.002306 0.005528 +464 1 0.000219 1560.000000 -0.003417 0.001090 0.007688 +465 1 0.000197 1560.000000 0.002916 -0.002087 0.007559 +466 1 0.000232 1560.000000 0.000998 -0.000398 0.000747 +467 1 0.000228 1560.000000 0.002448 0.001411 0.002011 +468 1 0.000215 1560.000000 -0.002281 -0.002630 0.001012 +469 1 0.000241 1560.000000 0.003672 0.000842 0.003602 +470 1 0.000272 1560.000000 -0.002284 0.003050 0.006621 +471 1 0.000198 1560.000000 -0.000638 0.000615 0.002655 +472 1 0.000197 1560.000000 0.000847 -0.001274 0.009781 +473 1 0.000203 1560.000000 -0.000243 -0.001150 0.001106 +474 1 0.000198 1560.000000 0.000333 0.000772 0.005199 +475 1 0.000265 1560.000000 -0.001699 0.002517 0.008300 +476 1 0.000228 1560.000000 -0.000717 -0.001307 0.002947 +477 1 0.000195 1560.000000 0.002922 0.001124 0.002725 +478 1 0.000230 1560.000000 -0.000520 0.003348 0.009183 +479 1 0.000220 1560.000000 -0.001081 0.000275 0.002629 +480 1 0.000242 1560.000000 -0.002729 0.001006 0.008455 +481 1 0.000267 1560.000000 0.000218 0.002160 0.007347 +482 1 0.000238 1560.000000 -0.002355 0.001773 0.001426 +483 1 0.000205 1560.000000 0.001522 -0.000443 0.008238 +484 1 0.000207 1560.000000 0.002363 -0.000125 0.007765 +485 1 0.000206 1560.000000 0.000457 -0.003110 0.005735 +486 1 0.000268 1560.000000 -0.002227 0.001367 0.009315 +487 1 0.000253 1560.000000 -0.003060 0.000864 0.002594 +488 1 0.000230 1560.000000 0.000020 -0.000386 0.003854 +489 1 0.000284 1560.000000 -0.000053 0.000052 0.007770 +490 1 0.000225 1560.000000 0.000203 0.000853 0.001916 +491 1 0.000197 1560.000000 -0.001587 0.001505 0.001622 +492 1 0.000203 1560.000000 -0.000007 0.002403 0.000759 +493 1 0.000251 1560.000000 0.000036 -0.000308 0.008620 +494 1 0.000268 1560.000000 -0.000322 -0.000036 0.007655 +495 1 0.000283 1560.000000 0.001094 -0.001160 0.001391 +496 1 0.000203 1560.000000 0.000959 -0.000317 0.002008 +497 1 0.000258 1560.000000 -0.001355 0.001371 0.009431 +498 1 0.000220 1560.000000 0.003487 0.000816 0.005572 +499 1 0.000197 1560.000000 -0.000587 -0.000260 0.002530 +500 1 0.000204 1560.000000 0.000036 0.000510 0.001762 +501 1 0.000243 1560.000000 -0.000871 0.001604 0.003067 +502 1 0.000285 1560.000000 0.002001 -0.002258 0.002102 +503 1 0.000222 1560.000000 -0.000769 0.000819 0.007312 +504 1 0.000228 1560.000000 -0.001871 0.000426 0.001357 +505 1 0.000255 1560.000000 -0.000193 0.000910 0.003553 +506 1 0.000216 1560.000000 -0.000390 -0.000116 0.008812 +507 1 0.000208 1560.000000 -0.001403 -0.000940 0.000239 +508 1 0.000279 1560.000000 -0.001415 0.000032 0.003888 +509 1 0.000207 1560.000000 -0.002670 -0.000789 0.006988 +510 1 0.000243 1560.000000 -0.001197 0.002935 0.009408 +511 1 0.000215 1560.000000 0.002635 -0.001967 0.006242 +512 1 0.000224 1560.000000 -0.001727 -0.001120 0.002565 +513 1 0.000268 1560.000000 -0.002071 0.000418 0.002328 +514 1 0.000218 1560.000000 0.001071 -0.000383 0.002231 +515 1 0.000255 1560.000000 0.000334 -0.000777 0.007209 +516 1 0.000253 1560.000000 -0.001771 0.000027 0.007420 +517 1 0.000231 1560.000000 0.000135 -0.001019 0.000517 +518 1 0.000194 1560.000000 -0.003477 -0.000577 0.005987 +519 1 0.000286 1560.000000 -0.002530 -0.002238 0.004379 +520 1 0.000203 1560.000000 0.000738 -0.002383 0.005250 +521 1 0.000201 1560.000000 -0.000602 -0.003280 0.009673 +522 1 0.000277 1560.000000 -0.000632 -0.002190 0.004083 +523 1 0.000211 1560.000000 0.001797 -0.001035 0.007962 +524 1 0.000195 1560.000000 0.000766 0.003139 0.003704 +525 1 0.000207 1560.000000 0.000254 -0.000933 0.003260 +526 1 0.000214 1560.000000 0.000503 -0.002258 0.004703 +527 1 0.000214 1560.000000 0.000725 0.002098 0.007952 +528 1 0.000284 1560.000000 -0.000258 0.000624 0.007088 +529 1 0.000201 1560.000000 -0.000904 0.001589 0.005410 +530 1 0.000269 1560.000000 -0.000219 0.000875 0.006674 +531 1 0.000205 1560.000000 -0.001164 0.002566 0.008706 +532 1 0.000221 1560.000000 -0.003259 -0.000518 0.003346 +533 1 0.000283 1560.000000 -0.000105 0.000548 0.008101 +534 1 0.000256 1560.000000 -0.000435 -0.002772 0.006320 +535 1 0.000241 1560.000000 -0.001932 -0.002755 0.005232 +536 1 0.000198 1560.000000 -0.000550 -0.002873 0.000460 +537 1 0.000219 1560.000000 0.002044 -0.000536 0.000948 +538 1 0.000224 1560.000000 -0.003671 0.000620 0.006588 +539 1 0.000232 1560.000000 -0.000186 -0.002753 0.006712 +540 1 0.000282 1560.000000 0.002381 0.002467 0.003162 +541 1 0.000253 1560.000000 -0.002733 0.001346 0.000718 +542 1 0.000256 1560.000000 -0.001657 -0.001186 0.005595 +543 1 0.000245 1560.000000 0.002653 -0.000712 0.002329 +544 1 0.000274 1560.000000 -0.000578 -0.002285 0.004578 +545 1 0.000198 1560.000000 0.000167 0.000493 0.003533 +546 1 0.000211 1560.000000 0.000312 -0.000437 0.000317 +547 1 0.000212 1560.000000 0.000702 -0.002542 0.007634 +548 1 0.000193 1560.000000 0.000521 -0.000459 0.002500 +549 1 0.000264 1560.000000 -0.001813 0.000014 0.008047 +550 1 0.000206 1560.000000 -0.002396 0.000840 0.008450 +551 1 0.000196 1560.000000 -0.000496 -0.000188 0.001030 +552 1 0.000227 1560.000000 -0.000169 0.000351 0.002840 +553 1 0.000275 1560.000000 0.000096 -0.000973 0.005510 +554 1 0.000247 1560.000000 -0.001280 -0.000271 0.001142 +555 1 0.000193 1560.000000 0.002387 0.001234 0.007644 +556 1 0.000201 1560.000000 -0.001148 0.002096 0.009789 +557 1 0.000216 1560.000000 -0.000051 0.002353 0.000487 +558 1 0.000215 1560.000000 0.000134 -0.000060 0.003903 +559 1 0.000282 1560.000000 -0.000352 0.000450 0.007474 +560 1 0.000221 1560.000000 -0.000675 0.001413 0.009691 +561 1 0.000202 1560.000000 0.000206 -0.000357 0.002063 +562 1 0.000239 1560.000000 -0.000161 0.001401 0.002095 +563 1 0.000205 1560.000000 -0.000585 -0.003458 0.000195 +564 1 0.000248 1560.000000 -0.002794 0.000023 0.004810 +565 1 0.000197 1560.000000 -0.000275 -0.003157 0.002962 +566 1 0.000281 1560.000000 0.000109 0.000064 0.006792 +567 1 0.000198 1560.000000 0.000180 -0.000588 0.007566 +568 1 0.000237 1560.000000 -0.002915 0.000227 0.001155 +569 1 0.000227 1560.000000 0.000147 0.003523 0.000600 +570 1 0.000210 1560.000000 0.001909 -0.001803 0.007688 +571 1 0.000206 1560.000000 -0.001548 0.001526 0.006671 +572 1 0.000273 1560.000000 -0.001165 -0.001207 0.000192 +573 1 0.000198 1560.000000 -0.002971 -0.000439 0.003545 +574 1 0.000264 1560.000000 0.000470 -0.000178 0.003228 +575 1 0.000287 1560.000000 0.000168 -0.003069 0.007179 +576 1 0.000208 1560.000000 -0.000864 0.000521 0.007697 +577 1 0.000265 1560.000000 -0.001440 -0.000205 0.001540 +578 1 0.000266 1560.000000 -0.000219 -0.001004 0.000246 +579 1 0.000220 1560.000000 -0.000733 0.000371 0.000315 +580 1 0.000207 1560.000000 0.002571 0.000471 0.001094 +581 1 0.000264 1560.000000 -0.000107 -0.003601 0.008960 +582 1 0.000201 1560.000000 -0.002119 -0.000246 0.000581 +583 1 0.000258 1560.000000 -0.002077 0.001380 0.006097 +584 1 0.000271 1560.000000 0.000892 -0.002219 0.003464 +585 1 0.000235 1560.000000 -0.001338 -0.001006 0.001329 +586 1 0.000199 1560.000000 -0.001050 -0.000851 0.003369 +587 1 0.000250 1560.000000 0.000768 0.001005 0.009699 +588 1 0.000239 1560.000000 0.003101 0.000957 0.004454 +589 1 0.000272 1560.000000 0.000783 -0.000873 0.008727 +590 1 0.000263 1560.000000 -0.000957 -0.001132 0.006036 +591 1 0.000192 1560.000000 -0.002770 -0.001986 0.007187 +592 1 0.000209 1560.000000 0.000697 -0.003085 0.000969 +593 1 0.000204 1560.000000 -0.000179 -0.001994 0.009715 +594 1 0.000209 1560.000000 -0.000270 0.000500 0.009759 +595 1 0.000224 1560.000000 -0.001725 0.000026 0.002541 +596 1 0.000236 1560.000000 -0.000132 -0.003374 0.000716 +597 1 0.000264 1560.000000 -0.000371 0.001340 0.001716 +598 1 0.000209 1560.000000 -0.000873 -0.000942 0.008531 +599 1 0.000210 1560.000000 -0.000863 0.003259 0.003599 +600 1 0.000208 1560.000000 -0.001374 0.001831 0.005957 +601 1 0.000263 1560.000000 -0.000931 -0.000757 0.007361 +602 1 0.000270 1560.000000 -0.000831 0.000056 0.004072 +603 1 0.000205 1560.000000 0.000105 -0.001096 0.007460 +604 1 0.000225 1560.000000 -0.001486 0.002041 0.008821 +605 1 0.000215 1560.000000 0.000434 0.001313 0.004690 +606 1 0.000208 1560.000000 -0.001718 -0.002624 0.005172 +607 1 0.000259 1560.000000 -0.000735 -0.002587 0.009151 +608 1 0.000251 1560.000000 -0.001327 -0.001985 0.007851 +609 1 0.000206 1560.000000 -0.000825 -0.003202 0.001758 +610 1 0.000256 1560.000000 0.001927 0.001270 0.003696 +611 1 0.000227 1560.000000 0.000069 0.000336 0.003976 +612 1 0.000199 1560.000000 -0.000702 -0.000458 0.000428 +613 1 0.000258 1560.000000 -0.002284 -0.002008 0.004068 +614 1 0.000199 1560.000000 0.000328 0.003677 0.004646 +615 1 0.000250 1560.000000 -0.000306 0.000251 0.001954 +616 1 0.000246 1560.000000 -0.003051 -0.001942 0.007282 +617 1 0.000225 1560.000000 -0.001224 0.000343 0.004963 +618 1 0.000215 1560.000000 0.000375 0.000466 0.004538 +619 1 0.000246 1560.000000 0.002111 0.001390 0.005007 +620 1 0.000226 1560.000000 0.000611 -0.002188 0.007634 +621 1 0.000227 1560.000000 -0.002479 0.002280 0.003265 +622 1 0.000219 1560.000000 -0.001896 -0.000470 0.003141 +623 1 0.000240 1560.000000 0.000463 -0.001886 0.006836 +624 1 0.000207 1560.000000 0.000531 -0.001652 0.005953 +625 1 0.000221 1560.000000 0.000988 0.001057 0.007306 +626 1 0.000260 1560.000000 -0.001672 0.000619 0.002344 +627 1 0.000242 1560.000000 -0.000786 -0.001093 0.009789 +628 1 0.000250 1560.000000 0.002521 0.001581 0.006386 +629 1 0.000240 1560.000000 -0.000689 -0.000662 0.004647 +630 1 0.000201 1560.000000 -0.002893 -0.000085 0.007319 +631 1 0.000205 1560.000000 0.001755 -0.000446 0.009781 +632 1 0.000281 1560.000000 0.002548 0.000139 0.007135 +633 1 0.000197 1560.000000 -0.000830 -0.002859 0.002522 +634 1 0.000220 1560.000000 -0.000094 -0.000872 0.003897 +635 1 0.000215 1560.000000 0.003416 -0.000532 0.005897 +636 1 0.000206 1560.000000 -0.000469 0.001233 0.004674 +637 1 0.000222 1560.000000 -0.002301 -0.001285 0.003489 +638 1 0.000217 1560.000000 0.000327 -0.001328 0.002057 +639 1 0.000194 1560.000000 0.001744 0.002072 0.002528 +640 1 0.000200 1560.000000 -0.001362 0.002182 0.006835 +641 1 0.000235 1560.000000 -0.002408 -0.002984 0.009790 +642 1 0.000283 1560.000000 0.002500 -0.000221 0.006567 +643 1 0.000210 1560.000000 -0.000289 -0.000235 0.009736 +644 1 0.000197 1560.000000 -0.002200 -0.000330 0.008557 +645 1 0.000202 1560.000000 -0.000673 -0.002328 0.007352 +646 1 0.000265 1560.000000 0.000065 0.001722 0.008112 +647 1 0.000230 1560.000000 -0.002580 -0.000350 0.000195 +648 1 0.000194 1560.000000 -0.001391 0.000609 0.008967 +649 1 0.000196 1560.000000 -0.002121 0.000581 0.004207 +650 1 0.000196 1560.000000 0.000552 0.000584 0.007679 +651 1 0.000258 1560.000000 -0.003472 -0.001266 0.002972 +652 1 0.000202 1560.000000 -0.000868 0.000730 0.006134 +653 1 0.000283 1560.000000 0.003115 0.000321 0.000603 +654 1 0.000198 1560.000000 -0.000636 0.003238 0.001715 +655 1 0.000263 1560.000000 0.000086 -0.000958 0.001520 +656 1 0.000280 1560.000000 -0.000308 0.003013 0.005769 +657 1 0.000214 1560.000000 0.001641 -0.003142 0.001815 +658 1 0.000210 1560.000000 0.000154 -0.000348 0.006890 +659 1 0.000242 1560.000000 0.000388 -0.000748 0.000962 +660 1 0.000227 1560.000000 -0.001354 0.001351 0.000185 +661 1 0.000225 1560.000000 0.002433 0.002601 0.004239 +662 1 0.000194 1560.000000 -0.002517 -0.000311 0.001810 +663 1 0.000201 1560.000000 0.000009 0.003505 0.000284 +664 1 0.000243 1560.000000 -0.000460 0.000555 0.008105 +665 1 0.000268 1560.000000 -0.000929 -0.001481 0.006431 +666 1 0.000234 1560.000000 0.001164 0.002522 0.000691 +667 1 0.000216 1560.000000 -0.001103 -0.000472 0.000866 +668 1 0.000254 1560.000000 0.001087 0.003665 0.002945 +669 1 0.000263 1560.000000 0.001090 -0.001690 0.000957 +670 1 0.000195 1560.000000 0.001730 0.002855 0.009208 +671 1 0.000238 1560.000000 -0.002235 0.001544 0.007208 +672 1 0.000278 1560.000000 0.001996 0.001974 0.000660 +673 1 0.000262 1560.000000 -0.002386 -0.001362 0.000478 +674 1 0.000270 1560.000000 -0.001749 0.001499 0.005933 +675 1 0.000284 1560.000000 -0.000231 0.000272 0.006382 +676 1 0.000218 1560.000000 -0.002393 0.001414 0.003581 +677 1 0.000238 1560.000000 -0.002482 -0.000018 0.003468 +678 1 0.000219 1560.000000 0.000250 0.000150 0.003460 +679 1 0.000239 1560.000000 0.001151 0.000585 0.001804 +680 1 0.000202 1560.000000 0.000298 -0.000306 0.005216 +681 1 0.000224 1560.000000 0.001952 0.001197 0.004575 +682 1 0.000256 1560.000000 0.000662 -0.002498 0.000665 +683 1 0.000220 1560.000000 0.000226 0.000499 0.006561 +684 1 0.000206 1560.000000 -0.000079 0.000583 0.008655 +685 1 0.000224 1560.000000 0.000710 0.001742 0.008068 +686 1 0.000213 1560.000000 -0.000683 -0.000008 0.002645 +687 1 0.000238 1560.000000 0.001911 0.001038 0.009648 +688 1 0.000219 1560.000000 -0.000840 0.002494 0.007471 +689 1 0.000282 1560.000000 -0.001572 0.001083 0.002746 +690 1 0.000251 1560.000000 -0.002601 -0.000531 0.009640 +691 1 0.000218 1560.000000 0.001143 0.001942 0.004699 +692 1 0.000234 1560.000000 -0.002868 -0.000506 0.004553 +693 1 0.000192 1560.000000 0.000744 -0.000393 0.003464 +694 1 0.000254 1560.000000 0.000210 -0.003515 0.007021 +695 1 0.000248 1560.000000 -0.002743 -0.000713 0.006539 +696 1 0.000281 1560.000000 0.000754 0.001441 0.007882 +697 1 0.000230 1560.000000 0.002332 -0.000153 0.007549 +698 1 0.000285 1560.000000 -0.000436 -0.003654 0.003119 +699 1 0.000285 1560.000000 0.000126 -0.000802 0.006993 +700 1 0.000243 1560.000000 0.003563 0.001262 0.003975 +701 1 0.000195 1560.000000 0.000424 0.002975 0.003234 +702 1 0.000230 1560.000000 -0.001056 0.000051 0.001439 +703 1 0.000222 1560.000000 -0.000460 0.000985 0.003068 +704 1 0.000232 1560.000000 0.000114 0.000156 0.001523 +705 1 0.000205 1560.000000 -0.000812 -0.000171 0.004522 +706 1 0.000235 1560.000000 -0.001627 -0.002552 0.007718 +707 1 0.000237 1560.000000 0.001112 0.002470 0.008791 +708 1 0.000209 1560.000000 0.000437 -0.000966 0.008758 +709 1 0.000217 1560.000000 0.000695 -0.000044 0.002186 +710 1 0.000233 1560.000000 -0.000253 0.000060 0.008427 +711 1 0.000247 1560.000000 0.001164 0.002536 0.004395 +712 1 0.000244 1560.000000 0.001133 0.000574 0.009464 +713 1 0.000278 1560.000000 -0.000714 -0.001103 0.004980 +714 1 0.000207 1560.000000 0.001981 0.001843 0.006404 +715 1 0.000226 1560.000000 -0.001604 -0.000284 0.002437 +716 1 0.000283 1560.000000 -0.002368 -0.001397 0.005157 +717 1 0.000205 1560.000000 0.003176 0.000235 0.003811 +718 1 0.000226 1560.000000 -0.002505 0.000273 0.000362 +719 1 0.000237 1560.000000 0.003680 -0.000330 0.005410 +720 1 0.000250 1560.000000 -0.000262 0.000661 0.003972 +721 1 0.000213 1560.000000 0.002749 0.002291 0.003394 +722 1 0.000282 1560.000000 0.000740 0.000056 0.004866 +723 1 0.000211 1560.000000 -0.000834 -0.000971 0.009329 +724 1 0.000259 1560.000000 0.000399 -0.000188 0.001564 +725 1 0.000201 1560.000000 -0.000194 -0.000126 0.007312 +726 1 0.000284 1560.000000 -0.000374 0.001916 0.003962 +727 1 0.000195 1560.000000 -0.001476 -0.000238 0.000418 +728 1 0.000243 1560.000000 -0.002035 0.000058 0.008433 +729 1 0.000238 1560.000000 0.001227 0.002012 0.003671 +730 1 0.000219 1560.000000 -0.002459 0.002435 0.007110 +731 1 0.000215 1560.000000 0.001111 0.001537 0.006736 +732 1 0.000236 1560.000000 -0.000780 0.001814 0.005305 +733 1 0.000225 1560.000000 0.003183 0.001333 0.007695 +734 1 0.000200 1560.000000 -0.000791 -0.001050 0.005544 +735 1 0.000252 1560.000000 0.000522 -0.000587 0.002800 +736 1 0.000234 1560.000000 -0.001016 0.001087 0.009196 +737 1 0.000274 1560.000000 0.000479 0.001525 0.001012 +738 1 0.000242 1560.000000 -0.000877 -0.001060 0.004714 +739 1 0.000259 1560.000000 0.002762 0.001770 0.003939 +740 1 0.000255 1560.000000 -0.000184 -0.000937 0.004276 +741 1 0.000213 1560.000000 -0.000194 -0.001183 0.009467 +742 1 0.000223 1560.000000 -0.000512 -0.002282 0.007175 +743 1 0.000201 1560.000000 0.002072 -0.000882 0.007495 +744 1 0.000260 1560.000000 0.001324 -0.001993 0.003263 +745 1 0.000226 1560.000000 -0.000979 -0.000291 0.000604 +746 1 0.000215 1560.000000 -0.002899 0.000610 0.002808 +747 1 0.000249 1560.000000 0.000288 0.000805 0.006985 +748 1 0.000196 1560.000000 0.000323 -0.002344 0.002669 +749 1 0.000206 1560.000000 0.002182 -0.001727 0.007532 +750 1 0.000224 1560.000000 -0.000477 0.000490 0.009690 +751 1 0.000245 1560.000000 -0.003370 0.001435 0.005613 +752 1 0.000229 1560.000000 0.000726 0.003783 0.004338 +753 1 0.000243 1560.000000 -0.000066 0.000132 0.001218 +754 1 0.000272 1560.000000 -0.001824 0.000757 0.001318 +755 1 0.000278 1560.000000 -0.000432 0.001457 0.002996 +756 1 0.000246 1560.000000 -0.002811 -0.001654 0.005219 +757 1 0.000195 1560.000000 0.002740 0.002609 0.007441 +758 1 0.000219 1560.000000 0.003512 0.000907 0.001781 +759 1 0.000278 1560.000000 0.002842 -0.002583 0.008331 +760 1 0.000218 1560.000000 0.003128 -0.001124 0.008940 +761 1 0.000218 1560.000000 -0.000419 0.000294 0.009097 +762 1 0.000202 1560.000000 -0.001361 -0.001514 0.000666 +763 1 0.000249 1560.000000 -0.002295 0.000726 0.009747 +764 1 0.000245 1560.000000 0.001423 0.000753 0.002932 +765 1 0.000226 1560.000000 0.003468 0.001153 0.003208 +766 1 0.000200 1560.000000 -0.001401 -0.001117 0.000378 +767 1 0.000253 1560.000000 -0.000085 -0.001242 0.002302 +768 1 0.000227 1560.000000 -0.000123 0.000086 0.002045 +769 1 0.000197 1560.000000 0.000066 0.000792 0.007549 +770 1 0.000219 1560.000000 -0.003181 0.000353 0.004580 +771 1 0.000237 1560.000000 0.000584 -0.001715 0.002799 +772 1 0.000221 1560.000000 0.000213 -0.000186 0.003521 +773 1 0.000226 1560.000000 -0.000845 -0.000584 0.002504 +774 1 0.000209 1560.000000 -0.000267 -0.000158 0.003347 +775 1 0.000241 1560.000000 0.003113 0.001916 0.001779 +776 1 0.000248 1560.000000 0.000738 -0.000668 0.001705 +777 1 0.000218 1560.000000 -0.001770 -0.000633 0.008259 +778 1 0.000232 1560.000000 -0.000144 0.000233 0.009204 +779 1 0.000216 1560.000000 -0.000270 0.001157 0.006688 +780 1 0.000208 1560.000000 -0.000099 0.000519 0.003336 +781 1 0.000230 1560.000000 0.001578 -0.002757 0.004219 +782 1 0.000227 1560.000000 0.000146 -0.001952 0.003493 +783 1 0.000229 1560.000000 0.001906 0.003190 0.006981 +784 1 0.000206 1560.000000 0.000960 -0.000606 0.002354 +785 1 0.000209 1560.000000 0.001031 0.002786 0.002782 +786 1 0.000270 1560.000000 -0.001604 0.000170 0.001736 +787 1 0.000249 1560.000000 -0.002043 -0.002788 0.008219 +788 1 0.000203 1560.000000 0.000280 -0.002336 0.005463 +789 1 0.000271 1560.000000 0.000123 0.000529 0.001461 +790 1 0.000259 1560.000000 -0.000504 -0.000930 0.004220 +791 1 0.000195 1560.000000 0.002713 0.000639 0.007759 +792 1 0.000268 1560.000000 0.001938 -0.000281 0.005118 +793 1 0.000197 1560.000000 -0.002691 0.001245 0.006874 +794 1 0.000235 1560.000000 -0.002950 0.002388 0.009049 +795 1 0.000194 1560.000000 -0.000999 -0.000766 0.001153 +796 1 0.000197 1560.000000 0.000215 0.000980 0.000290 +797 1 0.000205 1560.000000 -0.001302 -0.003458 0.003723 +798 1 0.000193 1560.000000 -0.000329 0.000416 0.003035 +799 1 0.000201 1560.000000 0.000011 -0.000016 0.001398 +800 1 0.000203 1560.000000 0.001520 0.000877 0.001105 +801 1 0.000276 1560.000000 -0.000844 0.000109 0.006845 +802 1 0.000279 1560.000000 -0.003024 0.001733 0.007558 +803 1 0.000214 1560.000000 -0.000449 -0.001811 0.003272 +804 1 0.000278 1560.000000 -0.002489 -0.000640 0.005549 +805 1 0.000241 1560.000000 -0.002903 -0.002448 0.008743 +806 1 0.000202 1560.000000 -0.003031 -0.002124 0.003900 +807 1 0.000243 1560.000000 0.000737 0.003082 0.006416 +808 1 0.000225 1560.000000 0.000185 0.003317 0.005389 +809 1 0.000261 1560.000000 -0.001367 -0.002170 0.009162 +810 1 0.000277 1560.000000 0.003288 -0.000734 0.000709 +811 1 0.000193 1560.000000 0.001329 -0.001244 0.003495 +812 1 0.000198 1560.000000 0.000472 0.000615 0.001465 +813 1 0.000244 1560.000000 0.003260 0.001507 0.002850 +814 1 0.000196 1560.000000 0.001942 -0.001881 0.000542 +815 1 0.000209 1560.000000 0.001691 0.003204 0.003740 +816 1 0.000245 1560.000000 -0.003106 0.000743 0.007132 +817 1 0.000226 1560.000000 0.001675 -0.000870 0.005146 +818 1 0.000193 1560.000000 -0.001249 -0.001747 0.001899 +819 1 0.000248 1560.000000 0.001835 0.001348 0.008878 +820 1 0.000209 1560.000000 0.002592 -0.002628 0.001133 +821 1 0.000259 1560.000000 0.000410 -0.002038 0.003111 +822 1 0.000253 1560.000000 0.003341 -0.000951 0.006051 +823 1 0.000201 1560.000000 -0.001301 -0.003393 0.000208 +824 1 0.000193 1560.000000 -0.001105 -0.002341 0.001622 +825 1 0.000256 1560.000000 0.002585 -0.000915 0.000209 +826 1 0.000271 1560.000000 -0.000896 0.002207 0.005010 +827 1 0.000220 1560.000000 0.000594 0.000506 0.006798 +828 1 0.000246 1560.000000 0.000467 0.001135 0.000207 +829 1 0.000283 1560.000000 -0.000475 -0.002443 0.002076 +830 1 0.000214 1560.000000 -0.002200 -0.000053 0.005351 +831 1 0.000281 1560.000000 0.000507 -0.000525 0.004153 +832 1 0.000193 1560.000000 -0.000502 0.001227 0.005968 +833 1 0.000211 1560.000000 -0.001820 -0.000847 0.004216 +834 1 0.000214 1560.000000 0.000964 -0.002224 0.001566 +835 1 0.000217 1560.000000 0.001145 -0.002043 0.008723 +836 1 0.000200 1560.000000 -0.000662 -0.002150 0.003352 +837 1 0.000202 1560.000000 0.000400 -0.003566 0.001123 +838 1 0.000221 1560.000000 -0.000009 0.000417 0.007195 +839 1 0.000220 1560.000000 -0.000249 0.000283 0.006078 +840 1 0.000224 1560.000000 -0.002904 0.001148 0.000561 +841 1 0.000263 1560.000000 0.002116 0.001309 0.008069 +842 1 0.000271 1560.000000 -0.000414 -0.000243 0.007056 +843 1 0.000211 1560.000000 0.003230 -0.002097 0.007065 +844 1 0.000269 1560.000000 0.001496 -0.001554 0.001920 +845 1 0.000246 1560.000000 0.000506 0.002853 0.002500 +846 1 0.000208 1560.000000 -0.000378 -0.003500 0.008422 +847 1 0.000195 1560.000000 0.002092 0.002254 0.007027 +848 1 0.000225 1560.000000 0.000162 0.000036 0.003074 +849 1 0.000198 1560.000000 -0.000539 0.001753 0.005479 +850 1 0.000199 1560.000000 -0.003602 0.000489 0.007819 +851 1 0.000240 1560.000000 -0.000108 0.000831 0.008302 +852 1 0.000202 1560.000000 -0.000571 -0.000305 0.004990 +853 1 0.000268 1560.000000 -0.003349 -0.000548 0.004174 +854 1 0.000203 1560.000000 0.000089 -0.000196 0.004168 +855 1 0.000254 1560.000000 -0.002275 -0.002650 0.007825 +856 1 0.000197 1560.000000 0.000388 0.001222 0.008897 +857 1 0.000199 1560.000000 -0.001810 -0.001544 0.002795 +858 1 0.000209 1560.000000 -0.001789 0.002884 0.003844 +859 1 0.000225 1560.000000 -0.001651 0.000816 0.002917 +860 1 0.000225 1560.000000 0.000361 -0.000432 0.009677 +861 1 0.000250 1560.000000 -0.002249 -0.001108 0.004808 +862 1 0.000206 1560.000000 0.001515 0.001133 0.000763 +863 1 0.000284 1560.000000 0.001004 -0.000050 0.000252 +864 1 0.000251 1560.000000 -0.000765 -0.003550 0.003456 +865 1 0.000254 1560.000000 0.000163 -0.000350 0.001334 +866 1 0.000210 1560.000000 -0.000760 0.001335 0.000643 +867 1 0.000251 1560.000000 -0.003639 -0.001069 0.005518 +868 1 0.000273 1560.000000 -0.001340 -0.002590 0.009659 +869 1 0.000232 1560.000000 0.002297 -0.001925 0.004653 +870 1 0.000229 1560.000000 0.002712 -0.000828 0.008441 +871 1 0.000241 1560.000000 0.000501 0.000148 0.000686 +872 1 0.000196 1560.000000 0.001763 0.000719 0.003322 +873 1 0.000250 1560.000000 0.000260 0.003340 0.002186 +874 1 0.000233 1560.000000 -0.002910 0.000176 0.000687 +875 1 0.000194 1560.000000 -0.001767 0.000009 0.003978 +876 1 0.000198 1560.000000 0.000562 0.000706 0.002235 +877 1 0.000223 1560.000000 0.002897 -0.000634 0.006065 +878 1 0.000203 1560.000000 0.002569 -0.001354 0.007303 +879 1 0.000209 1560.000000 0.000147 0.000897 0.007168 +880 1 0.000249 1560.000000 0.000614 0.001874 0.005592 +881 1 0.000262 1560.000000 0.001403 0.000727 0.006648 +882 1 0.000242 1560.000000 -0.000638 -0.001813 0.002148 +883 1 0.000275 1560.000000 -0.001939 0.000250 0.007233 +884 1 0.000262 1560.000000 0.002962 -0.000173 0.005043 +885 1 0.000195 1560.000000 -0.002117 -0.000060 0.006631 +886 1 0.000194 1560.000000 0.001087 -0.000359 0.005108 +887 1 0.000237 1560.000000 -0.001856 0.000651 0.002997 +888 1 0.000233 1560.000000 0.000548 0.003741 0.007746 +889 1 0.000203 1560.000000 0.000368 -0.001686 0.000963 +890 1 0.000203 1560.000000 0.002319 -0.001140 0.006250 +891 1 0.000200 1560.000000 0.000834 -0.001600 0.003964 +892 1 0.000197 1560.000000 -0.001175 -0.001127 0.007038 +893 1 0.000201 1560.000000 0.002549 0.001726 0.008410 +894 1 0.000196 1560.000000 0.003411 0.000097 0.007456 +895 1 0.000196 1560.000000 -0.001787 -0.001986 0.007398 +896 1 0.000203 1560.000000 0.001942 0.000366 0.002207 +897 1 0.000288 1560.000000 0.001674 -0.001760 0.000228 +898 1 0.000196 1560.000000 0.001076 -0.000826 0.000682 +899 1 0.000222 1560.000000 -0.000424 0.000144 0.003584 +900 1 0.000244 1560.000000 0.001004 0.001795 0.006322 +901 1 0.000228 1560.000000 0.000201 0.001114 0.001384 +902 1 0.000210 1560.000000 0.001587 -0.000193 0.007821 +903 1 0.000237 1560.000000 0.002069 0.001485 0.008671 +904 1 0.000212 1560.000000 0.001909 0.000068 0.008235 +905 1 0.000240 1560.000000 -0.001664 -0.000731 0.005628 +906 1 0.000220 1560.000000 0.000367 -0.002068 0.002861 +907 1 0.000211 1560.000000 -0.001103 -0.001481 0.009687 +908 1 0.000201 1560.000000 0.000109 -0.000847 0.000839 +909 1 0.000243 1560.000000 -0.001521 -0.001399 0.001314 +910 1 0.000199 1560.000000 0.000450 -0.000260 0.006610 +911 1 0.000201 1560.000000 0.003056 -0.000466 0.004350 +912 1 0.000205 1560.000000 -0.000921 0.001102 0.004616 +913 1 0.000231 1560.000000 0.000829 0.000383 0.004556 +914 1 0.000226 1560.000000 -0.000507 0.000166 0.002727 +915 1 0.000214 1560.000000 0.001543 0.000945 0.008143 +916 1 0.000218 1560.000000 0.000065 -0.000181 0.000556 +917 1 0.000238 1560.000000 0.000049 -0.002568 0.007307 +918 1 0.000233 1560.000000 0.002040 -0.002563 0.006423 +919 1 0.000285 1560.000000 0.001090 -0.000721 0.003103 +920 1 0.000204 1560.000000 -0.000050 0.000204 0.007023 +921 1 0.000237 1560.000000 0.002236 0.000777 0.001394 +922 1 0.000218 1560.000000 -0.002932 -0.001816 0.006523 +923 1 0.000211 1560.000000 0.001212 -0.000049 0.008172 +924 1 0.000237 1560.000000 0.000272 0.001638 0.001839 +925 1 0.000287 1560.000000 -0.003293 0.000257 0.008478 +926 1 0.000204 1560.000000 0.000725 0.000289 0.001651 +927 1 0.000253 1560.000000 0.001989 -0.001772 0.006042 +928 1 0.000248 1560.000000 0.002770 -0.000648 0.002738 +929 1 0.000238 1560.000000 0.002939 -0.002438 0.005345 +930 1 0.000194 1560.000000 0.000301 0.000082 0.008843 +931 1 0.000208 1560.000000 -0.000461 0.002345 0.001006 +932 1 0.000249 1560.000000 0.000787 0.001273 0.003275 +933 1 0.000194 1560.000000 -0.000979 -0.001486 0.003379 +934 1 0.000286 1560.000000 -0.001242 -0.001195 0.005883 +935 1 0.000198 1560.000000 0.000189 -0.001364 0.008563 +936 1 0.000211 1560.000000 -0.001865 -0.002020 0.001695 +937 1 0.000218 1560.000000 -0.003423 0.000433 0.007104 +938 1 0.000217 1560.000000 -0.001505 0.002885 0.002379 +939 1 0.000214 1560.000000 0.000349 0.000655 0.006341 +940 1 0.000261 1560.000000 0.001692 -0.003076 0.006084 +941 1 0.000266 1560.000000 0.001303 0.000721 0.009000 +942 1 0.000273 1560.000000 0.001875 0.002083 0.002277 +943 1 0.000285 1560.000000 0.001421 0.002843 0.001960 +944 1 0.000224 1560.000000 -0.000139 0.001773 0.009674 +945 1 0.000198 1560.000000 -0.001905 -0.003078 0.000132 +946 1 0.000279 1560.000000 0.002017 0.000609 0.001647 +947 1 0.000263 1560.000000 -0.000590 -0.001603 0.008645 +948 1 0.000207 1560.000000 0.000343 -0.000072 0.000163 +949 1 0.000279 1560.000000 -0.003243 -0.000975 0.004238 +950 1 0.000268 1560.000000 -0.000275 -0.000912 0.001243 +951 1 0.000213 1560.000000 -0.000081 -0.000076 0.003453 +952 1 0.000197 1560.000000 0.000779 -0.000195 0.003700 +953 1 0.000222 1560.000000 0.002846 0.001423 0.001606 +954 1 0.000209 1560.000000 0.000361 0.000908 0.006601 +955 1 0.000238 1560.000000 -0.001037 -0.003615 0.009501 +956 1 0.000230 1560.000000 0.000066 0.002609 0.003702 +957 1 0.000271 1560.000000 -0.003452 -0.000708 0.004889 +958 1 0.000283 1560.000000 -0.001279 -0.000462 0.007513 +959 1 0.000221 1560.000000 -0.000081 0.000133 0.007316 +960 1 0.000267 1560.000000 -0.000802 0.003059 0.006708 +961 1 0.000197 1560.000000 -0.001635 -0.001334 0.007525 +962 1 0.000195 1560.000000 0.002657 0.000935 0.007894 +963 1 0.000224 1560.000000 -0.000934 -0.001683 0.002009 +964 1 0.000206 1560.000000 0.001203 -0.003137 0.004865 +965 1 0.000288 1560.000000 -0.000483 0.000711 0.009396 +966 1 0.000217 1560.000000 -0.001818 0.000156 0.000866 +967 1 0.000259 1560.000000 -0.002030 0.002364 0.008705 +968 1 0.000271 1560.000000 0.000768 0.002015 0.000432 +969 1 0.000235 1560.000000 0.000584 0.001037 0.007780 +970 1 0.000253 1560.000000 -0.001718 -0.001058 0.005915 +971 1 0.000193 1560.000000 -0.000396 0.002132 0.003778 +972 1 0.000273 1560.000000 0.000034 -0.001146 0.004560 +973 1 0.000209 1560.000000 0.003352 0.000094 0.003839 +974 1 0.000270 1560.000000 -0.000352 -0.002637 0.001125 +975 1 0.000200 1560.000000 -0.000186 -0.000517 0.004247 +976 1 0.000204 1560.000000 -0.000206 0.000817 0.003068 +977 1 0.000252 1560.000000 -0.001095 -0.001788 0.003754 +978 1 0.000267 1560.000000 0.003590 0.000419 0.007908 +979 1 0.000217 1560.000000 -0.000340 0.002399 0.001588 +980 1 0.000233 1560.000000 0.000192 0.000628 0.003353 +981 1 0.000236 1560.000000 -0.002637 -0.001475 0.004329 +982 1 0.000265 1560.000000 -0.000286 -0.003206 0.007662 +983 1 0.000205 1560.000000 0.001047 0.000052 0.006903 +984 1 0.000210 1560.000000 0.000462 0.000701 0.006027 +985 1 0.000202 1560.000000 0.002313 -0.001927 0.003654 +986 1 0.000201 1560.000000 -0.003216 -0.000856 0.007122 +987 1 0.000239 1560.000000 -0.002657 0.001316 0.004451 +988 1 0.000251 1560.000000 0.003211 -0.000413 0.003047 +989 1 0.000235 1560.000000 -0.001632 -0.001906 0.004734 +990 1 0.000221 1560.000000 -0.002529 0.000027 0.006478 +991 1 0.000249 1560.000000 -0.001311 -0.000704 0.009624 +992 1 0.000271 1560.000000 0.002007 0.000086 0.009625 +993 1 0.000209 1560.000000 -0.000263 -0.002496 0.008369 +994 1 0.000196 1560.000000 -0.001014 -0.003118 0.001692 +995 1 0.000212 1560.000000 0.000974 0.002437 0.007894 +996 1 0.000259 1560.000000 0.000962 0.000917 0.005275 +997 1 0.000240 1560.000000 0.002940 -0.000447 0.002052 +998 1 0.000231 1560.000000 0.001332 0.002667 0.006377 +999 1 0.000208 1560.000000 0.000815 -0.002135 0.003730 +1000 1 0.000279 1560.000000 0.000125 -0.003837 0.004754 +1001 1 0.000235 1560.000000 -0.000054 0.001877 0.002816 +1002 1 0.000260 1560.000000 0.000632 0.002912 0.008436 +1003 1 0.000205 1560.000000 0.001948 0.000792 0.008315 +1004 1 0.000241 1560.000000 0.002996 0.000132 0.008586 +1005 1 0.000201 1560.000000 -0.001375 0.000940 0.006571 +1006 1 0.000257 1560.000000 -0.001862 -0.001786 0.000717 +1007 1 0.000204 1560.000000 -0.000473 0.002976 0.005031 +1008 1 0.000200 1560.000000 0.000668 -0.002347 0.007467 +1009 1 0.000270 1560.000000 0.000025 -0.000138 0.002190 +1010 1 0.000242 1560.000000 0.001449 0.001381 0.007564 +1011 1 0.000220 1560.000000 0.002642 -0.002427 0.008731 +1012 1 0.000270 1560.000000 -0.001335 -0.003188 0.006551 +1013 1 0.000194 1560.000000 -0.001259 0.002050 0.004390 +1014 1 0.000241 1560.000000 0.001175 -0.003143 0.005573 +1015 1 0.000271 1560.000000 -0.001968 -0.001317 0.006883 +1016 1 0.000228 1560.000000 0.003037 -0.001822 0.001804 +1017 1 0.000260 1560.000000 0.002061 -0.002066 0.005962 +1018 1 0.000218 1560.000000 -0.001321 -0.001610 0.006989 +1019 1 0.000271 1560.000000 0.000988 -0.001353 0.007338 +1020 1 0.000280 1560.000000 -0.001776 0.001674 0.003622 +1021 1 0.000211 1560.000000 -0.000556 -0.002119 0.009391 +1022 1 0.000242 1560.000000 0.000532 -0.000417 0.008790 +1023 1 0.000225 1560.000000 -0.001612 0.001762 0.002614 +1024 1 0.000207 1560.000000 -0.002319 -0.000950 0.001276 +1025 1 0.000271 1560.000000 0.000928 0.000351 0.001389 +1026 1 0.000211 1560.000000 -0.000048 -0.000069 0.000943 +1027 1 0.000199 1560.000000 0.002651 0.001636 0.000388 +1028 1 0.000250 1560.000000 0.002522 -0.000199 0.002045 +1029 1 0.000240 1560.000000 0.002786 0.000985 0.001629 +1030 1 0.000215 1560.000000 -0.002198 0.001146 0.001608 +1031 1 0.000205 1560.000000 -0.002768 -0.001699 0.006737 +1032 1 0.000246 1560.000000 0.000977 0.000545 0.005444 +1033 1 0.000196 1560.000000 0.001383 0.000702 0.007716 +1034 1 0.000197 1560.000000 0.000103 0.000034 0.005982 +1035 1 0.000204 1560.000000 -0.000317 0.000636 0.007790 +1036 1 0.000278 1560.000000 -0.000158 -0.000075 0.006370 +1037 1 0.000258 1560.000000 0.002061 0.001116 0.003262 +1038 1 0.000195 1560.000000 0.000307 0.000981 0.002198 +1039 1 0.000226 1560.000000 0.000098 0.003324 0.005660 +1040 1 0.000237 1560.000000 0.000205 -0.001283 0.003707 +1041 1 0.000246 1560.000000 0.000637 -0.001492 0.001195 +1042 1 0.000219 1560.000000 0.000977 -0.001883 0.003267 +1043 1 0.000232 1560.000000 -0.001100 0.000105 0.005242 +1044 1 0.000214 1560.000000 -0.001013 0.001842 0.002554 +1045 1 0.000249 1560.000000 -0.001160 0.000632 0.004217 +1046 1 0.000221 1560.000000 0.001455 0.002252 0.004753 +1047 1 0.000245 1560.000000 -0.002042 -0.000664 0.009064 +1048 1 0.000229 1560.000000 0.000829 -0.000401 0.005327 +1049 1 0.000195 1560.000000 -0.000227 -0.000489 0.001145 +1050 1 0.000198 1560.000000 -0.002271 -0.002468 0.002553 +1051 1 0.000253 1560.000000 0.000152 0.000766 0.006559 +1052 1 0.000210 1560.000000 -0.000284 0.002971 0.009599 +1053 1 0.000248 1560.000000 -0.002391 -0.001429 0.009632 +1054 1 0.000279 1560.000000 -0.000798 -0.001282 0.007304 +1055 1 0.000222 1560.000000 -0.000999 0.000290 0.004405 +1056 1 0.000196 1560.000000 0.000309 -0.000324 0.001018 +1057 1 0.000196 1560.000000 -0.000666 -0.000090 0.007343 +1058 1 0.000214 1560.000000 0.000924 -0.002846 0.002102 +1059 1 0.000212 1560.000000 0.000157 0.000908 0.004710 +1060 1 0.000213 1560.000000 0.001365 -0.002862 0.003947 +1061 1 0.000200 1560.000000 0.003687 0.000119 0.003181 +1062 1 0.000266 1560.000000 0.000676 -0.000040 0.008590 +1063 1 0.000221 1560.000000 -0.000419 0.000132 0.005143 +1064 1 0.000194 1560.000000 -0.002081 0.001368 0.007971 +1065 1 0.000239 1560.000000 0.003150 0.001376 0.001944 +1066 1 0.000226 1560.000000 0.000983 -0.001601 0.006763 +1067 1 0.000279 1560.000000 0.002763 -0.001095 0.006728 +1068 1 0.000219 1560.000000 -0.001006 -0.001408 0.002421 +1069 1 0.000270 1560.000000 0.001128 -0.001999 0.008478 +1070 1 0.000217 1560.000000 0.000040 -0.002829 0.002018 +1071 1 0.000196 1560.000000 -0.001251 -0.000592 0.000105 +1072 1 0.000277 1560.000000 0.001478 0.002094 0.005985 +1073 1 0.000283 1560.000000 0.000614 0.003436 0.009260 +1074 1 0.000254 1560.000000 -0.001072 0.001037 0.001942 +1075 1 0.000250 1560.000000 0.000879 -0.001616 0.007398 +1076 1 0.000217 1560.000000 0.000158 0.002581 0.005669 +1077 1 0.000250 1560.000000 -0.000029 -0.002452 0.003151 +1078 1 0.000203 1560.000000 0.000320 -0.003418 0.007613 +1079 1 0.000254 1560.000000 -0.000338 -0.003042 0.008506 +1080 1 0.000207 1560.000000 0.001339 0.000401 0.001959 +1081 1 0.000239 1560.000000 -0.000338 0.001407 0.008585 +1082 1 0.000221 1560.000000 -0.001526 0.001043 0.002400 +1083 1 0.000201 1560.000000 -0.002505 0.000601 0.002631 +1084 1 0.000216 1560.000000 -0.000630 -0.000861 0.008582 +1085 1 0.000193 1560.000000 -0.000315 0.000885 0.009350 +1086 1 0.000200 1560.000000 0.000486 0.002339 0.001226 +1087 1 0.000231 1560.000000 -0.002423 0.000521 0.005087 +1088 1 0.000216 1560.000000 -0.001673 -0.001448 0.006731 +1089 1 0.000198 1560.000000 -0.000183 0.000138 0.004004 +1090 1 0.000286 1560.000000 -0.002418 0.000056 0.006787 +1091 1 0.000231 1560.000000 -0.002048 0.001403 0.001897 +1092 1 0.000207 1560.000000 -0.001305 -0.001647 0.005354 +1093 1 0.000192 1560.000000 0.000003 0.001434 0.009687 +1094 1 0.000230 1560.000000 0.000011 -0.000375 0.009216 +1095 1 0.000229 1560.000000 0.000265 0.001297 0.007118 +1096 1 0.000260 1560.000000 -0.002403 0.001231 0.002540 +1097 1 0.000219 1560.000000 -0.000316 0.002217 0.003281 +1098 1 0.000211 1560.000000 0.001667 -0.001173 0.002266 +1099 1 0.000261 1560.000000 -0.000044 0.000533 0.009289 +1100 1 0.000262 1560.000000 -0.000403 -0.002642 0.005072 +1101 1 0.000213 1560.000000 0.000088 0.000587 0.005838 +1102 1 0.000227 1560.000000 -0.000261 -0.000116 0.001021 +1103 1 0.000240 1560.000000 -0.001418 -0.002490 0.005861 +1104 1 0.000194 1560.000000 0.000479 0.000072 0.008691 +1105 1 0.000216 1560.000000 -0.001562 0.003247 0.004982 +1106 1 0.000267 1560.000000 0.000687 -0.001363 0.005082 +1107 1 0.000285 1560.000000 0.000514 0.000393 0.001984 +1108 1 0.000285 1560.000000 0.000440 -0.000772 0.009411 +1109 1 0.000261 1560.000000 0.000624 -0.000302 0.007146 +1110 1 0.000222 1560.000000 -0.001215 0.002844 0.001072 +1111 1 0.000224 1560.000000 0.000080 -0.001046 0.006915 +1112 1 0.000206 1560.000000 0.000344 0.001289 0.009083 +1113 1 0.000208 1560.000000 0.002033 0.002673 0.003005 +1114 1 0.000243 1560.000000 -0.001094 0.002567 0.002224 +1115 1 0.000260 1560.000000 0.000742 0.000088 0.006602 +1116 1 0.000195 1560.000000 0.000344 -0.000614 0.005416 +1117 1 0.000209 1560.000000 -0.000101 0.001264 0.008153 +1118 1 0.000219 1560.000000 0.000042 0.000188 0.000397 +1119 1 0.000218 1560.000000 -0.003067 -0.002165 0.008970 +1120 1 0.000275 1560.000000 -0.001973 0.001163 0.004777 +1121 1 0.000227 1560.000000 0.000425 0.001335 0.008208 +1122 1 0.000246 1560.000000 0.000531 0.000872 0.006176 +1123 1 0.000275 1560.000000 0.003157 0.000856 0.006371 +1124 1 0.000213 1560.000000 0.002569 -0.001016 0.007473 +1125 1 0.000213 1560.000000 0.000063 -0.002014 0.008591 +1126 1 0.000213 1560.000000 0.002743 0.000007 0.003796 +1127 1 0.000213 1560.000000 0.000715 0.002500 0.002908 +1128 1 0.000200 1560.000000 -0.000413 0.001207 0.005403 +1129 1 0.000270 1560.000000 -0.000391 0.000559 0.003420 +1130 1 0.000276 1560.000000 -0.000317 -0.000824 0.002375 +1131 1 0.000200 1560.000000 -0.002981 -0.002002 0.004061 +1132 1 0.000282 1560.000000 -0.003256 0.000630 0.000497 +1133 1 0.000223 1560.000000 -0.000082 -0.000470 0.005502 +1134 1 0.000263 1560.000000 0.003516 0.000550 0.002860 +1135 1 0.000232 1560.000000 0.001054 -0.000285 0.002585 +1136 1 0.000197 1560.000000 -0.000086 -0.001385 0.003856 +1137 1 0.000238 1560.000000 0.002496 0.000451 0.002246 +1138 1 0.000271 1560.000000 0.000291 -0.001439 0.000241 +1139 1 0.000238 1560.000000 -0.002131 -0.002741 0.001509 +1140 1 0.000204 1560.000000 0.000249 0.003040 0.004003 +1141 1 0.000212 1560.000000 -0.000043 0.000599 0.003896 +1142 1 0.000235 1560.000000 0.000137 -0.003455 0.003740 +1143 1 0.000233 1560.000000 0.002430 0.000204 0.006245 +1144 1 0.000199 1560.000000 -0.002834 0.000953 0.007925 +1145 1 0.000216 1560.000000 -0.002756 0.000701 0.002266 +1146 1 0.000203 1560.000000 0.002235 0.003102 0.003116 +1147 1 0.000249 1560.000000 0.001471 0.002766 0.000251 +1148 1 0.000222 1560.000000 0.001629 0.001973 0.004640 +1149 1 0.000256 1560.000000 -0.000648 0.002142 0.004055 +1150 1 0.000207 1560.000000 0.000094 0.002988 0.002316 +1151 1 0.000209 1560.000000 0.000894 -0.000634 0.009275 +1152 1 0.000223 1560.000000 -0.000318 -0.002002 0.006009 +1153 1 0.000279 1560.000000 0.002114 -0.000746 0.008621 +1154 1 0.000254 1560.000000 0.000180 -0.000273 0.009417 +1155 1 0.000221 1560.000000 -0.000006 -0.001894 0.002570 +1156 1 0.000275 1560.000000 0.000130 0.001705 0.008923 +1157 1 0.000236 1560.000000 -0.000261 -0.001499 0.003116 +1158 1 0.000278 1560.000000 -0.000128 0.000520 0.002541 +1159 1 0.000230 1560.000000 -0.001160 0.000104 0.009007 +1160 1 0.000204 1560.000000 -0.002040 -0.000037 0.001474 +1161 1 0.000197 1560.000000 0.000640 -0.000272 0.000525 +1162 1 0.000238 1560.000000 0.000390 0.002909 0.002974 +1163 1 0.000208 1560.000000 -0.001803 -0.001255 0.000389 +1164 1 0.000274 1560.000000 0.001346 0.000325 0.006660 +1165 1 0.000205 1560.000000 -0.001282 -0.003265 0.004066 +1166 1 0.000208 1560.000000 0.001107 -0.001134 0.008599 +1167 1 0.000200 1560.000000 -0.000371 -0.002582 0.002413 +1168 1 0.000197 1560.000000 -0.001229 -0.000550 0.001078 +1169 1 0.000206 1560.000000 -0.001426 -0.000035 0.003518 +1170 1 0.000203 1560.000000 0.002171 -0.000663 0.007912 +1171 1 0.000263 1560.000000 0.003201 0.000459 0.001055 +1172 1 0.000237 1560.000000 -0.001660 -0.001119 0.001130 +1173 1 0.000253 1560.000000 -0.000877 0.000935 0.000187 +1174 1 0.000222 1560.000000 0.001794 0.000713 0.007781 +1175 1 0.000255 1560.000000 -0.000177 0.002820 0.002062 +1176 1 0.000217 1560.000000 -0.000194 0.000672 0.005782 +1177 1 0.000208 1560.000000 -0.000235 -0.000141 0.000794 +1178 1 0.000193 1560.000000 -0.002663 -0.000924 0.007467 +1179 1 0.000261 1560.000000 0.001920 0.000260 0.004277 +1180 1 0.000284 1560.000000 0.003651 0.001221 0.003396 +1181 1 0.000265 1560.000000 0.001600 -0.002052 0.004654 +1182 1 0.000229 1560.000000 -0.000408 -0.000881 0.007678 +1183 1 0.000287 1560.000000 -0.001437 -0.000433 0.009566 +1184 1 0.000212 1560.000000 0.000874 -0.000102 0.005119 +1185 1 0.000203 1560.000000 0.001701 -0.001272 0.000792 +1186 1 0.000195 1560.000000 0.000006 -0.000105 0.001625 +1187 1 0.000216 1560.000000 -0.000052 0.000285 0.003438 +1188 1 0.000264 1560.000000 0.003077 -0.000586 0.004812 +1189 1 0.000238 1560.000000 0.000874 0.002429 0.001343 +1190 1 0.000199 1560.000000 -0.000437 -0.000955 0.006609 +1191 1 0.000199 1560.000000 -0.000405 -0.001749 0.001549 +1192 1 0.000270 1560.000000 -0.002218 0.000483 0.009470 +1193 1 0.000240 1560.000000 -0.002985 0.000311 0.007864 +1194 1 0.000197 1560.000000 -0.000534 -0.000259 0.003945 +1195 1 0.000239 1560.000000 -0.000173 0.001291 0.005402 +1196 1 0.000223 1560.000000 0.001602 -0.001213 0.004469 +1197 1 0.000210 1560.000000 0.002364 -0.002025 0.003136 +1198 1 0.000231 1560.000000 -0.001573 0.002150 0.000677 +1199 1 0.000249 1560.000000 -0.001526 0.000620 0.001616 +1200 1 0.000243 1560.000000 0.000925 0.001087 0.001492 +1201 1 0.000194 1560.000000 0.002900 0.001446 0.006904 +1202 1 0.000237 1560.000000 0.001143 0.001397 0.000437 +1203 1 0.000250 1560.000000 0.001981 -0.000901 0.005704 +1204 1 0.000197 1560.000000 0.000553 -0.001556 0.002478 +1205 1 0.000197 1560.000000 0.000709 0.001467 0.000903 +1206 1 0.000242 1560.000000 0.001309 -0.000539 0.003969 +1207 1 0.000200 1560.000000 -0.000001 -0.000569 0.001625 +1208 1 0.000235 1560.000000 -0.000130 0.002011 0.003985 +1209 1 0.000212 1560.000000 0.000209 0.000105 0.005013 +1210 1 0.000201 1560.000000 0.000879 -0.001308 0.006370 +1211 1 0.000237 1560.000000 -0.000548 -0.000288 0.006569 +1212 1 0.000205 1560.000000 -0.000000 -0.000504 0.009011 +1213 1 0.000229 1560.000000 0.000429 0.000417 0.006990 +1214 1 0.000261 1560.000000 0.001336 0.000230 0.003849 +1215 1 0.000260 1560.000000 -0.002965 -0.001411 0.002721 +1216 1 0.000246 1560.000000 -0.000243 -0.001042 0.000824 +1217 1 0.000223 1560.000000 -0.000331 -0.001378 0.008981 +1218 1 0.000287 1560.000000 0.002866 0.001233 0.007768 +1219 1 0.000264 1560.000000 0.001362 0.000984 0.002709 +1220 1 0.000206 1560.000000 0.001431 0.001696 0.006915 +1221 1 0.000268 1560.000000 0.003496 -0.000231 0.006119 +1222 1 0.000263 1560.000000 -0.002253 0.002847 0.000747 +1223 1 0.000236 1560.000000 -0.001511 0.002611 0.000194 +1224 1 0.000200 1560.000000 -0.003330 0.000928 0.002241 +1225 1 0.000214 1560.000000 -0.000014 0.002168 0.003818 +1226 1 0.000273 1560.000000 -0.001559 -0.000881 0.007982 +1227 1 0.000205 1560.000000 -0.000305 -0.001743 0.004048 +1228 1 0.000273 1560.000000 0.000987 -0.000079 0.007314 +1229 1 0.000206 1560.000000 0.000316 0.000285 0.008592 +1230 1 0.000217 1560.000000 -0.000053 -0.000189 0.007993 +1231 1 0.000257 1560.000000 -0.000857 0.003066 0.002249 +1232 1 0.000200 1560.000000 -0.002571 0.001058 0.004784 +1233 1 0.000276 1560.000000 -0.000285 0.000330 0.000340 +1234 1 0.000269 1560.000000 0.002213 -0.000288 0.006527 +1235 1 0.000245 1560.000000 -0.001832 0.000997 0.005012 +1236 1 0.000240 1560.000000 0.000660 0.002615 0.004223 +1237 1 0.000240 1560.000000 -0.000037 0.001047 0.007270 +1238 1 0.000199 1560.000000 -0.003158 0.000394 0.002809 +1239 1 0.000264 1560.000000 -0.000430 -0.000253 0.001584 +1240 1 0.000203 1560.000000 0.000755 -0.000601 0.003305 +1241 1 0.000248 1560.000000 -0.001953 -0.002696 0.003999 +1242 1 0.000283 1560.000000 -0.003182 -0.001090 0.001202 +1243 1 0.000242 1560.000000 0.001317 0.001165 0.007893 +1244 1 0.000240 1560.000000 -0.000625 -0.000058 0.008416 +1245 1 0.000209 1560.000000 -0.000613 0.003678 0.007179 +1246 1 0.000281 1560.000000 -0.000337 -0.000153 0.002088 +1247 1 0.000221 1560.000000 -0.001510 -0.000259 0.002849 +1248 1 0.000210 1560.000000 0.001052 0.000918 0.006160 +1249 1 0.000271 1560.000000 -0.002591 0.000008 0.009017 +1250 1 0.000213 1560.000000 -0.000056 -0.000528 0.002654 +1251 1 0.000249 1560.000000 -0.000564 0.000694 0.003201 +1252 1 0.000202 1560.000000 -0.002437 0.000474 0.008383 +1253 1 0.000288 1560.000000 0.001484 -0.002622 0.004974 +1254 1 0.000234 1560.000000 -0.001199 -0.000229 0.009120 +1255 1 0.000235 1560.000000 0.002714 -0.001389 0.001830 +1256 1 0.000213 1560.000000 -0.001265 0.002999 0.006027 +1257 1 0.000276 1560.000000 -0.003059 0.002091 0.002524 +1258 1 0.000284 1560.000000 0.003083 0.001312 0.001024 +1259 1 0.000220 1560.000000 0.003435 -0.000849 0.008997 +1260 1 0.000199 1560.000000 -0.000708 -0.000023 0.004330 +1261 1 0.000230 1560.000000 -0.003084 -0.002017 0.009588 +1262 1 0.000197 1560.000000 0.000722 -0.001694 0.005289 +1263 1 0.000243 1560.000000 0.001389 0.003569 0.007576 +1264 1 0.000254 1560.000000 0.000125 -0.000720 0.002075 +1265 1 0.000216 1560.000000 -0.000268 -0.000245 0.006688 +1266 1 0.000263 1560.000000 0.000968 -0.003726 0.008763 +1267 1 0.000194 1560.000000 -0.001232 0.000966 0.007503 +1268 1 0.000264 1560.000000 0.003269 -0.001197 0.001022 +1269 1 0.000192 1560.000000 0.001619 -0.000949 0.004580 +1270 1 0.000227 1560.000000 0.002079 -0.002174 0.000357 +1271 1 0.000252 1560.000000 0.002023 -0.000461 0.008969 +1272 1 0.000223 1560.000000 -0.002565 -0.000776 0.008917 +1273 1 0.000199 1560.000000 0.000404 -0.000180 0.005662 +1274 1 0.000217 1560.000000 -0.001623 0.000536 0.003490 +1275 1 0.000206 1560.000000 0.000159 -0.002764 0.003474 +1276 1 0.000235 1560.000000 0.002629 0.000298 0.001594 +1277 1 0.000208 1560.000000 0.000658 0.000232 0.003897 +1278 1 0.000259 1560.000000 0.000848 -0.000037 0.005972 +1279 1 0.000233 1560.000000 -0.000769 0.001688 0.002862 +1280 1 0.000287 1560.000000 0.000796 -0.000055 0.002933 +1281 1 0.000251 1560.000000 0.000281 0.001343 0.001584 +1282 1 0.000193 1560.000000 -0.000208 0.001061 0.003226 +1283 1 0.000282 1560.000000 0.001334 -0.002047 0.007121 +1284 1 0.000235 1560.000000 0.000359 -0.000215 0.002572 +1285 1 0.000230 1560.000000 0.000377 -0.001215 0.008866 +1286 1 0.000259 1560.000000 -0.003236 0.001890 0.005366 +1287 1 0.000256 1560.000000 -0.000203 0.000618 0.001258 +1288 1 0.000225 1560.000000 -0.002610 0.002559 0.002466 +1289 1 0.000279 1560.000000 0.001917 0.001983 0.005636 +1290 1 0.000205 1560.000000 0.001684 0.001879 0.005101 +1291 1 0.000199 1560.000000 -0.000042 -0.001195 0.004012 +1292 1 0.000252 1560.000000 -0.003696 -0.000908 0.002140 +1293 1 0.000255 1560.000000 0.001763 0.000762 0.001711 +1294 1 0.000244 1560.000000 0.003214 0.000057 0.007846 +1295 1 0.000226 1560.000000 0.000019 -0.003508 0.001852 +1296 1 0.000208 1560.000000 -0.002233 0.001632 0.003017 +1297 1 0.000199 1560.000000 0.000124 -0.000771 0.006283 +1298 1 0.000239 1560.000000 -0.003108 -0.002090 0.006347 +1299 1 0.000260 1560.000000 -0.003324 -0.000320 0.001801 +1300 1 0.000229 1560.000000 -0.001072 0.000104 0.003013 +1301 1 0.000199 1560.000000 -0.000855 0.001564 0.000159 +1302 1 0.000231 1560.000000 -0.001629 -0.003193 0.001992 +1303 1 0.000215 1560.000000 -0.000144 0.000382 0.000657 +1304 1 0.000207 1560.000000 0.000451 -0.000957 0.002985 +1305 1 0.000270 1560.000000 0.002581 -0.002439 0.001489 +1306 1 0.000209 1560.000000 0.000284 0.000594 0.004733 +1307 1 0.000198 1560.000000 0.002631 -0.002182 0.009056 +1308 1 0.000280 1560.000000 0.000089 0.002567 0.001875 +1309 1 0.000263 1560.000000 -0.002187 0.002474 0.002455 +1310 1 0.000230 1560.000000 0.000376 0.003308 0.001745 +1311 1 0.000252 1560.000000 -0.002564 -0.000508 0.004820 +1312 1 0.000252 1560.000000 0.000105 -0.001687 0.004917 +1313 1 0.000251 1560.000000 0.000375 0.003095 0.004576 +1314 1 0.000274 1560.000000 0.001273 0.002283 0.008502 +1315 1 0.000240 1560.000000 -0.000543 0.000236 0.002060 +1316 1 0.000205 1560.000000 -0.002664 0.002582 0.008402 +1317 1 0.000254 1560.000000 0.001774 0.000548 0.004938 +1318 1 0.000252 1560.000000 -0.001390 -0.003173 0.008149 +1319 1 0.000212 1560.000000 -0.002782 0.002250 0.006782 +1320 1 0.000194 1560.000000 -0.000332 -0.001363 0.001291 +1321 1 0.000211 1560.000000 -0.002976 -0.000645 0.004136 +1322 1 0.000195 1560.000000 0.001332 -0.002176 0.009535 +1323 1 0.000237 1560.000000 -0.000826 0.001090 0.007445 +1324 1 0.000192 1560.000000 0.001828 -0.000202 0.003016 +1325 1 0.000207 1560.000000 -0.000777 -0.000576 0.000789 +1326 1 0.000253 1560.000000 -0.001702 0.003116 0.005967 +1327 1 0.000219 1560.000000 -0.001608 0.001555 0.008806 +1328 1 0.000198 1560.000000 -0.002329 -0.002594 0.005781 +1329 1 0.000241 1560.000000 -0.003057 -0.000558 0.008419 +1330 1 0.000240 1560.000000 0.000842 0.001870 0.005344 +1331 1 0.000213 1560.000000 0.000708 -0.002135 0.005932 +1332 1 0.000217 1560.000000 -0.001583 -0.000676 0.002040 +1333 1 0.000281 1560.000000 -0.001414 -0.002229 0.007179 +1334 1 0.000233 1560.000000 -0.002860 0.000562 0.001353 +1335 1 0.000260 1560.000000 0.003323 0.000310 0.000260 +1336 1 0.000286 1560.000000 0.000733 0.000078 0.008061 +1337 1 0.000282 1560.000000 -0.001879 0.003335 0.004626 +1338 1 0.000211 1560.000000 0.000546 -0.001521 0.004710 +1339 1 0.000201 1560.000000 -0.003154 -0.000699 0.009631 +1340 1 0.000253 1560.000000 -0.000121 -0.000077 0.004341 +1341 1 0.000248 1560.000000 0.000862 -0.000850 0.005577 +1342 1 0.000265 1560.000000 0.000904 0.000315 0.009124 +1343 1 0.000206 1560.000000 -0.002755 -0.002228 0.009004 +1344 1 0.000217 1560.000000 0.000679 0.001523 0.002468 +1345 1 0.000214 1560.000000 -0.003242 -0.001282 0.000797 +1346 1 0.000259 1560.000000 -0.003653 -0.000897 0.004188 +1347 1 0.000197 1560.000000 -0.002044 -0.002591 0.007807 +1348 1 0.000230 1560.000000 0.000910 0.000170 0.001835 +1349 1 0.000207 1560.000000 -0.000593 -0.000682 0.005767 +1350 1 0.000199 1560.000000 -0.001855 -0.001593 0.006704 +1351 1 0.000211 1560.000000 0.001309 -0.002968 0.003352 +1352 1 0.000221 1560.000000 0.001004 0.002415 0.000285 +1353 1 0.000208 1560.000000 0.001771 0.001498 0.006196 +1354 1 0.000205 1560.000000 0.001389 0.003298 0.004191 +1355 1 0.000194 1560.000000 0.000787 -0.001015 0.003701 +1356 1 0.000224 1560.000000 0.003009 -0.000091 0.001594 +1357 1 0.000209 1560.000000 -0.000501 -0.000311 0.005494 +1358 1 0.000243 1560.000000 -0.002237 -0.003121 0.000731 +1359 1 0.000270 1560.000000 -0.002946 0.002408 0.003881 +1360 1 0.000194 1560.000000 -0.000466 0.000755 0.006532 +1361 1 0.000252 1560.000000 -0.000431 0.002137 0.003488 +1362 1 0.000285 1560.000000 0.002461 -0.000643 0.003216 +1363 1 0.000260 1560.000000 0.001250 -0.000093 0.009234 +1364 1 0.000200 1560.000000 0.001341 0.001360 0.006053 +1365 1 0.000204 1560.000000 -0.001295 0.003415 0.006163 +1366 1 0.000246 1560.000000 -0.000675 -0.000946 0.003123 +1367 1 0.000214 1560.000000 -0.000340 0.001731 0.003697 +1368 1 0.000207 1560.000000 -0.001955 -0.003116 0.002990 +1369 1 0.000260 1560.000000 0.000385 -0.000129 0.009112 +1370 1 0.000211 1560.000000 0.001828 -0.001955 0.001685 +1371 1 0.000205 1560.000000 -0.000625 0.000737 0.002265 +1372 1 0.000255 1560.000000 -0.002983 0.000710 0.008326 +1373 1 0.000233 1560.000000 -0.000357 -0.001433 0.002751 +1374 1 0.000214 1560.000000 -0.001322 0.000376 0.001432 +1375 1 0.000213 1560.000000 0.000850 -0.001498 0.002146 +1376 1 0.000285 1560.000000 -0.000989 0.002357 0.009558 +1377 1 0.000279 1560.000000 -0.001135 -0.001331 0.006883 +1378 1 0.000209 1560.000000 -0.003032 -0.001597 0.000617 +1379 1 0.000207 1560.000000 0.000571 0.001909 0.000692 +1380 1 0.000207 1560.000000 -0.000710 0.000864 0.008595 +1381 1 0.000212 1560.000000 0.001987 -0.003013 0.005407 +1382 1 0.000209 1560.000000 0.002208 0.000240 0.004504 +1383 1 0.000227 1560.000000 -0.002759 0.000128 0.003122 +1384 1 0.000200 1560.000000 0.000405 0.000882 0.001834 +1385 1 0.000242 1560.000000 0.000350 0.002280 0.003152 +1386 1 0.000254 1560.000000 0.000253 -0.000483 0.007872 +1387 1 0.000268 1560.000000 0.000908 0.002159 0.004060 +1388 1 0.000220 1560.000000 0.001092 -0.000385 0.009705 +1389 1 0.000196 1560.000000 0.000847 0.001203 0.003539 +1390 1 0.000193 1560.000000 0.001363 -0.000861 0.006120 +1391 1 0.000233 1560.000000 0.001475 -0.000742 0.006726 +1392 1 0.000204 1560.000000 -0.002131 -0.002052 0.001481 +1393 1 0.000229 1560.000000 -0.002540 0.001255 0.005103 +1394 1 0.000270 1560.000000 0.000518 0.002432 0.009710 +1395 1 0.000266 1560.000000 -0.002590 0.002167 0.004930 +1396 1 0.000268 1560.000000 0.002224 -0.001163 0.003292 +1397 1 0.000201 1560.000000 -0.000342 0.003783 0.001075 +1398 1 0.000212 1560.000000 -0.000860 0.001038 0.004262 +1399 1 0.000252 1560.000000 0.000704 -0.002318 0.001856 +1400 1 0.000264 1560.000000 -0.001132 -0.002467 0.003629 +1401 1 0.000197 1560.000000 -0.000613 -0.000139 0.002335 +1402 1 0.000285 1560.000000 -0.000077 -0.000979 0.007239 +1403 1 0.000226 1560.000000 -0.000177 -0.001659 0.002367 +1404 1 0.000248 1560.000000 -0.000265 0.002508 0.004064 +1405 1 0.000279 1560.000000 0.000694 0.002971 0.009185 +1406 1 0.000238 1560.000000 -0.001207 0.000559 0.007079 +1407 1 0.000239 1560.000000 0.001206 0.000918 0.007612 +1408 1 0.000235 1560.000000 0.003461 0.001691 0.002054 +1409 1 0.000198 1560.000000 0.002761 -0.000382 0.000396 +1410 1 0.000255 1560.000000 0.002152 -0.002437 0.009154 +1411 1 0.000201 1560.000000 0.001519 -0.002945 0.005873 +1412 1 0.000255 1560.000000 0.001254 0.000869 0.001976 +1413 1 0.000248 1560.000000 -0.000257 0.000028 0.009482 +1414 1 0.000215 1560.000000 0.000594 0.000550 0.001797 +1415 1 0.000199 1560.000000 0.002196 -0.001210 0.001837 +1416 1 0.000209 1560.000000 -0.000930 0.001930 0.009136 +1417 1 0.000222 1560.000000 0.000926 -0.001845 0.008478 +1418 1 0.000217 1560.000000 -0.001221 -0.001429 0.001162 +1419 1 0.000211 1560.000000 0.002431 -0.000145 0.008739 +1420 1 0.000209 1560.000000 0.002004 -0.002427 0.001319 +1421 1 0.000266 1560.000000 -0.000450 -0.003189 0.003661 +1422 1 0.000204 1560.000000 0.001306 0.000401 0.005467 +1423 1 0.000213 1560.000000 -0.001821 -0.000910 0.003974 +1424 1 0.000274 1560.000000 0.001862 -0.002382 0.001672 +1425 1 0.000222 1560.000000 -0.002429 0.000960 0.001002 +1426 1 0.000203 1560.000000 0.000479 -0.000037 0.004388 +1427 1 0.000282 1560.000000 0.000427 -0.000018 0.009568 +1428 1 0.000221 1560.000000 -0.000605 0.000382 0.003217 +1429 1 0.000227 1560.000000 -0.000098 -0.000101 0.003913 +1430 1 0.000243 1560.000000 0.002699 0.000053 0.002682 +1431 1 0.000197 1560.000000 -0.000159 -0.001162 0.008567 +1432 1 0.000203 1560.000000 0.000004 -0.000324 0.008226 +1433 1 0.000201 1560.000000 0.001088 -0.001406 0.002745 +1434 1 0.000222 1560.000000 -0.001226 0.001628 0.006716 +1435 1 0.000213 1560.000000 0.002087 0.002572 0.008045 +1436 1 0.000279 1560.000000 -0.001217 0.000381 0.007919 +1437 1 0.000263 1560.000000 -0.001028 0.002239 0.005830 +1438 1 0.000224 1560.000000 -0.002022 -0.001206 0.009564 +1439 1 0.000211 1560.000000 -0.002935 0.001217 0.002865 +1440 1 0.000219 1560.000000 0.001936 -0.000989 0.008291 +1441 1 0.000279 1560.000000 -0.000058 0.001863 0.004648 +1442 1 0.000204 1560.000000 0.001925 -0.002871 0.003598 +1443 1 0.000193 1560.000000 -0.000448 0.001332 0.005010 +1444 1 0.000214 1560.000000 0.000131 0.000169 0.003806 +1445 1 0.000243 1560.000000 -0.000326 -0.000598 0.008681 +1446 1 0.000216 1560.000000 0.001531 -0.002179 0.002102 +1447 1 0.000197 1560.000000 0.000046 0.000537 0.007631 +1448 1 0.000269 1560.000000 -0.000208 -0.001447 0.001799 +1449 1 0.000260 1560.000000 0.002116 0.000119 0.007139 +1450 1 0.000223 1560.000000 -0.003164 0.002129 0.008966 +1451 1 0.000200 1560.000000 -0.001386 0.001769 0.002095 +1452 1 0.000249 1560.000000 -0.000648 -0.000179 0.003180 +1453 1 0.000263 1560.000000 0.003684 -0.000705 0.007802 +1454 1 0.000228 1560.000000 0.002810 -0.001752 0.004001 +1455 1 0.000225 1560.000000 0.001171 0.000585 0.008623 +1456 1 0.000199 1560.000000 -0.003175 0.001369 0.005843 +1457 1 0.000261 1560.000000 0.001347 -0.000177 0.002471 +1458 1 0.000224 1560.000000 0.000987 0.000812 0.005546 +1459 1 0.000251 1560.000000 0.002988 -0.000398 0.009301 +1460 1 0.000213 1560.000000 0.000695 0.000848 0.005597 +1461 1 0.000212 1560.000000 -0.001416 -0.003538 0.001241 +1462 1 0.000210 1560.000000 0.000383 0.001667 0.000542 +1463 1 0.000202 1560.000000 0.000591 0.000423 0.005861 +1464 1 0.000198 1560.000000 0.000351 0.001513 0.004460 +1465 1 0.000251 1560.000000 -0.002140 -0.002460 0.003713 +1466 1 0.000235 1560.000000 -0.001407 0.000675 0.000228 +1467 1 0.000216 1560.000000 0.002255 -0.000121 0.001477 +1468 1 0.000229 1560.000000 0.000551 0.001300 0.001996 +1469 1 0.000205 1560.000000 0.002526 -0.001238 0.008458 +1470 1 0.000252 1560.000000 -0.001158 0.002075 0.000653 +1471 1 0.000242 1560.000000 0.001129 0.003128 0.003283 +1472 1 0.000263 1560.000000 -0.000088 -0.000345 0.006207 +1473 1 0.000198 1560.000000 -0.000411 0.000864 0.001032 +1474 1 0.000222 1560.000000 0.001516 0.002324 0.005835 +1475 1 0.000260 1560.000000 0.000391 -0.000461 0.003399 +1476 1 0.000284 1560.000000 0.001627 0.000733 0.002356 +1477 1 0.000215 1560.000000 0.000343 -0.002229 0.008112 +1478 1 0.000247 1560.000000 -0.000732 -0.001847 0.002885 +1479 1 0.000245 1560.000000 -0.003382 0.000494 0.005713 +1480 1 0.000230 1560.000000 -0.001562 -0.001180 0.007208 +1481 1 0.000225 1560.000000 -0.000156 0.000161 0.004224 +1482 1 0.000236 1560.000000 -0.002835 -0.001808 0.004705 +1483 1 0.000193 1560.000000 -0.002310 -0.001196 0.007541 +1484 1 0.000218 1560.000000 -0.002307 0.002218 0.004429 +1485 1 0.000207 1560.000000 -0.002465 -0.002143 0.001108 +1486 1 0.000226 1560.000000 0.000868 0.000341 0.002552 +1487 1 0.000274 1560.000000 -0.002896 -0.001367 0.004993 +1488 1 0.000215 1560.000000 -0.002065 0.001614 0.001328 +1489 1 0.000250 1560.000000 -0.000275 -0.000604 0.001340 +1490 1 0.000226 1560.000000 0.003350 -0.000367 0.002459 +1491 1 0.000257 1560.000000 0.003503 0.000372 0.005908 +1492 1 0.000198 1560.000000 -0.002106 -0.002911 0.002122 +1493 1 0.000240 1560.000000 -0.001225 -0.000316 0.001389 +1494 1 0.000242 1560.000000 -0.000254 0.000139 0.001059 +1495 1 0.000197 1560.000000 0.002072 -0.002128 0.001332 +1496 1 0.000270 1560.000000 0.000740 -0.002112 0.005042 +1497 1 0.000258 1560.000000 -0.002297 0.001246 0.009678 +1498 1 0.000260 1560.000000 -0.001639 -0.002723 0.006469 +1499 1 0.000243 1560.000000 -0.003614 -0.000261 0.004967 +1500 1 0.000219 1560.000000 0.000862 0.001398 0.002457 +1501 1 0.000200 1560.000000 0.002763 -0.002159 0.004925 +1502 1 0.000220 1560.000000 0.000759 -0.000884 0.002818 +1503 1 0.000287 1560.000000 -0.000961 -0.002955 0.008697 +1504 1 0.000273 1560.000000 -0.003370 0.001287 0.008879 +1505 1 0.000278 1560.000000 0.001136 0.000620 0.004934 +1506 1 0.000206 1560.000000 -0.001248 0.000534 0.000106 +1507 1 0.000197 1560.000000 0.001326 -0.000166 0.000945 +1508 1 0.000266 1560.000000 -0.000087 -0.000311 0.007197 +1509 1 0.000233 1560.000000 0.001134 0.000289 0.008709 +1510 1 0.000221 1560.000000 -0.000241 0.000188 0.008731 +1511 1 0.000199 1560.000000 -0.000535 -0.002030 0.001583 +1512 1 0.000210 1560.000000 0.000557 -0.003454 0.004270 +1513 1 0.000251 1560.000000 -0.001691 0.000028 0.005379 +1514 1 0.000284 1560.000000 0.003095 -0.002076 0.006493 +1515 1 0.000231 1560.000000 -0.001994 0.002288 0.007173 +1516 1 0.000243 1560.000000 -0.003295 0.001484 0.002017 +1517 1 0.000245 1560.000000 0.002134 0.001125 0.009388 +1518 1 0.000270 1560.000000 -0.003495 -0.000155 0.000545 +1519 1 0.000281 1560.000000 -0.003554 0.000907 0.006012 +1520 1 0.000205 1560.000000 0.002417 0.001952 0.002729 +1521 1 0.000218 1560.000000 -0.002582 0.002287 0.006273 +1522 1 0.000286 1560.000000 0.001757 -0.002816 0.001206 +1523 1 0.000195 1560.000000 0.000002 -0.002380 0.008131 +1524 1 0.000204 1560.000000 0.002213 0.003049 0.003802 +1525 1 0.000210 1560.000000 0.001685 0.002669 0.007614 +1526 1 0.000250 1560.000000 -0.002950 0.001653 0.006761 +1527 1 0.000201 1560.000000 -0.001289 0.001602 0.000919 +1528 1 0.000270 1560.000000 -0.000249 -0.002539 0.004480 +1529 1 0.000251 1560.000000 0.002074 -0.001007 0.004210 +1530 1 0.000236 1560.000000 -0.002691 -0.001240 0.004400 +1531 1 0.000195 1560.000000 -0.002328 -0.000064 0.007766 +1532 1 0.000196 1560.000000 -0.000950 0.001698 0.000795 +1533 1 0.000223 1560.000000 -0.000687 -0.000648 0.005453 +1534 1 0.000276 1560.000000 -0.001410 0.001923 0.006567 +1535 1 0.000275 1560.000000 -0.000627 0.003665 0.001567 +1536 1 0.000199 1560.000000 0.002681 -0.000484 0.006420 +1537 1 0.000205 1560.000000 0.002226 0.000075 0.003067 +1538 1 0.000209 1560.000000 -0.001634 -0.000256 0.002183 +1539 1 0.000203 1560.000000 -0.001592 0.002119 0.001551 +1540 1 0.000254 1560.000000 0.002055 0.001437 0.003024 +1541 1 0.000205 1560.000000 0.000415 0.002629 0.008189 +1542 1 0.000224 1560.000000 0.001374 0.001061 0.001777 +1543 1 0.000213 1560.000000 -0.002082 0.002099 0.003062 +1544 1 0.000253 1560.000000 -0.001850 0.001474 0.002862 +1545 1 0.000285 1560.000000 0.001211 0.002093 0.007194 +1546 1 0.000200 1560.000000 0.000197 -0.002208 0.005273 +1547 1 0.000194 1560.000000 -0.000885 0.001167 0.005460 +1548 1 0.000219 1560.000000 -0.001289 0.002439 0.004679 +1549 1 0.000273 1560.000000 0.002578 0.001040 0.006239 +1550 1 0.000204 1560.000000 -0.000232 0.001761 0.009102 +1551 1 0.000245 1560.000000 -0.001998 0.003113 0.006112 +1552 1 0.000200 1560.000000 -0.000247 -0.000801 0.008314 +1553 1 0.000210 1560.000000 0.001242 -0.003079 0.007130 +1554 1 0.000216 1560.000000 -0.001608 0.001533 0.002719 +1555 1 0.000208 1560.000000 -0.003274 0.001702 0.002200 +1556 1 0.000287 1560.000000 0.000492 0.001051 0.005284 +1557 1 0.000267 1560.000000 -0.001291 -0.002533 0.005584 +1558 1 0.000226 1560.000000 -0.001193 0.000604 0.009800 +1559 1 0.000213 1560.000000 -0.001429 -0.000230 0.008909 +1560 1 0.000232 1560.000000 0.002755 0.001858 0.003298 +1561 1 0.000247 1560.000000 0.000057 0.001439 0.008557 +1562 1 0.000288 1560.000000 0.002568 0.001480 0.001583 +1563 1 0.000242 1560.000000 0.001075 0.002053 0.005827 +1564 1 0.000198 1560.000000 0.000664 0.000515 0.009188 +1565 1 0.000194 1560.000000 -0.000678 0.002331 0.001885 +1566 1 0.000226 1560.000000 0.001490 -0.002033 0.006543 +1567 1 0.000278 1560.000000 0.000151 0.002983 0.001104 +1568 1 0.000228 1560.000000 -0.001414 0.001652 0.002645 +1569 1 0.000267 1560.000000 0.002031 -0.000019 0.002401 +1570 1 0.000202 1560.000000 0.002630 -0.002676 0.003827 +1571 1 0.000262 1560.000000 -0.001642 -0.001002 0.006401 +1572 1 0.000274 1560.000000 0.002227 0.002149 0.006505 +1573 1 0.000214 1560.000000 0.002404 0.000432 0.000845 +1574 1 0.000247 1560.000000 0.000116 -0.000398 0.003503 +1575 1 0.000280 1560.000000 -0.000344 -0.001208 0.004360 +1576 1 0.000207 1560.000000 -0.001901 0.001249 0.009579 +1577 1 0.000262 1560.000000 0.001352 -0.002241 0.004597 +1578 1 0.000222 1560.000000 -0.003232 0.001756 0.007919 +1579 1 0.000280 1560.000000 0.000172 -0.001421 0.007014 +1580 1 0.000232 1560.000000 -0.003610 -0.000412 0.002070 +1581 1 0.000215 1560.000000 -0.000003 -0.001362 0.002571 +1582 1 0.000219 1560.000000 -0.000306 -0.000052 0.000263 +1583 1 0.000211 1560.000000 0.003042 -0.001449 0.006800 +1584 1 0.000224 1560.000000 -0.003412 -0.000574 0.008902 +1585 1 0.000202 1560.000000 -0.000907 -0.001551 0.006720 +1586 1 0.000226 1560.000000 0.001573 0.000547 0.006799 +1587 1 0.000215 1560.000000 0.003679 -0.000398 0.004898 +1588 1 0.000197 1560.000000 -0.001643 0.001102 0.005936 +1589 1 0.000209 1560.000000 -0.000916 -0.003139 0.007023 +1590 1 0.000199 1560.000000 0.000142 -0.000514 0.007322 +1591 1 0.000218 1560.000000 0.001242 0.000814 0.002417 +1592 1 0.000235 1560.000000 -0.001841 -0.000654 0.001453 +1593 1 0.000280 1560.000000 0.003523 -0.000242 0.006778 +1594 1 0.000249 1560.000000 -0.001944 0.000811 0.006919 +1595 1 0.000213 1560.000000 0.000315 -0.002688 0.007465 +1596 1 0.000212 1560.000000 0.001667 0.000601 0.008661 +1597 1 0.000284 1560.000000 -0.001388 0.001442 0.000524 +1598 1 0.000201 1560.000000 -0.000635 0.001129 0.001795 +1599 1 0.000210 1560.000000 -0.000106 0.001496 0.004546 +1600 1 0.000269 1560.000000 -0.001190 -0.001211 0.001956 +1601 1 0.000245 1560.000000 0.001133 -0.001711 0.001699 +1602 1 0.000286 1560.000000 -0.002078 -0.000522 0.002448 +1603 1 0.000217 1560.000000 0.002752 0.001711 0.004891 +1604 1 0.000210 1560.000000 -0.000003 0.003838 0.004533 +1605 1 0.000204 1560.000000 -0.000117 -0.000426 0.000224 +1606 1 0.000233 1560.000000 0.000241 0.000258 0.004847 +1607 1 0.000211 1560.000000 0.001682 0.000647 0.002895 +1608 1 0.000196 1560.000000 -0.002034 -0.000760 0.009482 +1609 1 0.000251 1560.000000 -0.000245 0.003276 0.008813 +1610 1 0.000216 1560.000000 -0.000292 -0.000383 0.002657 +1611 1 0.000202 1560.000000 0.000094 0.000524 0.008325 +1612 1 0.000199 1560.000000 0.000320 -0.000741 0.005652 +1613 1 0.000278 1560.000000 -0.001058 -0.000913 0.008898 +1614 1 0.000255 1560.000000 -0.001095 -0.000377 0.001850 +1615 1 0.000220 1560.000000 0.000530 -0.001402 0.001868 +1616 1 0.000194 1560.000000 -0.000946 0.002398 0.003256 +1617 1 0.000200 1560.000000 0.001937 0.000844 0.000785 +1618 1 0.000253 1560.000000 -0.000364 -0.000105 0.005133 +1619 1 0.000197 1560.000000 0.001885 0.001786 0.000898 +1620 1 0.000222 1560.000000 -0.001897 -0.003236 0.006183 +1621 1 0.000204 1560.000000 -0.002957 -0.000095 0.009545 +1622 1 0.000268 1560.000000 0.000528 0.000750 0.009691 +1623 1 0.000238 1560.000000 0.002687 -0.000026 0.003062 +1624 1 0.000212 1560.000000 0.002422 -0.001749 0.004381 +1625 1 0.000225 1560.000000 -0.002502 -0.001469 0.006727 +1626 1 0.000207 1560.000000 -0.000675 0.001893 0.007078 +1627 1 0.000277 1560.000000 -0.001055 -0.001835 0.001067 +1628 1 0.000217 1560.000000 0.000368 -0.000452 0.001436 +1629 1 0.000222 1560.000000 0.000722 -0.000981 0.004153 +1630 1 0.000268 1560.000000 0.003272 0.000181 0.005972 +1631 1 0.000219 1560.000000 0.002286 -0.000094 0.002301 +1632 1 0.000208 1560.000000 -0.000759 0.000119 0.007489 +1633 1 0.000220 1560.000000 -0.002942 -0.000592 0.006721 +1634 1 0.000284 1560.000000 -0.000715 0.000354 0.004184 +1635 1 0.000205 1560.000000 -0.000867 0.002603 0.000955 +1636 1 0.000192 1560.000000 -0.002059 0.001804 0.004102 +1637 1 0.000212 1560.000000 0.001858 0.001986 0.007106 +1638 1 0.000238 1560.000000 0.000125 -0.000972 0.005950 +1639 1 0.000219 1560.000000 -0.000085 0.001133 0.001428 +1640 1 0.000262 1560.000000 -0.001116 -0.002835 0.003608 +1641 1 0.000230 1560.000000 -0.000928 -0.002693 0.001696 +1642 1 0.000208 1560.000000 -0.000010 -0.000788 0.009089 +1643 1 0.000271 1560.000000 -0.001046 0.001383 0.002307 +1644 1 0.000198 1560.000000 -0.002524 -0.001404 0.009227 +1645 1 0.000210 1560.000000 0.001783 -0.000870 0.004750 +1646 1 0.000280 1560.000000 -0.002981 -0.000806 0.008753 +1647 1 0.000236 1560.000000 0.000032 -0.002326 0.002224 +1648 1 0.000217 1560.000000 0.001496 -0.003101 0.002256 +1649 1 0.000225 1560.000000 -0.001217 -0.000172 0.005941 +1650 1 0.000201 1560.000000 0.000205 -0.003687 0.005717 +1651 1 0.000211 1560.000000 -0.000803 -0.000811 0.001306 +1652 1 0.000196 1560.000000 0.000975 0.001639 0.001895 +1653 1 0.000232 1560.000000 -0.001957 0.001976 0.007269 +1654 1 0.000280 1560.000000 -0.001333 0.001640 0.001242 +1655 1 0.000256 1560.000000 0.002966 -0.001731 0.008088 +1656 1 0.000282 1560.000000 0.002652 0.000813 0.004999 +1657 1 0.000249 1560.000000 -0.001453 -0.000063 0.006666 +1658 1 0.000218 1560.000000 0.000602 0.002261 0.008859 +1659 1 0.000211 1560.000000 -0.001683 0.001869 0.001088 +1660 1 0.000223 1560.000000 -0.000357 0.001988 0.000245 +1661 1 0.000201 1560.000000 -0.000315 -0.000342 0.004636 +1662 1 0.000230 1560.000000 -0.000557 0.000658 0.005065 +1663 1 0.000207 1560.000000 -0.000543 -0.000662 0.008647 +1664 1 0.000196 1560.000000 -0.001028 0.003347 0.006099 +1665 1 0.000245 1560.000000 0.001476 0.000059 0.004562 +1666 1 0.000258 1560.000000 0.000331 0.002817 0.007958 +1667 1 0.000221 1560.000000 0.000323 -0.000356 0.002752 +1668 1 0.000249 1560.000000 -0.001642 -0.000391 0.002655 +1669 1 0.000225 1560.000000 0.001898 -0.000203 0.002130 +1670 1 0.000204 1560.000000 0.000601 -0.000271 0.009761 +1671 1 0.000212 1560.000000 -0.000905 -0.001918 0.001501 +1672 1 0.000199 1560.000000 -0.001860 0.003059 0.005768 +1673 1 0.000249 1560.000000 0.001623 -0.000193 0.001845 +1674 1 0.000230 1560.000000 0.001866 0.000857 0.005082 +1675 1 0.000237 1560.000000 0.001602 0.002916 0.005680 +1676 1 0.000240 1560.000000 0.001132 0.002669 0.005505 +1677 1 0.000225 1560.000000 -0.001091 -0.000094 0.004457 +1678 1 0.000236 1560.000000 0.000759 0.002772 0.001086 +1679 1 0.000199 1560.000000 -0.000418 -0.002333 0.001277 +1680 1 0.000236 1560.000000 0.003248 -0.001939 0.007394 +1681 1 0.000196 1560.000000 0.000304 -0.001337 0.002838 +1682 1 0.000214 1560.000000 -0.000760 0.002111 0.001472 +1683 1 0.000244 1560.000000 -0.000225 0.001093 0.005678 +1684 1 0.000213 1560.000000 -0.001130 -0.002551 0.002701 +1685 1 0.000217 1560.000000 -0.001478 -0.001688 0.008309 +1686 1 0.000219 1560.000000 -0.000614 -0.000011 0.003381 +1687 1 0.000235 1560.000000 -0.002678 0.001922 0.004328 +1688 1 0.000233 1560.000000 0.001635 0.001081 0.002702 +1689 1 0.000193 1560.000000 0.001032 -0.002214 0.000819 +1690 1 0.000268 1560.000000 -0.000096 0.001309 0.006249 +1691 1 0.000198 1560.000000 0.002119 -0.001905 0.001903 +1692 1 0.000219 1560.000000 -0.001446 -0.000140 0.007093 +1693 1 0.000241 1560.000000 -0.000699 0.002814 0.009347 +1694 1 0.000261 1560.000000 -0.001293 -0.001122 0.007682 +1695 1 0.000209 1560.000000 -0.001042 -0.000012 0.002458 +1696 1 0.000211 1560.000000 -0.000242 -0.003094 0.004461 +1697 1 0.000228 1560.000000 -0.001767 -0.000241 0.001636 +1698 1 0.000198 1560.000000 0.001284 0.003009 0.007865 +1699 1 0.000206 1560.000000 -0.000263 0.000116 0.007951 +1700 1 0.000218 1560.000000 -0.001514 0.001384 0.007325 +1701 1 0.000206 1560.000000 0.000563 -0.002973 0.004647 +1702 1 0.000244 1560.000000 -0.001800 -0.003309 0.002358 +1703 1 0.000197 1560.000000 0.001875 0.003169 0.000133 +1704 1 0.000221 1560.000000 0.000038 -0.000809 0.003308 +1705 1 0.000256 1560.000000 0.000372 0.002241 0.006259 +1706 1 0.000198 1560.000000 0.001424 0.001820 0.009685 +1707 1 0.000256 1560.000000 -0.000460 -0.000028 0.004068 +1708 1 0.000251 1560.000000 -0.000391 0.003791 0.002113 +1709 1 0.000255 1560.000000 -0.001867 -0.002147 0.005646 +1710 1 0.000245 1560.000000 -0.000986 -0.000607 0.006644 +1711 1 0.000208 1560.000000 -0.001981 0.001125 0.002972 +1712 1 0.000192 1560.000000 0.001848 -0.002445 0.009744 +1713 1 0.000206 1560.000000 0.001033 -0.001593 0.004389 +1714 1 0.000235 1560.000000 0.001950 -0.002579 0.004552 +1715 1 0.000266 1560.000000 -0.001730 -0.000052 0.008773 +1716 1 0.000233 1560.000000 -0.000960 -0.000453 0.005810 +1717 1 0.000231 1560.000000 -0.000793 -0.000472 0.002283 +1718 1 0.000210 1560.000000 0.001825 -0.001193 0.001078 +1719 1 0.000246 1560.000000 -0.001000 0.000644 0.005730 +1720 1 0.000202 1560.000000 0.001314 -0.001250 0.004481 +1721 1 0.000197 1560.000000 0.002303 0.000668 0.003281 +1722 1 0.000253 1560.000000 -0.001503 0.000638 0.009729 +1723 1 0.000279 1560.000000 -0.000941 0.002000 0.007457 +1724 1 0.000199 1560.000000 -0.000945 0.003174 0.009302 +1725 1 0.000238 1560.000000 0.000839 -0.000588 0.007461 +1726 1 0.000199 1560.000000 0.002360 0.002881 0.005851 +1727 1 0.000243 1560.000000 0.002418 0.000593 0.009247 +1728 1 0.000243 1560.000000 -0.001073 -0.001088 0.006803 +1729 1 0.000225 1560.000000 -0.001026 0.001657 0.005858 +1730 1 0.000277 1560.000000 0.000265 0.001677 0.007728 +1731 1 0.000209 1560.000000 0.000182 -0.001342 0.005630 +1732 1 0.000276 1560.000000 0.002862 -0.001489 0.002907 +1733 1 0.000206 1560.000000 0.000500 -0.001791 0.009702 +1734 1 0.000248 1560.000000 0.001004 -0.001500 0.008292 +1735 1 0.000255 1560.000000 -0.000716 0.001798 0.004042 +1736 1 0.000196 1560.000000 0.000922 -0.002553 0.005206 +1737 1 0.000212 1560.000000 0.000676 -0.001901 0.000789 +1738 1 0.000193 1560.000000 0.001785 -0.000525 0.001814 +1739 1 0.000237 1560.000000 0.002555 -0.001502 0.001595 +1740 1 0.000217 1560.000000 0.000563 0.001617 0.009585 +1741 1 0.000193 1560.000000 0.002822 0.000516 0.009090 +1742 1 0.000206 1560.000000 -0.001431 -0.000623 0.006721 +1743 1 0.000195 1560.000000 0.002333 0.002212 0.008926 +1744 1 0.000251 1560.000000 0.000057 -0.000316 0.002404 +1745 1 0.000280 1560.000000 0.001238 -0.002594 0.003831 +1746 1 0.000199 1560.000000 -0.000511 -0.000032 0.008164 +1747 1 0.000213 1560.000000 0.000588 0.000915 0.009016 +1748 1 0.000243 1560.000000 -0.000760 -0.001171 0.001907 +1749 1 0.000245 1560.000000 0.003134 -0.002149 0.005287 +1750 1 0.000261 1560.000000 -0.002530 0.001887 0.003694 +1751 1 0.000223 1560.000000 -0.000381 -0.002910 0.009654 +1752 1 0.000279 1560.000000 -0.000794 -0.001427 0.001215 +1753 1 0.000254 1560.000000 -0.001654 0.000341 0.007609 +1754 1 0.000201 1560.000000 -0.000071 0.000442 0.004258 +1755 1 0.000228 1560.000000 -0.000514 0.002966 0.008489 +1756 1 0.000252 1560.000000 -0.000569 0.003511 0.006457 +1757 1 0.000248 1560.000000 -0.000743 -0.001524 0.004911 +1758 1 0.000197 1560.000000 0.000219 -0.000805 0.004406 +1759 1 0.000238 1560.000000 -0.001759 0.000917 0.002320 +1760 1 0.000207 1560.000000 0.001345 0.003068 0.001572 +1761 1 0.000194 1560.000000 0.000203 -0.000144 0.009674 +1762 1 0.000247 1560.000000 -0.000179 -0.000486 0.008496 +1763 1 0.000221 1560.000000 0.000368 0.000155 0.008339 +1764 1 0.000281 1560.000000 0.000747 0.002257 0.004791 +1765 1 0.000196 1560.000000 -0.001273 -0.000604 0.007943 +1766 1 0.000280 1560.000000 -0.002534 0.002283 0.000359 +1767 1 0.000282 1560.000000 -0.002909 -0.002247 0.001624 +1768 1 0.000204 1560.000000 0.002089 -0.002422 0.005225 +1769 1 0.000206 1560.000000 0.001407 0.003229 0.003776 +1770 1 0.000285 1560.000000 0.001984 -0.000892 0.005167 +1771 1 0.000237 1560.000000 -0.001830 -0.000557 0.003493 +1772 1 0.000202 1560.000000 -0.003352 0.001184 0.008480 +1773 1 0.000237 1560.000000 0.001600 -0.003160 0.001211 +1774 1 0.000266 1560.000000 0.002823 -0.000411 0.002531 +1775 1 0.000241 1560.000000 0.001270 -0.000999 0.008301 +1776 1 0.000223 1560.000000 -0.000010 0.002783 0.007145 +1777 1 0.000213 1560.000000 0.002506 0.000828 0.002811 +1778 1 0.000198 1560.000000 0.000923 0.003536 0.001981 +1779 1 0.000221 1560.000000 0.001525 0.002717 0.006184 +1780 1 0.000273 1560.000000 0.002601 0.001998 0.002277 +1781 1 0.000198 1560.000000 0.001944 0.003076 0.004476 +1782 1 0.000196 1560.000000 -0.002020 0.000419 0.004390 +1783 1 0.000283 1560.000000 0.003129 0.000479 0.009408 +1784 1 0.000255 1560.000000 0.000021 -0.000255 0.007707 +1785 1 0.000205 1560.000000 -0.000399 -0.000424 0.003706 +1786 1 0.000200 1560.000000 -0.003136 -0.001952 0.002072 +1787 1 0.000208 1560.000000 0.000290 0.001444 0.002143 +1788 1 0.000210 1560.000000 -0.001795 0.001802 0.001641 +1789 1 0.000217 1560.000000 0.001168 -0.002971 0.007500 +1790 1 0.000201 1560.000000 0.000005 0.000012 0.009492 +1791 1 0.000206 1560.000000 0.000534 0.000050 0.005915 +1792 1 0.000243 1560.000000 0.001981 0.000457 0.005739 +1793 1 0.000272 1560.000000 0.002424 0.002016 0.000143 +1794 1 0.000223 1560.000000 0.002881 -0.002537 0.001947 +1795 1 0.000211 1560.000000 -0.000801 -0.001166 0.007635 +1796 1 0.000260 1560.000000 0.002155 -0.000277 0.000209 +1797 1 0.000212 1560.000000 0.000037 0.001808 0.004993 +1798 1 0.000263 1560.000000 0.000003 -0.003296 0.006966 +1799 1 0.000251 1560.000000 -0.001914 0.003299 0.004116 +1800 1 0.000288 1560.000000 -0.000699 0.000693 0.001948 +1801 1 0.000219 1560.000000 0.001403 0.001554 0.004206 +1802 1 0.000220 1560.000000 0.000962 -0.000588 0.002654 +1803 1 0.000231 1560.000000 0.000643 0.002178 0.002043 +1804 1 0.000195 1560.000000 0.002485 -0.002509 0.001966 +1805 1 0.000203 1560.000000 0.000938 -0.001819 0.007681 +1806 1 0.000193 1560.000000 -0.001927 0.001031 0.009513 +1807 1 0.000220 1560.000000 0.002447 -0.001504 0.007169 +1808 1 0.000237 1560.000000 0.000319 0.003082 0.009237 +1809 1 0.000209 1560.000000 -0.003442 -0.000332 0.005391 +1810 1 0.000200 1560.000000 -0.000846 -0.001148 0.008679 +1811 1 0.000246 1560.000000 0.001951 0.002005 0.008343 +1812 1 0.000240 1560.000000 -0.000073 0.000244 0.004586 +1813 1 0.000205 1560.000000 -0.001385 0.000938 0.005770 +1814 1 0.000217 1560.000000 -0.000366 0.000116 0.006737 +1815 1 0.000251 1560.000000 -0.000217 0.000805 0.001520 +1816 1 0.000259 1560.000000 0.000155 0.000398 0.004439 +1817 1 0.000260 1560.000000 0.000142 0.000471 0.008780 +1818 1 0.000269 1560.000000 -0.001678 -0.000175 0.005862 +1819 1 0.000192 1560.000000 0.001828 -0.000846 0.004237 +1820 1 0.000198 1560.000000 -0.001014 0.001754 0.000282 +1821 1 0.000199 1560.000000 0.002010 -0.000260 0.004057 +1822 1 0.000239 1560.000000 0.002909 0.000243 0.009085 +1823 1 0.000249 1560.000000 -0.000878 0.002501 0.008608 +1824 1 0.000212 1560.000000 0.001430 -0.003457 0.004021 +1825 1 0.000198 1560.000000 -0.001991 -0.000698 0.008013 +1826 1 0.000199 1560.000000 0.000920 -0.000110 0.002397 +1827 1 0.000226 1560.000000 -0.000593 -0.000058 0.006496 +1828 1 0.000266 1560.000000 0.001001 -0.002289 0.003026 +1829 1 0.000224 1560.000000 -0.001151 -0.000551 0.003460 +1830 1 0.000230 1560.000000 0.000445 0.000323 0.009747 +1831 1 0.000213 1560.000000 0.002047 0.000729 0.009374 +1832 1 0.000196 1560.000000 0.000639 0.000881 0.003301 +1833 1 0.000221 1560.000000 -0.000558 -0.002068 0.007909 +1834 1 0.000203 1560.000000 0.000380 0.000367 0.007710 +1835 1 0.000200 1560.000000 0.000906 0.001760 0.009090 +1836 1 0.000255 1560.000000 0.001726 0.002566 0.004520 +1837 1 0.000193 1560.000000 -0.000124 -0.000265 0.000561 +1838 1 0.000212 1560.000000 0.001039 -0.002947 0.002313 +1839 1 0.000193 1560.000000 -0.000765 0.000182 0.001924 +1840 1 0.000213 1560.000000 0.001917 0.000775 0.008743 +1841 1 0.000243 1560.000000 0.002772 -0.002182 0.002470 +1842 1 0.000222 1560.000000 0.001824 0.000774 0.005961 +1843 1 0.000209 1560.000000 -0.001526 0.001600 0.009049 +1844 1 0.000236 1560.000000 -0.000553 0.003127 0.002285 +1845 1 0.000250 1560.000000 0.001528 0.001139 0.002085 +1846 1 0.000258 1560.000000 -0.000938 -0.000053 0.009166 +1847 1 0.000213 1560.000000 -0.000196 -0.001216 0.008165 +1848 1 0.000267 1560.000000 -0.000586 0.000124 0.005336 +1849 1 0.000209 1560.000000 0.001635 -0.003052 0.007770 +1850 1 0.000204 1560.000000 0.003129 -0.000105 0.003668 +1851 1 0.000220 1560.000000 0.000028 -0.000164 0.001921 +1852 1 0.000219 1560.000000 0.002253 -0.002090 0.009216 +1853 1 0.000199 1560.000000 0.002851 0.002558 0.001646 +1854 1 0.000279 1560.000000 -0.003383 0.000622 0.006652 +1855 1 0.000197 1560.000000 0.000782 -0.001764 0.001715 +1856 1 0.000225 1560.000000 0.002422 0.002205 0.005315 +1857 1 0.000225 1560.000000 -0.000161 0.002459 0.005178 +1858 1 0.000235 1560.000000 -0.001981 -0.001167 0.006282 +1859 1 0.000206 1560.000000 -0.001461 0.001548 0.004351 +1860 1 0.000221 1560.000000 0.002194 -0.000132 0.009304 +1861 1 0.000193 1560.000000 -0.000793 -0.003329 0.001557 +1862 1 0.000232 1560.000000 -0.001438 -0.002902 0.007177 +1863 1 0.000254 1560.000000 0.001671 0.002455 0.002730 +1864 1 0.000210 1560.000000 -0.000028 0.003598 0.005278 +1865 1 0.000205 1560.000000 -0.000366 0.000510 0.004294 +1866 1 0.000256 1560.000000 0.001708 0.000302 0.008022 +1867 1 0.000207 1560.000000 0.003051 0.002085 0.003333 +1868 1 0.000215 1560.000000 -0.000166 -0.002878 0.002141 +1869 1 0.000221 1560.000000 0.000545 0.002591 0.007375 +1870 1 0.000215 1560.000000 -0.000840 -0.001867 0.008597 +1871 1 0.000218 1560.000000 -0.000779 -0.000714 0.003895 +1872 1 0.000195 1560.000000 -0.002052 0.000813 0.001189 +1873 1 0.000280 1560.000000 -0.001331 0.000522 0.006838 +1874 1 0.000203 1560.000000 0.000650 0.000739 0.007008 +1875 1 0.000214 1560.000000 -0.000301 -0.000642 0.003972 +1876 1 0.000246 1560.000000 0.003223 0.000107 0.004305 +1877 1 0.000211 1560.000000 0.002667 0.002222 0.009648 +1878 1 0.000278 1560.000000 -0.001351 -0.002653 0.005329 +1879 1 0.000222 1560.000000 -0.003689 0.000997 0.004635 +1880 1 0.000210 1560.000000 -0.003129 0.002140 0.005373 +1881 1 0.000231 1560.000000 -0.001750 0.000125 0.001948 +1882 1 0.000217 1560.000000 0.001087 0.002322 0.000601 +1883 1 0.000284 1560.000000 0.002397 -0.000274 0.000476 +1884 1 0.000253 1560.000000 0.000085 -0.001497 0.004406 +1885 1 0.000262 1560.000000 -0.003726 -0.000991 0.004792 +1886 1 0.000261 1560.000000 0.001960 0.000872 0.005772 +1887 1 0.000264 1560.000000 0.001199 -0.002000 0.004024 +1888 1 0.000214 1560.000000 -0.000335 0.002833 0.006473 +1889 1 0.000206 1560.000000 -0.001619 0.003109 0.005672 +1890 1 0.000203 1560.000000 -0.001359 -0.000717 0.001517 +1891 1 0.000275 1560.000000 0.001479 0.001325 0.001807 +1892 1 0.000246 1560.000000 0.000056 0.002628 0.007520 +1893 1 0.000278 1560.000000 -0.001333 -0.002544 0.001004 +1894 1 0.000200 1560.000000 -0.000618 -0.003621 0.003685 +1895 1 0.000220 1560.000000 0.001222 -0.003236 0.002232 +1896 1 0.000193 1560.000000 -0.000422 -0.000537 0.008918 +1897 1 0.000220 1560.000000 0.000084 0.001448 0.007739 +1898 1 0.000225 1560.000000 -0.000718 0.000870 0.002974 +1899 1 0.000249 1560.000000 0.000714 0.001137 0.002436 +1900 1 0.000205 1560.000000 -0.002555 -0.000539 0.005873 +1901 1 0.000197 1560.000000 -0.001673 0.002478 0.002657 +1902 1 0.000282 1560.000000 -0.000050 -0.001815 0.004417 +1903 1 0.000243 1560.000000 0.000087 0.003027 0.006796 +1904 1 0.000218 1560.000000 -0.000226 0.000845 0.008010 +1905 1 0.000212 1560.000000 0.000170 -0.003780 0.009162 +1906 1 0.000244 1560.000000 -0.001003 -0.000986 0.000422 +1907 1 0.000271 1560.000000 0.001224 0.002925 0.009159 +1908 1 0.000228 1560.000000 0.000075 0.000109 0.000716 +1909 1 0.000200 1560.000000 0.001930 0.003190 0.000529 +1910 1 0.000246 1560.000000 -0.003764 0.000012 0.000848 +1911 1 0.000198 1560.000000 0.000462 -0.000036 0.001087 +1912 1 0.000213 1560.000000 -0.002459 0.001925 0.000207 +1913 1 0.000236 1560.000000 0.001886 -0.000082 0.008834 +1914 1 0.000253 1560.000000 0.000875 0.000756 0.007694 +1915 1 0.000288 1560.000000 0.002536 0.000052 0.009161 +1916 1 0.000201 1560.000000 -0.001367 0.000062 0.002149 +1917 1 0.000270 1560.000000 -0.000084 0.003222 0.000908 +1918 1 0.000261 1560.000000 -0.000102 0.001267 0.002408 +1919 1 0.000226 1560.000000 0.001376 0.002593 0.003738 +1920 1 0.000284 1560.000000 0.000094 -0.003101 0.003032 +1921 1 0.000286 1560.000000 -0.002568 0.000139 0.009815 +1922 1 0.000222 1560.000000 -0.002697 0.000754 0.002948 +1923 1 0.000240 1560.000000 -0.000268 0.003455 0.007945 +1924 1 0.000251 1560.000000 -0.001204 -0.000871 0.005552 +1925 1 0.000214 1560.000000 -0.000163 -0.001794 0.000511 +1926 1 0.000271 1560.000000 0.000363 -0.001890 0.009520 +1927 1 0.000230 1560.000000 0.002178 0.001554 0.007558 +1928 1 0.000216 1560.000000 -0.001281 -0.001046 0.009184 +1929 1 0.000216 1560.000000 -0.002125 0.001468 0.001045 +1930 1 0.000247 1560.000000 0.001616 -0.000610 0.003250 +1931 1 0.000208 1560.000000 0.000847 -0.000433 0.001510 +1932 1 0.000199 1560.000000 -0.002913 0.001619 0.001968 +1933 1 0.000256 1560.000000 0.000726 -0.000263 0.002543 +1934 1 0.000239 1560.000000 -0.000266 0.000017 0.002882 +1935 1 0.000207 1560.000000 0.002844 0.000231 0.007887 +1936 1 0.000201 1560.000000 0.000574 -0.000833 0.003150 +1937 1 0.000260 1560.000000 -0.000851 0.001222 0.007084 +1938 1 0.000243 1560.000000 -0.001442 0.002943 0.008710 +1939 1 0.000283 1560.000000 -0.000721 0.002752 0.008429 +1940 1 0.000233 1560.000000 0.002280 0.002590 0.001116 +1941 1 0.000262 1560.000000 -0.000106 0.000375 0.006722 +1942 1 0.000270 1560.000000 0.001048 0.002491 0.006353 +1943 1 0.000197 1560.000000 -0.001184 0.002016 0.007256 +1944 1 0.000195 1560.000000 0.000447 -0.000472 0.007652 +1945 1 0.000222 1560.000000 -0.000643 -0.001620 0.000585 +1946 1 0.000221 1560.000000 -0.000294 0.000273 0.008122 +1947 1 0.000243 1560.000000 -0.001763 0.000733 0.007904 +1948 1 0.000219 1560.000000 -0.000415 0.000706 0.007361 +1949 1 0.000276 1560.000000 -0.000871 -0.002879 0.005842 +1950 1 0.000205 1560.000000 -0.002558 -0.001558 0.004609 +1951 1 0.000245 1560.000000 -0.002045 -0.001836 0.003192 +1952 1 0.000219 1560.000000 -0.002913 0.000569 0.005952 +1953 1 0.000196 1560.000000 0.000457 -0.001071 0.005556 +1954 1 0.000209 1560.000000 -0.000990 0.000040 0.008044 +1955 1 0.000272 1560.000000 -0.002672 -0.002138 0.008172 +1956 1 0.000215 1560.000000 -0.000469 0.000230 0.008848 +1957 1 0.000198 1560.000000 -0.002453 -0.002289 0.005370 +1958 1 0.000211 1560.000000 0.003607 0.000011 0.009501 +1959 1 0.000238 1560.000000 0.001480 0.002871 0.000883 +1960 1 0.000197 1560.000000 -0.002910 -0.001727 0.008679 +1961 1 0.000260 1560.000000 0.003223 -0.000049 0.007185 +1962 1 0.000260 1560.000000 0.001190 -0.001806 0.005536 +1963 1 0.000265 1560.000000 -0.000306 0.000514 0.009235 +1964 1 0.000204 1560.000000 -0.000087 -0.000067 0.002475 +1965 1 0.000234 1560.000000 -0.002759 0.001383 0.002426 +1966 1 0.000203 1560.000000 -0.001463 -0.000056 0.003123 +1967 1 0.000203 1560.000000 0.001133 0.002821 0.004956 +1968 1 0.000207 1560.000000 -0.001097 -0.003271 0.007166 +1969 1 0.000279 1560.000000 0.001242 -0.002701 0.002458 +1970 1 0.000261 1560.000000 -0.002007 0.002893 0.004179 +1971 1 0.000211 1560.000000 -0.001424 -0.001689 0.003971 +1972 1 0.000238 1560.000000 -0.002483 -0.001492 0.008836 +1973 1 0.000202 1560.000000 -0.001623 -0.000428 0.000111 +1974 1 0.000212 1560.000000 -0.000593 -0.002663 0.000812 +1975 1 0.000265 1560.000000 0.000761 0.002958 0.006738 +1976 1 0.000210 1560.000000 -0.001505 0.001972 0.008322 +1977 1 0.000207 1560.000000 0.001462 -0.000910 0.005803 +1978 1 0.000214 1560.000000 0.003084 -0.000070 0.002630 +1979 1 0.000193 1560.000000 -0.000518 -0.000422 0.006150 +1980 1 0.000238 1560.000000 0.000606 0.002573 0.003870 +1981 1 0.000262 1560.000000 -0.001869 -0.001492 0.001924 +1982 1 0.000205 1560.000000 0.003112 -0.000182 0.003348 +1983 1 0.000250 1560.000000 0.001292 0.002725 0.002739 +1984 1 0.000279 1560.000000 -0.003127 0.000030 0.009752 +1985 1 0.000286 1560.000000 0.002791 0.000408 0.005072 +1986 1 0.000215 1560.000000 0.000053 0.001212 0.006665 +1987 1 0.000225 1560.000000 0.000041 -0.001741 0.001144 +1988 1 0.000219 1560.000000 0.001934 0.002481 0.003820 +1989 1 0.000270 1560.000000 -0.002640 0.002082 0.007338 +1990 1 0.000227 1560.000000 0.002506 0.001732 0.006631 +1991 1 0.000238 1560.000000 -0.000049 0.000337 0.007474 +1992 1 0.000238 1560.000000 0.001629 -0.001394 0.003826 +1993 1 0.000235 1560.000000 -0.001879 -0.000807 0.000201 +1994 1 0.000277 1560.000000 0.000324 0.000738 0.008720 +1995 1 0.000268 1560.000000 0.001515 -0.001333 0.005384 +1996 1 0.000198 1560.000000 -0.000532 -0.000308 0.002946 +1997 1 0.000243 1560.000000 -0.002483 -0.000332 0.007016 +1998 1 0.000278 1560.000000 0.000627 -0.003138 0.002081 +1999 1 0.000201 1560.000000 0.002513 -0.001981 0.004626 +2000 1 0.000220 1560.000000 -0.001012 -0.000916 0.000735 +2001 1 0.000282 1560.000000 0.001187 -0.000926 0.003510 +2002 1 0.000256 1560.000000 0.000513 -0.002184 0.003882 +2003 1 0.000215 1560.000000 -0.000454 0.000939 0.000832 +2004 1 0.000204 1560.000000 0.001953 -0.003276 0.001965 +2005 1 0.000224 1560.000000 0.000174 -0.000617 0.002565 +2006 1 0.000262 1560.000000 -0.003621 0.000501 0.003286 +2007 1 0.000229 1560.000000 0.000226 0.000800 0.009346 +2008 1 0.000199 1560.000000 -0.001259 -0.001684 0.008904 +2009 1 0.000209 1560.000000 -0.000981 0.000552 0.002657 +2010 1 0.000194 1560.000000 -0.000362 -0.001209 0.005023 +2011 1 0.000192 1560.000000 0.000130 0.001074 0.005119 +2012 1 0.000238 1560.000000 0.001540 -0.000093 0.007528 +2013 1 0.000218 1560.000000 0.000035 -0.002035 0.007075 +2014 1 0.000200 1560.000000 0.003499 -0.000572 0.004008 +2015 1 0.000276 1560.000000 0.001831 0.002251 0.009015 +2016 1 0.000200 1560.000000 -0.000602 -0.000334 0.000843 +2017 1 0.000202 1560.000000 -0.001483 0.002910 0.009201 +2018 1 0.000202 1560.000000 -0.001938 -0.000053 0.006191 +2019 1 0.000203 1560.000000 -0.002454 -0.000266 0.004641 +2020 1 0.000240 1560.000000 -0.000469 -0.000390 0.002017 +2021 1 0.000228 1560.000000 0.002468 -0.000486 0.002841 +2022 1 0.000205 1560.000000 -0.000246 0.003265 0.009420 +2023 1 0.000265 1560.000000 0.003129 -0.001040 0.008141 +2024 1 0.000250 1560.000000 -0.000300 0.001066 0.000487 +2025 1 0.000207 1560.000000 0.000723 0.002724 0.005258 +2026 1 0.000207 1560.000000 -0.000307 -0.000383 0.008841 +2027 1 0.000261 1560.000000 -0.000625 -0.002835 0.005671 +2028 1 0.000214 1560.000000 -0.002209 -0.001808 0.000979 +2029 1 0.000200 1560.000000 -0.002711 -0.000629 0.000264 +2030 1 0.000202 1560.000000 -0.000780 -0.001322 0.006675 +2031 1 0.000275 1560.000000 -0.000696 -0.001075 0.001146 +2032 1 0.000240 1560.000000 -0.002885 -0.001283 0.000526 +2033 1 0.000253 1560.000000 0.001084 0.000444 0.007538 +2034 1 0.000266 1560.000000 -0.000174 0.000251 0.001689 +2035 1 0.000209 1560.000000 -0.000652 0.003673 0.003351 +2036 1 0.000202 1560.000000 -0.000858 -0.002672 0.005359 +2037 1 0.000214 1560.000000 0.000489 0.000110 0.002200 +2038 1 0.000220 1560.000000 -0.003461 -0.001112 0.007962 +2039 1 0.000227 1560.000000 0.001646 -0.001322 0.003411 +2040 1 0.000207 1560.000000 0.001576 -0.001526 0.009450 +2041 1 0.000195 1560.000000 -0.002218 -0.001350 0.003017 +2042 1 0.000237 1560.000000 0.001027 0.002198 0.005091 +2043 1 0.000240 1560.000000 0.002351 0.002638 0.003859 +2044 1 0.000224 1560.000000 -0.000843 -0.001309 0.008864 +2045 1 0.000276 1560.000000 0.000228 0.000126 0.008017 +2046 1 0.000212 1560.000000 0.000560 0.000187 0.003565 +2047 1 0.000225 1560.000000 0.002222 0.002085 0.006101 +2048 1 0.000227 1560.000000 -0.000656 0.000664 0.005795 +2049 1 0.000231 1560.000000 0.002112 0.000106 0.004114 +2050 1 0.000196 1560.000000 0.001117 0.000102 0.004311 +2051 1 0.000229 1560.000000 -0.000803 -0.002572 0.000325 +2052 1 0.000215 1560.000000 0.000402 -0.002056 0.000870 +2053 1 0.000194 1560.000000 0.000552 -0.002466 0.000171 +2054 1 0.000216 1560.000000 0.000842 0.000757 0.001462 +2055 1 0.000223 1560.000000 0.000453 0.001545 0.005214 +2056 1 0.000206 1560.000000 0.000308 0.000238 0.006781 +2057 1 0.000200 1560.000000 0.000711 0.000928 0.003494 +2058 1 0.000209 1560.000000 0.001919 0.001072 0.008726 +2059 1 0.000216 1560.000000 0.000672 0.000288 0.006840 +2060 1 0.000223 1560.000000 -0.001095 -0.002188 0.003897 +2061 1 0.000224 1560.000000 -0.003590 0.001140 0.000533 +2062 1 0.000198 1560.000000 0.003509 0.000585 0.005063 +2063 1 0.000196 1560.000000 -0.002622 -0.002457 0.003811 +2064 1 0.000208 1560.000000 0.001561 -0.001696 0.004015 +2065 1 0.000271 1560.000000 0.003673 -0.000027 0.000341 +2066 1 0.000242 1560.000000 -0.000490 0.002125 0.006935 +2067 1 0.000215 1560.000000 0.000832 -0.000154 0.000518 +2068 1 0.000236 1560.000000 0.003501 0.000939 0.009713 +2069 1 0.000280 1560.000000 -0.000320 -0.000830 0.008842 +2070 1 0.000248 1560.000000 0.000513 0.000327 0.003107 +2071 1 0.000280 1560.000000 0.003069 -0.000132 0.008970 +2072 1 0.000267 1560.000000 -0.001132 -0.001985 0.007036 +2073 1 0.000238 1560.000000 -0.001774 0.002346 0.008664 +2074 1 0.000232 1560.000000 0.002557 0.002458 0.001913 +2075 1 0.000209 1560.000000 -0.000280 -0.002287 0.003058 +2076 1 0.000201 1560.000000 -0.003571 -0.001067 0.007465 +2077 1 0.000228 1560.000000 -0.003172 -0.000267 0.003563 +2078 1 0.000204 1560.000000 -0.002451 0.002186 0.002881 +2079 1 0.000232 1560.000000 0.001735 0.002815 0.007820 +2080 1 0.000243 1560.000000 0.002046 0.000007 0.001372 +2081 1 0.000278 1560.000000 -0.001598 0.000944 0.001290 +2082 1 0.000205 1560.000000 -0.001799 -0.000026 0.006447 +2083 1 0.000230 1560.000000 -0.000482 0.000493 0.002055 +2084 1 0.000211 1560.000000 0.001568 -0.003456 0.003358 +2085 1 0.000233 1560.000000 0.000552 0.002926 0.009471 +2086 1 0.000205 1560.000000 -0.002174 -0.000567 0.007916 +2087 1 0.000239 1560.000000 -0.001230 -0.001956 0.000513 +2088 1 0.000234 1560.000000 -0.002847 -0.000327 0.001269 +2089 1 0.000236 1560.000000 0.003445 -0.000465 0.003305 +2090 1 0.000196 1560.000000 0.000494 -0.002480 0.003441 +2091 1 0.000201 1560.000000 0.000854 -0.003116 0.006062 +2092 1 0.000198 1560.000000 0.001656 -0.003407 0.005400 +2093 1 0.000218 1560.000000 -0.001596 0.000926 0.004291 +2094 1 0.000268 1560.000000 0.001808 0.002005 0.001188 +2095 1 0.000267 1560.000000 -0.002239 0.002719 0.007947 +2096 1 0.000243 1560.000000 -0.001418 -0.001698 0.006307 +2097 1 0.000224 1560.000000 -0.001365 0.001049 0.006047 +2098 1 0.000241 1560.000000 0.000474 0.000605 0.005046 +2099 1 0.000211 1560.000000 0.000970 0.000188 0.003271 +2100 1 0.000195 1560.000000 0.001280 -0.002761 0.006830 +2101 1 0.000197 1560.000000 -0.003240 0.001900 0.006045 +2102 1 0.000204 1560.000000 -0.000437 -0.000057 0.007861 +2103 1 0.000253 1560.000000 -0.003317 -0.000094 0.005914 +2104 1 0.000249 1560.000000 -0.000542 0.003328 0.002096 +2105 1 0.000205 1560.000000 -0.000450 -0.000863 0.005006 +2106 1 0.000205 1560.000000 -0.001750 -0.000039 0.003230 +2107 1 0.000237 1560.000000 0.002386 -0.001488 0.000756 +2108 1 0.000210 1560.000000 -0.000611 -0.001751 0.004861 +2109 1 0.000271 1560.000000 -0.002088 -0.000722 0.001471 +2110 1 0.000197 1560.000000 0.002968 0.001617 0.004942 +2111 1 0.000203 1560.000000 0.000350 0.001267 0.001115 +2112 1 0.000204 1560.000000 -0.002938 -0.002055 0.007912 +2113 1 0.000244 1560.000000 -0.000444 0.002750 0.009090 +2114 1 0.000230 1560.000000 0.000762 0.003264 0.002564 +2115 1 0.000238 1560.000000 0.001427 -0.003494 0.008468 +2116 1 0.000226 1560.000000 -0.001742 -0.002856 0.003686 +2117 1 0.000276 1560.000000 -0.000543 -0.000258 0.007563 +2118 1 0.000238 1560.000000 -0.000650 -0.000998 0.008024 +2119 1 0.000264 1560.000000 0.002522 -0.002766 0.005054 +2120 1 0.000235 1560.000000 0.001914 -0.002840 0.009359 +2121 1 0.000215 1560.000000 0.002726 -0.000749 0.004781 +2122 1 0.000219 1560.000000 -0.001827 -0.000404 0.006983 +2123 1 0.000194 1560.000000 -0.001571 0.000177 0.003314 +2124 1 0.000217 1560.000000 0.002429 0.000709 0.002460 +2125 1 0.000193 1560.000000 -0.000117 0.003462 0.002624 +2126 1 0.000271 1560.000000 0.002073 -0.002471 0.002677 +2127 1 0.000283 1560.000000 -0.001428 -0.001546 0.008739 +2128 1 0.000193 1560.000000 -0.000119 0.000537 0.001551 +2129 1 0.000239 1560.000000 0.000977 -0.000758 0.007972 +2130 1 0.000226 1560.000000 0.000555 0.000245 0.009542 +2131 1 0.000283 1560.000000 0.000767 0.000841 0.007384 +2132 1 0.000232 1560.000000 0.000943 -0.002422 0.003702 +2133 1 0.000218 1560.000000 0.000432 0.003686 0.006694 +2134 1 0.000232 1560.000000 -0.000713 0.001586 0.004659 +2135 1 0.000224 1560.000000 0.000565 0.001799 0.009095 +2136 1 0.000195 1560.000000 -0.002430 0.000449 0.003937 +2137 1 0.000214 1560.000000 -0.000010 0.000162 0.002992 +2138 1 0.000211 1560.000000 -0.000506 -0.000960 0.000608 +2139 1 0.000215 1560.000000 0.002762 -0.000161 0.008519 +2140 1 0.000269 1560.000000 -0.000405 0.003025 0.004477 +2141 1 0.000255 1560.000000 -0.000816 -0.002241 0.000231 +2142 1 0.000222 1560.000000 -0.000251 -0.000483 0.009588 +2143 1 0.000206 1560.000000 0.001536 0.001430 0.001261 +2144 1 0.000209 1560.000000 0.001137 -0.003200 0.001366 +2145 1 0.000233 1560.000000 -0.001395 0.001795 0.007307 +2146 1 0.000206 1560.000000 0.000349 -0.003543 0.009071 +2147 1 0.000242 1560.000000 0.000719 0.002869 0.004588 +2148 1 0.000255 1560.000000 -0.000213 -0.001602 0.006231 +2149 1 0.000250 1560.000000 0.001513 0.001513 0.002612 +2150 1 0.000224 1560.000000 -0.002777 0.002228 0.008554 +2151 1 0.000196 1560.000000 -0.001643 0.000953 0.006717 +2152 1 0.000286 1560.000000 0.001339 -0.001639 0.003793 +2153 1 0.000230 1560.000000 -0.000454 0.000263 0.007617 +2154 1 0.000208 1560.000000 -0.000340 -0.001124 0.005695 +2155 1 0.000278 1560.000000 -0.001479 0.001550 0.002056 +2156 1 0.000224 1560.000000 -0.001483 0.002005 0.005047 +2157 1 0.000241 1560.000000 0.003128 0.000278 0.008911 +2158 1 0.000194 1560.000000 0.000784 -0.001220 0.002554 +2159 1 0.000218 1560.000000 -0.002552 -0.001778 0.009463 +2160 1 0.000242 1560.000000 -0.002196 -0.000764 0.008780 +2161 1 0.000205 1560.000000 -0.001140 -0.001318 0.006315 +2162 1 0.000265 1560.000000 -0.002916 0.001937 0.001426 +2163 1 0.000235 1560.000000 -0.002227 -0.000990 0.004380 +2164 1 0.000268 1560.000000 0.002561 0.000989 0.005295 +2165 1 0.000194 1560.000000 -0.000323 -0.000045 0.006008 +2166 1 0.000227 1560.000000 -0.002531 -0.000992 0.005200 +2167 1 0.000210 1560.000000 -0.003155 0.000424 0.002529 +2168 1 0.000265 1560.000000 -0.001394 -0.001267 0.006432 +2169 1 0.000209 1560.000000 -0.000158 0.000026 0.003702 +2170 1 0.000214 1560.000000 -0.000341 0.000174 0.003119 +2171 1 0.000251 1560.000000 -0.001871 -0.000024 0.007133 +2172 1 0.000192 1560.000000 -0.001112 0.003567 0.008364 +2173 1 0.000220 1560.000000 0.000901 0.000684 0.002307 +2174 1 0.000198 1560.000000 0.001524 -0.003160 0.004473 +2175 1 0.000207 1560.000000 -0.001825 -0.002326 0.005851 +2176 1 0.000237 1560.000000 0.000097 0.002843 0.006178 +2177 1 0.000250 1560.000000 0.000384 0.001475 0.002978 +2178 1 0.000196 1560.000000 0.000618 0.000738 0.006582 +2179 1 0.000205 1560.000000 -0.003385 0.000386 0.004757 +2180 1 0.000249 1560.000000 0.000743 -0.000312 0.008368 +2181 1 0.000283 1560.000000 -0.000030 -0.001282 0.007342 +2182 1 0.000249 1560.000000 -0.001501 -0.001070 0.000579 +2183 1 0.000270 1560.000000 -0.000243 0.000446 0.003674 +2184 1 0.000194 1560.000000 0.002240 -0.001132 0.006665 +2185 1 0.000236 1560.000000 0.000339 0.001402 0.005648 +2186 1 0.000256 1560.000000 -0.000445 -0.001055 0.009038 +2187 1 0.000275 1560.000000 -0.000907 0.001515 0.003882 +2188 1 0.000226 1560.000000 -0.001574 -0.002960 0.001054 +2189 1 0.000240 1560.000000 0.000993 0.001508 0.001708 +2190 1 0.000232 1560.000000 0.002445 -0.001351 0.004637 +2191 1 0.000228 1560.000000 -0.000234 0.003262 0.004695 +2192 1 0.000193 1560.000000 -0.003006 -0.000955 0.002353 +2193 1 0.000225 1560.000000 0.001522 -0.001350 0.006644 +2194 1 0.000208 1560.000000 -0.000317 -0.002308 0.002821 +2195 1 0.000237 1560.000000 0.000658 0.003218 0.007044 +2196 1 0.000230 1560.000000 -0.000275 0.001111 0.009607 +2197 1 0.000229 1560.000000 0.001333 -0.001189 0.003726 +2198 1 0.000271 1560.000000 0.002759 -0.000296 0.007934 +2199 1 0.000225 1560.000000 0.000810 0.000937 0.008683 +2200 1 0.000242 1560.000000 0.001171 0.001614 0.001352 +2201 1 0.000194 1560.000000 0.000418 -0.001362 0.003162 +2202 1 0.000228 1560.000000 0.001266 -0.003353 0.000878 +2203 1 0.000255 1560.000000 0.000941 -0.000170 0.007031 +2204 1 0.000233 1560.000000 -0.000233 -0.003195 0.000260 +2205 1 0.000213 1560.000000 0.001451 0.002660 0.004700 +2206 1 0.000225 1560.000000 0.002510 0.001749 0.006037 +2207 1 0.000230 1560.000000 -0.002282 0.000837 0.005129 +2208 1 0.000227 1560.000000 0.000999 -0.000216 0.009067 +2209 1 0.000247 1560.000000 -0.002655 -0.001247 0.005776 +2210 1 0.000243 1560.000000 0.000964 0.002630 0.008371 +2211 1 0.000223 1560.000000 0.000385 -0.000001 0.007269 +2212 1 0.000219 1560.000000 0.001444 -0.000773 0.001818 +2213 1 0.000239 1560.000000 -0.000857 -0.003574 0.001371 +2214 1 0.000281 1560.000000 -0.000858 0.002729 0.002728 +2215 1 0.000197 1560.000000 0.000355 -0.000355 0.003906 +2216 1 0.000209 1560.000000 -0.000788 0.000429 0.008232 +2217 1 0.000264 1560.000000 0.003162 0.000882 0.001916 +2218 1 0.000235 1560.000000 -0.002644 -0.000004 0.009536 +2219 1 0.000209 1560.000000 -0.000050 -0.001177 0.000601 +2220 1 0.000218 1560.000000 -0.002620 0.001748 0.007820 +2221 1 0.000242 1560.000000 -0.000512 0.002251 0.006633 +2222 1 0.000193 1560.000000 0.000292 0.000381 0.009537 +2223 1 0.000204 1560.000000 -0.002680 0.001348 0.007651 +2224 1 0.000281 1560.000000 -0.000497 0.000770 0.003842 +2225 1 0.000197 1560.000000 0.001295 -0.000407 0.007982 +2226 1 0.000265 1560.000000 0.001512 -0.002927 0.006577 +2227 1 0.000193 1560.000000 0.001517 0.000458 0.009055 +2228 1 0.000210 1560.000000 0.000869 -0.002408 0.007891 +2229 1 0.000244 1560.000000 -0.000240 -0.000714 0.005318 +2230 1 0.000242 1560.000000 -0.000953 -0.001282 0.000802 +2231 1 0.000218 1560.000000 -0.002944 0.001081 0.000161 +2232 1 0.000259 1560.000000 0.000090 0.003055 0.002872 +2233 1 0.000211 1560.000000 -0.000211 0.002384 0.002286 +2234 1 0.000198 1560.000000 -0.002090 0.002962 0.001205 +2235 1 0.000206 1560.000000 -0.001946 0.000673 0.009156 +2236 1 0.000212 1560.000000 0.000359 -0.001154 0.005987 +2237 1 0.000215 1560.000000 0.000084 0.001060 0.004847 +2238 1 0.000208 1560.000000 0.002576 0.000777 0.003411 +2239 1 0.000245 1560.000000 -0.002502 0.002930 0.004837 +2240 1 0.000227 1560.000000 -0.001786 0.000418 0.001637 +2241 1 0.000230 1560.000000 0.000017 0.000177 0.005733 +2242 1 0.000194 1560.000000 0.000481 0.001386 0.003695 +2243 1 0.000267 1560.000000 0.000859 -0.000948 0.009033 +2244 1 0.000228 1560.000000 0.000130 -0.001251 0.001445 +2245 1 0.000257 1560.000000 0.002655 0.000441 0.002916 +2246 1 0.000193 1560.000000 -0.001089 -0.000725 0.003701 +2247 1 0.000263 1560.000000 -0.000654 -0.000151 0.000352 +2248 1 0.000249 1560.000000 -0.001680 -0.000628 0.004121 +2249 1 0.000220 1560.000000 0.000318 -0.001292 0.001229 +2250 1 0.000208 1560.000000 -0.001050 -0.001498 0.006133 +2251 1 0.000241 1560.000000 0.002752 -0.000508 0.003218 +2252 1 0.000222 1560.000000 0.001980 0.001273 0.002013 +2253 1 0.000225 1560.000000 0.000217 0.000584 0.003719 +2254 1 0.000265 1560.000000 0.002902 0.001506 0.002939 +2255 1 0.000229 1560.000000 -0.000394 -0.000812 0.007412 +2256 1 0.000200 1560.000000 -0.000299 -0.000695 0.002654 +2257 1 0.000250 1560.000000 0.002524 0.001228 0.007034 +2258 1 0.000262 1560.000000 0.002807 0.000780 0.002755 +2259 1 0.000217 1560.000000 0.002018 -0.001034 0.008057 +2260 1 0.000196 1560.000000 0.000880 -0.002827 0.002841 +2261 1 0.000259 1560.000000 0.001781 -0.003138 0.004890 +2262 1 0.000242 1560.000000 0.000641 -0.001662 0.006750 +2263 1 0.000250 1560.000000 0.000884 -0.001110 0.007188 +2264 1 0.000250 1560.000000 0.001267 -0.001148 0.004247 +2265 1 0.000245 1560.000000 -0.000267 -0.001935 0.008523 +2266 1 0.000236 1560.000000 -0.002041 -0.003119 0.000466 +2267 1 0.000196 1560.000000 -0.001048 0.003580 0.004076 +2268 1 0.000253 1560.000000 0.001300 0.002994 0.009557 +2269 1 0.000221 1560.000000 -0.000053 -0.000742 0.007364 +2270 1 0.000241 1560.000000 0.000269 0.003494 0.009433 +2271 1 0.000280 1560.000000 -0.000164 -0.003377 0.004836 +2272 1 0.000206 1560.000000 -0.002120 0.001358 0.008947 +2273 1 0.000200 1560.000000 0.002728 0.001730 0.006272 +2274 1 0.000208 1560.000000 0.003142 0.001416 0.000610 +2275 1 0.000198 1560.000000 -0.001107 0.000143 0.005608 +2276 1 0.000217 1560.000000 -0.001149 0.003594 0.003457 +2277 1 0.000193 1560.000000 -0.001354 0.001623 0.009185 +2278 1 0.000212 1560.000000 -0.000876 0.000459 0.002839 +2279 1 0.000268 1560.000000 -0.000132 -0.003154 0.002698 +2280 1 0.000194 1560.000000 -0.000125 -0.002522 0.005153 +2281 1 0.000209 1560.000000 -0.003703 0.000657 0.007386 +2282 1 0.000243 1560.000000 0.001782 0.000330 0.005378 +2283 1 0.000212 1560.000000 -0.000042 0.000345 0.002023 +2284 1 0.000243 1560.000000 0.000794 0.000557 0.007949 +2285 1 0.000244 1560.000000 0.001555 -0.001163 0.008721 +2286 1 0.000271 1560.000000 -0.001025 -0.003404 0.001268 +2287 1 0.000279 1560.000000 -0.001721 -0.000129 0.004678 +2288 1 0.000196 1560.000000 -0.001292 0.003464 0.004668 +2289 1 0.000227 1560.000000 -0.003387 0.000313 0.006229 +2290 1 0.000206 1560.000000 -0.002122 0.001291 0.002124 +2291 1 0.000228 1560.000000 -0.000755 0.001988 0.009379 +2292 1 0.000249 1560.000000 -0.001318 -0.000310 0.005418 +2293 1 0.000194 1560.000000 -0.000259 0.001025 0.005272 +2294 1 0.000229 1560.000000 -0.000434 -0.000378 0.002308 +2295 1 0.000222 1560.000000 0.002015 0.003272 0.006211 +2296 1 0.000282 1560.000000 -0.001776 -0.001154 0.007841 +2297 1 0.000212 1560.000000 -0.000698 0.000457 0.004819 +2298 1 0.000279 1560.000000 0.001092 0.002934 0.004169 +2299 1 0.000244 1560.000000 0.000927 -0.001080 0.005123 +2300 1 0.000211 1560.000000 -0.002201 0.000218 0.000315 +2301 1 0.000277 1560.000000 -0.001129 -0.001292 0.004338 +2302 1 0.000249 1560.000000 -0.001140 -0.001094 0.003309 +2303 1 0.000247 1560.000000 -0.001649 -0.001383 0.003858 +2304 1 0.000208 1560.000000 0.002708 0.000266 0.007524 +2305 1 0.000256 1560.000000 0.002515 -0.000981 0.003075 +2306 1 0.000277 1560.000000 -0.001225 0.000515 0.005302 +2307 1 0.000266 1560.000000 0.001846 -0.003273 0.000816 +2308 1 0.000201 1560.000000 -0.000948 0.000856 0.005386 +2309 1 0.000236 1560.000000 0.000274 -0.001391 0.000702 +2310 1 0.000203 1560.000000 0.001509 0.000267 0.004038 +2311 1 0.000204 1560.000000 -0.002683 0.000439 0.008486 +2312 1 0.000225 1560.000000 0.002250 0.001821 0.000793 +2313 1 0.000208 1560.000000 0.002537 0.001590 0.003967 +2314 1 0.000258 1560.000000 -0.001004 -0.002259 0.005466 +2315 1 0.000204 1560.000000 0.003205 -0.000274 0.002102 +2316 1 0.000232 1560.000000 0.000606 0.003031 0.007972 +2317 1 0.000193 1560.000000 -0.001447 -0.000966 0.002857 +2318 1 0.000252 1560.000000 -0.001125 -0.002910 0.005681 +2319 1 0.000195 1560.000000 0.000668 -0.001534 0.001634 +2320 1 0.000195 1560.000000 -0.000673 0.000502 0.005493 +2321 1 0.000192 1560.000000 -0.000755 -0.000189 0.005535 +2322 1 0.000198 1560.000000 -0.000278 0.001001 0.004898 +2323 1 0.000215 1560.000000 0.000918 0.001462 0.000376 +2324 1 0.000192 1560.000000 0.000950 -0.000796 0.001278 +2325 1 0.000282 1560.000000 -0.000184 -0.002757 0.003716 +2326 1 0.000218 1560.000000 0.001798 -0.000647 0.004578 +2327 1 0.000218 1560.000000 -0.001709 -0.001505 0.001232 +2328 1 0.000201 1560.000000 -0.002057 -0.000699 0.003607 +2329 1 0.000259 1560.000000 0.001840 -0.000891 0.000596 +2330 1 0.000221 1560.000000 0.000628 0.000130 0.005144 +2331 1 0.000193 1560.000000 0.001445 0.001247 0.005282 +2332 1 0.000260 1560.000000 -0.000742 0.003274 0.001367 +2333 1 0.000219 1560.000000 0.000275 0.000166 0.005862 +2334 1 0.000240 1560.000000 -0.000017 -0.000107 0.001189 +2335 1 0.000193 1560.000000 -0.000895 -0.000031 0.005656 +2336 1 0.000211 1560.000000 -0.003564 0.000359 0.000817 +2337 1 0.000200 1560.000000 0.003650 0.000687 0.009767 +2338 1 0.000211 1560.000000 0.000514 0.001903 0.002710 +2339 1 0.000221 1560.000000 0.002787 0.000874 0.008824 +2340 1 0.000197 1560.000000 0.000920 -0.000061 0.005514 +2341 1 0.000198 1560.000000 -0.000252 0.002333 0.002501 +2342 1 0.000213 1560.000000 -0.002949 -0.000746 0.001998 +2343 1 0.000210 1560.000000 0.000220 0.002125 0.000167 +2344 1 0.000243 1560.000000 0.002084 -0.002139 0.005287 +2345 1 0.000221 1560.000000 0.001709 0.001038 0.007462 +2346 1 0.000276 1560.000000 0.001127 -0.000611 0.001021 +2347 1 0.000220 1560.000000 0.000562 0.001581 0.004507 +2348 1 0.000267 1560.000000 0.003201 0.001401 0.003566 +2349 1 0.000203 1560.000000 -0.003332 0.001077 0.000185 +2350 1 0.000247 1560.000000 -0.000752 0.001138 0.004461 +2351 1 0.000267 1560.000000 -0.001883 0.000907 0.000969 +2352 1 0.000248 1560.000000 0.001329 -0.001091 0.000962 +2353 1 0.000214 1560.000000 -0.000529 0.001729 0.007191 +2354 1 0.000279 1560.000000 0.000606 -0.000643 0.002265 +2355 1 0.000194 1560.000000 0.001007 0.001755 0.001625 +2356 1 0.000230 1560.000000 -0.003579 0.000632 0.004604 +2357 1 0.000211 1560.000000 -0.001197 -0.000670 0.001976 +2358 1 0.000233 1560.000000 0.001476 0.000017 0.002899 +2359 1 0.000211 1560.000000 0.000935 0.002800 0.005109 +2360 1 0.000248 1560.000000 -0.001261 0.001332 0.000804 +2361 1 0.000244 1560.000000 -0.002641 0.000894 0.003591 +2362 1 0.000199 1560.000000 -0.000842 -0.002169 0.004751 +2363 1 0.000207 1560.000000 0.001295 -0.000177 0.000403 +2364 1 0.000209 1560.000000 -0.000616 -0.000352 0.008985 +2365 1 0.000199 1560.000000 -0.002158 -0.001212 0.001471 +2366 1 0.000199 1560.000000 -0.003308 0.001022 0.005387 +2367 1 0.000218 1560.000000 -0.001962 0.001960 0.001549 +2368 1 0.000207 1560.000000 0.000470 -0.000397 0.004988 +2369 1 0.000200 1560.000000 0.001181 -0.002052 0.009136 +2370 1 0.000218 1560.000000 0.001638 -0.000145 0.002882 +2371 1 0.000193 1560.000000 -0.003617 -0.000829 0.006062 +2372 1 0.000237 1560.000000 -0.000047 -0.001636 0.001416 +2373 1 0.000216 1560.000000 0.002188 -0.002307 0.008943 +2374 1 0.000228 1560.000000 -0.001821 0.002589 0.006060 +2375 1 0.000205 1560.000000 -0.001379 -0.003109 0.009049 +2376 1 0.000212 1560.000000 0.000449 0.001306 0.002821 +2377 1 0.000229 1560.000000 -0.003452 0.000151 0.000318 +2378 1 0.000219 1560.000000 0.000507 -0.001773 0.003989 +2379 1 0.000245 1560.000000 0.000425 0.002681 0.000280 +2380 1 0.000285 1560.000000 0.000533 0.001397 0.007239 +2381 1 0.000244 1560.000000 0.000948 -0.002915 0.007008 +2382 1 0.000203 1560.000000 -0.000579 -0.002655 0.009459 +2383 1 0.000232 1560.000000 -0.000230 -0.001961 0.007423 +2384 1 0.000221 1560.000000 -0.002720 0.000019 0.004548 +2385 1 0.000202 1560.000000 -0.002201 -0.000037 0.005825 +2386 1 0.000195 1560.000000 0.000797 0.000334 0.000526 +2387 1 0.000241 1560.000000 -0.001025 0.002711 0.008299 +2388 1 0.000208 1560.000000 0.002025 0.001482 0.007815 +2389 1 0.000203 1560.000000 0.000457 0.002278 0.006995 +2390 1 0.000240 1560.000000 0.000584 0.000386 0.006437 +2391 1 0.000212 1560.000000 0.001024 0.002682 0.002112 +2392 1 0.000201 1560.000000 -0.003031 0.000776 0.003798 +2393 1 0.000236 1560.000000 0.002672 -0.001437 0.006717 +2394 1 0.000199 1560.000000 0.002662 0.001432 0.008768 +2395 1 0.000219 1560.000000 -0.001207 -0.000829 0.002202 +2396 1 0.000258 1560.000000 0.002204 0.001136 0.005226 +2397 1 0.000229 1560.000000 0.001595 -0.003308 0.000394 +2398 1 0.000241 1560.000000 -0.001427 0.002482 0.007651 +2399 1 0.000287 1560.000000 0.000389 -0.001263 0.008293 +2400 1 0.000203 1560.000000 -0.001475 0.001370 0.009073 +2401 1 0.000236 1560.000000 0.001654 0.001014 0.008604 +2402 1 0.000261 1560.000000 -0.001539 -0.001603 0.003104 +2403 1 0.000273 1560.000000 0.000280 0.001006 0.007853 +2404 1 0.000198 1560.000000 0.000478 0.002988 0.002787 +2405 1 0.000229 1560.000000 0.002019 0.001918 0.001805 +2406 1 0.000193 1560.000000 -0.001870 -0.000950 0.005204 +2407 1 0.000206 1560.000000 0.000049 -0.001180 0.008462 +2408 1 0.000254 1560.000000 0.001248 0.000059 0.001372 +2409 1 0.000242 1560.000000 -0.002083 -0.001410 0.004654 +2410 1 0.000238 1560.000000 -0.001004 -0.000215 0.001568 +2411 1 0.000250 1560.000000 0.000063 -0.002820 0.000154 +2412 1 0.000208 1560.000000 -0.000398 -0.000952 0.009773 +2413 1 0.000204 1560.000000 -0.000154 -0.000166 0.009053 +2414 1 0.000200 1560.000000 -0.002175 -0.001903 0.001660 +2415 1 0.000206 1560.000000 0.001531 0.000642 0.003950 +2416 1 0.000285 1560.000000 -0.001644 0.000974 0.006246 +2417 1 0.000227 1560.000000 -0.001563 0.001613 0.000907 +2418 1 0.000260 1560.000000 0.001419 -0.001296 0.005970 +2419 1 0.000235 1560.000000 -0.001983 -0.002555 0.003328 +2420 1 0.000269 1560.000000 -0.000502 0.002561 0.001876 +2421 1 0.000230 1560.000000 0.002280 -0.000631 0.009467 +2422 1 0.000242 1560.000000 -0.000458 -0.000267 0.008234 +2423 1 0.000213 1560.000000 0.000263 -0.001074 0.001214 +2424 1 0.000243 1560.000000 0.002745 0.001222 0.008826 +2425 1 0.000278 1560.000000 0.001045 0.003507 0.005145 +2426 1 0.000200 1560.000000 0.000332 -0.001473 0.009187 +2427 1 0.000235 1560.000000 0.000276 -0.000323 0.005810 +2428 1 0.000268 1560.000000 -0.000034 -0.002022 0.003967 +2429 1 0.000249 1560.000000 0.000625 -0.001495 0.002934 +2430 1 0.000243 1560.000000 0.001038 0.002246 0.003247 +2431 1 0.000210 1560.000000 -0.002780 0.001871 0.007148 +2432 1 0.000206 1560.000000 0.000387 0.002002 0.004234 +2433 1 0.000237 1560.000000 0.000621 0.000804 0.003973 +2434 1 0.000240 1560.000000 0.000584 0.002472 0.009345 +2435 1 0.000270 1560.000000 -0.002195 0.000986 0.000667 +2436 1 0.000234 1560.000000 0.000539 0.000568 0.008569 +2437 1 0.000288 1560.000000 0.001260 -0.002349 0.001468 +2438 1 0.000221 1560.000000 0.000455 -0.000560 0.006566 +2439 1 0.000203 1560.000000 -0.001308 -0.002453 0.001270 +2440 1 0.000228 1560.000000 0.001556 0.001223 0.009484 +2441 1 0.000197 1560.000000 -0.000073 -0.001530 0.009608 +2442 1 0.000250 1560.000000 0.000621 0.000288 0.002474 +2443 1 0.000249 1560.000000 -0.002248 -0.002119 0.003637 +2444 1 0.000198 1560.000000 -0.001867 -0.000234 0.005309 +2445 1 0.000200 1560.000000 -0.000923 0.002392 0.009807 +2446 1 0.000210 1560.000000 0.003260 0.000237 0.002349 +2447 1 0.000263 1560.000000 0.002474 -0.000540 0.003910 +2448 1 0.000225 1560.000000 -0.002231 0.000739 0.001312 +2449 1 0.000202 1560.000000 -0.000968 -0.000564 0.002883 +2450 1 0.000220 1560.000000 -0.002257 -0.003049 0.007786 +2451 1 0.000221 1560.000000 0.001164 -0.001606 0.006327 +2452 1 0.000261 1560.000000 0.000430 0.000994 0.008666 +2453 1 0.000202 1560.000000 -0.001120 0.000846 0.001726 +2454 1 0.000195 1560.000000 0.002698 0.000072 0.000758 +2455 1 0.000282 1560.000000 -0.000127 -0.001997 0.005438 +2456 1 0.000241 1560.000000 0.000474 -0.001376 0.008653 +2457 1 0.000217 1560.000000 0.000230 0.001976 0.003796 +2458 1 0.000262 1560.000000 -0.001293 0.001326 0.001636 +2459 1 0.000245 1560.000000 0.000030 -0.000375 0.004983 +2460 1 0.000257 1560.000000 -0.002384 -0.001437 0.001667 +2461 1 0.000242 1560.000000 0.001156 0.002776 0.003036 +2462 1 0.000219 1560.000000 -0.002243 -0.000069 0.008274 +2463 1 0.000256 1560.000000 0.000372 0.000586 0.007459 +2464 1 0.000196 1560.000000 -0.000230 0.000220 0.001440 +2465 1 0.000196 1560.000000 0.002524 0.000097 0.007978 +2466 1 0.000199 1560.000000 -0.000757 0.000875 0.006647 +2467 1 0.000272 1560.000000 0.001250 -0.000367 0.002852 +2468 1 0.000217 1560.000000 0.000071 0.000985 0.004344 +2469 1 0.000219 1560.000000 -0.003776 -0.000649 0.005906 +2470 1 0.000277 1560.000000 -0.001429 0.001085 0.004559 +2471 1 0.000204 1560.000000 0.000121 -0.000478 0.004354 +2472 1 0.000193 1560.000000 -0.001374 0.001658 0.005720 +2473 1 0.000225 1560.000000 0.002582 0.001487 0.008274 +2474 1 0.000217 1560.000000 0.003384 0.000589 0.000843 +2475 1 0.000216 1560.000000 0.003230 -0.000610 0.008336 +2476 1 0.000243 1560.000000 -0.001288 -0.002867 0.009589 +2477 1 0.000219 1560.000000 0.001539 -0.000641 0.006368 +2478 1 0.000248 1560.000000 0.002640 -0.002103 0.007497 +2479 1 0.000248 1560.000000 0.000614 -0.003395 0.005644 +2480 1 0.000224 1560.000000 0.001506 -0.001372 0.007686 +2481 1 0.000241 1560.000000 -0.001556 0.001980 0.003756 +2482 1 0.000283 1560.000000 0.001937 -0.002710 0.002811 +2483 1 0.000207 1560.000000 0.002957 -0.000338 0.003686 +2484 1 0.000247 1560.000000 -0.000920 0.000064 0.006449 +2485 1 0.000237 1560.000000 -0.000734 -0.000104 0.005803 +2486 1 0.000256 1560.000000 -0.000477 -0.000962 0.004771 +2487 1 0.000196 1560.000000 -0.002911 -0.000939 0.004428 +2488 1 0.000243 1560.000000 0.000541 0.002814 0.001969 +2489 1 0.000221 1560.000000 -0.001592 -0.003241 0.005844 +2490 1 0.000193 1560.000000 -0.000209 -0.002163 0.005000 +2491 1 0.000240 1560.000000 0.001962 0.001135 0.001669 +2492 1 0.000194 1560.000000 0.000431 -0.000911 0.006206 +2493 1 0.000193 1560.000000 0.002090 -0.000775 0.004245 +2494 1 0.000250 1560.000000 -0.002090 -0.000699 0.003926 +2495 1 0.000202 1560.000000 0.000398 -0.001807 0.003706 +2496 1 0.000229 1560.000000 -0.000923 0.003554 0.004640 +2497 1 0.000234 1560.000000 -0.003036 0.001149 0.009451 +2498 1 0.000223 1560.000000 -0.003062 0.000433 0.006150 +2499 1 0.000216 1560.000000 -0.003710 -0.000000 0.007145 +2500 1 0.000247 1560.000000 0.001209 0.001323 0.002469 +2501 1 0.000262 1560.000000 -0.003136 -0.002219 0.007436 +2502 1 0.000193 1560.000000 0.000951 0.000641 0.009125 +2503 1 0.000288 1560.000000 -0.002778 0.001808 0.008411 +2504 1 0.000277 1560.000000 0.002271 0.001038 0.003536 +2505 1 0.000233 1560.000000 0.000596 0.002335 0.003279 +2506 1 0.000202 1560.000000 0.001653 0.001857 0.009532 +2507 1 0.000200 1560.000000 0.000324 0.001448 0.001201 +2508 1 0.000265 1560.000000 0.001776 -0.000864 0.003204 +2509 1 0.000210 1560.000000 -0.000943 -0.001941 0.008788 +2510 1 0.000260 1560.000000 0.001232 -0.000557 0.005198 +2511 1 0.000200 1560.000000 -0.000334 0.000767 0.000438 +2512 1 0.000202 1560.000000 0.000704 -0.001902 0.002543 +2513 1 0.000234 1560.000000 0.001063 -0.002123 0.005332 +2514 1 0.000210 1560.000000 -0.003080 0.001425 0.004137 +2515 1 0.000202 1560.000000 -0.001184 -0.000766 0.001682 +2516 1 0.000254 1560.000000 -0.000826 -0.002559 0.002011 +2517 1 0.000212 1560.000000 -0.000292 0.000420 0.005080 +2518 1 0.000274 1560.000000 -0.000298 -0.002174 0.002234 +2519 1 0.000201 1560.000000 0.001535 0.000041 0.000612 +2520 1 0.000244 1560.000000 0.001269 0.003365 0.003233 +2521 1 0.000257 1560.000000 0.001467 -0.002569 0.002782 +2522 1 0.000281 1560.000000 -0.000604 -0.001040 0.002538 +2523 1 0.000192 1560.000000 -0.000185 -0.002672 0.007365 +2524 1 0.000205 1560.000000 0.001777 0.002701 0.001769 +2525 1 0.000256 1560.000000 -0.000839 -0.003077 0.001507 +2526 1 0.000282 1560.000000 0.001656 0.001437 0.005555 +2527 1 0.000212 1560.000000 -0.001920 0.001608 0.003298 +2528 1 0.000252 1560.000000 -0.001575 -0.002940 0.004577 +2529 1 0.000262 1560.000000 0.003513 0.000341 0.001297 +2530 1 0.000240 1560.000000 -0.000322 0.003260 0.001577 +2531 1 0.000251 1560.000000 -0.001452 -0.003491 0.002486 +2532 1 0.000233 1560.000000 0.002088 0.001469 0.007167 +2533 1 0.000262 1560.000000 -0.002406 -0.000569 0.008235 +2534 1 0.000201 1560.000000 -0.002982 0.000143 0.003954 +2535 1 0.000267 1560.000000 -0.002563 -0.002115 0.009693 +2536 1 0.000194 1560.000000 0.001008 0.000485 0.007057 +2537 1 0.000239 1560.000000 -0.002191 -0.000262 0.001368 +2538 1 0.000225 1560.000000 -0.001403 -0.001357 0.004621 +2539 1 0.000223 1560.000000 -0.000499 -0.000026 0.004798 +2540 1 0.000221 1560.000000 0.001925 0.002195 0.005189 +2541 1 0.000204 1560.000000 0.000515 0.001714 0.005922 +2542 1 0.000254 1560.000000 0.001136 -0.002289 0.004137 +2543 1 0.000248 1560.000000 0.000200 -0.001610 0.008693 +2544 1 0.000254 1560.000000 -0.001746 0.002081 0.007026 +2545 1 0.000235 1560.000000 -0.000298 -0.001531 0.004287 +2546 1 0.000220 1560.000000 -0.001225 0.000219 0.004221 +2547 1 0.000277 1560.000000 0.002964 0.000536 0.006649 +2548 1 0.000247 1560.000000 -0.001619 -0.001168 0.001766 +2549 1 0.000255 1560.000000 0.003789 -0.000212 0.006611 +2550 1 0.000213 1560.000000 -0.003590 0.000468 0.009000 +2551 1 0.000201 1560.000000 0.002815 0.000626 0.001918 +2552 1 0.000281 1560.000000 0.000920 0.000484 0.003108 +2553 1 0.000197 1560.000000 0.000399 0.001922 0.001967 +2554 1 0.000274 1560.000000 -0.000108 0.000482 0.007819 +2555 1 0.000232 1560.000000 0.001519 -0.000684 0.003837 +2556 1 0.000278 1560.000000 -0.000620 -0.001757 0.004060 +2557 1 0.000222 1560.000000 -0.001460 0.001258 0.008542 +2558 1 0.000232 1560.000000 -0.000826 -0.003418 0.009394 +2559 1 0.000212 1560.000000 -0.003213 -0.001159 0.004540 +2560 1 0.000198 1560.000000 0.000163 0.002201 0.004195 +2561 1 0.000205 1560.000000 -0.001127 0.000614 0.005526 +2562 1 0.000199 1560.000000 0.000171 0.001116 0.008934 +2563 1 0.000210 1560.000000 -0.002503 -0.002567 0.004371 +2564 1 0.000247 1560.000000 0.002064 0.000814 0.009769 +2565 1 0.000194 1560.000000 0.000836 0.002584 0.002636 +2566 1 0.000193 1560.000000 0.001900 -0.001556 0.006771 +2567 1 0.000193 1560.000000 0.001001 0.001805 0.003258 +2568 1 0.000260 1560.000000 0.001070 -0.002628 0.008598 +2569 1 0.000199 1560.000000 0.002320 0.001592 0.001085 +2570 1 0.000236 1560.000000 0.000865 0.002357 0.000980 +2571 1 0.000271 1560.000000 0.000393 0.003150 0.002621 +2572 1 0.000228 1560.000000 -0.002774 -0.000358 0.009478 +2573 1 0.000261 1560.000000 0.001971 -0.001906 0.009718 +2574 1 0.000224 1560.000000 -0.000056 -0.002886 0.009101 +2575 1 0.000233 1560.000000 0.000753 0.003541 0.007703 +2576 1 0.000249 1560.000000 0.000082 -0.000767 0.006645 +2577 1 0.000227 1560.000000 0.002059 -0.001741 0.000903 +2578 1 0.000234 1560.000000 0.001151 0.001713 0.006966 +2579 1 0.000263 1560.000000 0.002088 0.000599 0.005184 +2580 1 0.000228 1560.000000 0.001116 0.001789 0.004050 +2581 1 0.000199 1560.000000 0.000283 -0.003260 0.004453 +2582 1 0.000232 1560.000000 0.001087 -0.002753 0.004430 +2583 1 0.000194 1560.000000 0.003375 0.001422 0.009388 +2584 1 0.000241 1560.000000 -0.000365 -0.002775 0.003094 +2585 1 0.000220 1560.000000 0.001544 -0.000224 0.006845 +2586 1 0.000228 1560.000000 0.000433 -0.000485 0.009149 +2587 1 0.000216 1560.000000 0.001706 0.001639 0.007115 +2588 1 0.000204 1560.000000 0.002048 -0.001737 0.003719 +2589 1 0.000223 1560.000000 0.000694 0.000778 0.005921 +2590 1 0.000225 1560.000000 -0.001541 -0.000234 0.004028 +2591 1 0.000198 1560.000000 0.002221 0.001621 0.000679 +2592 1 0.000241 1560.000000 -0.000536 0.001951 0.005150 +2593 1 0.000217 1560.000000 -0.000926 0.001803 0.003357 +2594 1 0.000218 1560.000000 0.000309 -0.001097 0.003082 +2595 1 0.000209 1560.000000 0.000454 -0.000354 0.006352 +2596 1 0.000199 1560.000000 0.001329 -0.000045 0.003118 +2597 1 0.000251 1560.000000 -0.000649 -0.000705 0.002166 +2598 1 0.000219 1560.000000 0.001707 -0.001604 0.007267 +2599 1 0.000267 1560.000000 -0.000205 -0.000557 0.007825 +2600 1 0.000239 1560.000000 0.003150 -0.002103 0.002204 +2601 1 0.000221 1560.000000 -0.002656 -0.001247 0.009482 +2602 1 0.000215 1560.000000 0.000796 -0.000510 0.002878 +2603 1 0.000262 1560.000000 0.000364 0.001858 0.003561 +2604 1 0.000279 1560.000000 -0.000307 0.000583 0.005345 +2605 1 0.000261 1560.000000 -0.002853 0.001555 0.001731 +2606 1 0.000231 1560.000000 0.001462 -0.002403 0.006182 +2607 1 0.000254 1560.000000 0.000990 -0.000442 0.000154 +2608 1 0.000238 1560.000000 0.000806 0.003460 0.008447 +2609 1 0.000220 1560.000000 -0.002554 -0.000229 0.000489 +2610 1 0.000246 1560.000000 0.001561 0.002983 0.007730 +2611 1 0.000241 1560.000000 -0.000893 -0.001113 0.007954 +2612 1 0.000285 1560.000000 0.000855 0.001135 0.004298 +2613 1 0.000221 1560.000000 -0.001036 -0.000063 0.000566 +2614 1 0.000248 1560.000000 0.001318 -0.001385 0.003296 +2615 1 0.000227 1560.000000 -0.002191 0.002702 0.007385 +2616 1 0.000199 1560.000000 -0.002489 -0.000830 0.001664 +2617 1 0.000260 1560.000000 -0.002445 0.000507 0.003373 +2618 1 0.000218 1560.000000 0.002583 -0.000130 0.004140 +2619 1 0.000195 1560.000000 0.000508 0.001797 0.006561 +2620 1 0.000205 1560.000000 -0.001467 0.000555 0.007332 +2621 1 0.000282 1560.000000 0.003230 -0.000377 0.008834 +2622 1 0.000234 1560.000000 -0.001405 -0.000905 0.005179 +2623 1 0.000231 1560.000000 -0.003617 -0.000113 0.002426 +2624 1 0.000220 1560.000000 0.001406 -0.001070 0.009606 +2625 1 0.000248 1560.000000 -0.003237 0.001721 0.004445 +2626 1 0.000222 1560.000000 0.000139 0.000376 0.006023 +2627 1 0.000210 1560.000000 -0.001702 -0.001712 0.001709 +2628 1 0.000217 1560.000000 0.000389 0.001807 0.008580 +2629 1 0.000195 1560.000000 0.002108 -0.000170 0.000527 +2630 1 0.000241 1560.000000 0.001225 0.001244 0.007346 +2631 1 0.000233 1560.000000 0.001582 0.002660 0.003319 +2632 1 0.000223 1560.000000 0.000759 -0.003671 0.007909 +2633 1 0.000213 1560.000000 -0.001171 0.000518 0.001611 +2634 1 0.000219 1560.000000 -0.002372 -0.002776 0.004137 +2635 1 0.000269 1560.000000 -0.001238 0.001354 0.005914 +2636 1 0.000260 1560.000000 0.002077 -0.000698 0.003905 +2637 1 0.000210 1560.000000 -0.001556 -0.002934 0.005560 +2638 1 0.000229 1560.000000 -0.001822 0.001821 0.007082 +2639 1 0.000217 1560.000000 -0.002994 -0.002003 0.001004 +2640 1 0.000197 1560.000000 0.002243 0.001642 0.003956 +2641 1 0.000256 1560.000000 0.002094 -0.002083 0.001629 +2642 1 0.000202 1560.000000 0.001377 0.002660 0.003418 +2643 1 0.000253 1560.000000 0.000785 0.000192 0.005534 +2644 1 0.000225 1560.000000 -0.001677 -0.002548 0.008477 +2645 1 0.000225 1560.000000 0.003747 0.000909 0.007176 +2646 1 0.000257 1560.000000 -0.002019 -0.000549 0.005653 +2647 1 0.000207 1560.000000 0.001439 0.000582 0.007508 +2648 1 0.000217 1560.000000 0.000957 -0.001754 0.002801 +2649 1 0.000251 1560.000000 0.001406 0.000005 0.002034 +2650 1 0.000256 1560.000000 -0.001824 0.001969 0.005180 +2651 1 0.000201 1560.000000 0.003335 0.000929 0.001425 +2652 1 0.000200 1560.000000 -0.000986 0.000234 0.001537 +2653 1 0.000233 1560.000000 0.002812 -0.000645 0.005473 +2654 1 0.000228 1560.000000 0.000713 -0.001858 0.004100 +2655 1 0.000222 1560.000000 0.000378 0.001919 0.006836 +2656 1 0.000202 1560.000000 0.002467 -0.000362 0.009798 +2657 1 0.000263 1560.000000 -0.002491 0.001710 0.005019 +2658 1 0.000192 1560.000000 0.000856 -0.003629 0.003074 +2659 1 0.000227 1560.000000 -0.000693 0.002167 0.007082 +2660 1 0.000253 1560.000000 0.000726 -0.001802 0.009622 +2661 1 0.000225 1560.000000 0.003405 -0.000903 0.003320 +2662 1 0.000274 1560.000000 -0.000513 0.002120 0.000530 +2663 1 0.000211 1560.000000 -0.003065 -0.000989 0.002911 +2664 1 0.000255 1560.000000 0.000810 0.001246 0.008255 +2665 1 0.000278 1560.000000 0.002061 0.002730 0.001167 +2666 1 0.000280 1560.000000 -0.002257 0.002639 0.009278 +2667 1 0.000201 1560.000000 0.001059 0.003630 0.001179 +2668 1 0.000255 1560.000000 0.000171 -0.000420 0.003016 +2669 1 0.000230 1560.000000 -0.001811 0.003214 0.003304 +2670 1 0.000217 1560.000000 0.000953 0.000877 0.000564 +2671 1 0.000203 1560.000000 0.001187 0.003582 0.001384 +2672 1 0.000200 1560.000000 0.000210 -0.000626 0.006153 +2673 1 0.000219 1560.000000 0.002070 0.002627 0.007113 +2674 1 0.000227 1560.000000 -0.002211 0.002308 0.007621 +2675 1 0.000247 1560.000000 -0.003217 -0.001344 0.002176 +2676 1 0.000204 1560.000000 0.000376 0.002312 0.009194 +2677 1 0.000239 1560.000000 0.001085 -0.000451 0.005489 +2678 1 0.000213 1560.000000 0.000510 0.002940 0.006799 +2679 1 0.000216 1560.000000 -0.001517 0.002201 0.005758 +2680 1 0.000229 1560.000000 0.001740 0.001273 0.008264 +2681 1 0.000221 1560.000000 -0.001828 0.000448 0.004761 +2682 1 0.000193 1560.000000 0.001239 -0.000217 0.008481 +2683 1 0.000287 1560.000000 -0.000865 -0.001783 0.006388 +2684 1 0.000248 1560.000000 -0.000600 -0.001094 0.006734 +2685 1 0.000257 1560.000000 0.001325 -0.003349 0.001759 +2686 1 0.000209 1560.000000 0.003670 0.000232 0.002477 +2687 1 0.000252 1560.000000 -0.003379 -0.000288 0.003069 +2688 1 0.000275 1560.000000 -0.000069 -0.000918 0.006264 +2689 1 0.000225 1560.000000 -0.001404 -0.002021 0.006453 +2690 1 0.000259 1560.000000 0.000075 -0.003490 0.005602 +2691 1 0.000195 1560.000000 -0.002539 0.001619 0.003657 +2692 1 0.000269 1560.000000 -0.000730 0.000152 0.004527 +2693 1 0.000246 1560.000000 0.000418 -0.001243 0.005291 +2694 1 0.000194 1560.000000 -0.003391 -0.001467 0.005705 +2695 1 0.000237 1560.000000 -0.003483 0.000328 0.002622 +2696 1 0.000217 1560.000000 0.000154 -0.002666 0.005321 +2697 1 0.000211 1560.000000 -0.000752 -0.000644 0.005898 +2698 1 0.000274 1560.000000 0.003594 -0.000192 0.000629 +2699 1 0.000227 1560.000000 -0.003684 0.000775 0.003893 +2700 1 0.000200 1560.000000 0.000770 0.003702 0.004080 +2701 1 0.000199 1560.000000 -0.002287 -0.001705 0.006695 +2702 1 0.000215 1560.000000 -0.000003 0.003726 0.002154 +2703 1 0.000196 1560.000000 0.000925 -0.002904 0.001800 +2704 1 0.000197 1560.000000 -0.001492 0.000400 0.004351 +2705 1 0.000240 1560.000000 0.000032 -0.001586 0.009318 +2706 1 0.000268 1560.000000 -0.003115 -0.000141 0.004633 +2707 1 0.000215 1560.000000 -0.002167 0.002826 0.002347 +2708 1 0.000217 1560.000000 -0.003063 0.001678 0.000364 +2709 1 0.000252 1560.000000 0.002501 0.002058 0.004890 +2710 1 0.000199 1560.000000 0.002486 0.000718 0.004780 +2711 1 0.000271 1560.000000 0.000971 -0.002945 0.003773 +2712 1 0.000285 1560.000000 0.002429 0.001859 0.003602 +2713 1 0.000256 1560.000000 0.001885 -0.000446 0.002841 +2714 1 0.000236 1560.000000 0.000879 -0.000566 0.006567 +2715 1 0.000238 1560.000000 -0.000306 -0.000151 0.005573 +2716 1 0.000235 1560.000000 -0.001692 -0.002617 0.000148 +2717 1 0.000235 1560.000000 -0.000390 -0.003586 0.004343 +2718 1 0.000192 1560.000000 -0.000795 0.000961 0.005788 +2719 1 0.000211 1560.000000 0.002824 -0.001809 0.005517 +2720 1 0.000234 1560.000000 -0.000004 -0.002101 0.004574 +2721 1 0.000202 1560.000000 0.001276 -0.001049 0.002993 +2722 1 0.000285 1560.000000 -0.003309 -0.000637 0.000981 +2723 1 0.000196 1560.000000 0.001748 0.000288 0.003832 +2724 1 0.000283 1560.000000 0.000040 0.003336 0.004579 +2725 1 0.000272 1560.000000 -0.001654 0.000194 0.000682 +2726 1 0.000236 1560.000000 -0.000060 -0.003795 0.001482 +2727 1 0.000199 1560.000000 0.001604 -0.000588 0.001857 +2728 1 0.000203 1560.000000 -0.002148 0.001857 0.008691 +2729 1 0.000200 1560.000000 -0.000856 -0.001232 0.009578 +2730 1 0.000223 1560.000000 -0.000463 -0.001564 0.005538 +2731 1 0.000204 1560.000000 -0.003151 0.002022 0.008034 +2732 1 0.000197 1560.000000 -0.000689 -0.000546 0.006661 +2733 1 0.000198 1560.000000 0.002583 -0.000449 0.002299 +2734 1 0.000198 1560.000000 0.000450 -0.001446 0.005707 +2735 1 0.000207 1560.000000 0.003209 0.000214 0.007597 +2736 1 0.000284 1560.000000 -0.001783 -0.001317 0.004397 +2737 1 0.000242 1560.000000 0.000031 0.000531 0.000270 +2738 1 0.000194 1560.000000 0.001235 0.000189 0.001874 +2739 1 0.000244 1560.000000 -0.001078 0.000484 0.006234 +2740 1 0.000208 1560.000000 -0.000315 -0.002907 0.001634 +2741 1 0.000212 1560.000000 -0.000067 -0.000444 0.005913 +2742 1 0.000231 1560.000000 0.000931 -0.000713 0.008435 +2743 1 0.000282 1560.000000 -0.000883 -0.000471 0.004288 +2744 1 0.000199 1560.000000 0.000751 0.000011 0.000312 +2745 1 0.000193 1560.000000 0.002608 0.002224 0.007370 +2746 1 0.000219 1560.000000 -0.000035 -0.003165 0.004653 +2747 1 0.000198 1560.000000 0.000043 0.001393 0.001174 +2748 1 0.000231 1560.000000 0.001370 -0.003074 0.001389 +2749 1 0.000274 1560.000000 -0.000051 -0.003303 0.000409 +2750 1 0.000252 1560.000000 0.000485 -0.000768 0.008414 +2751 1 0.000234 1560.000000 0.001360 0.002741 0.002443 +2752 1 0.000231 1560.000000 0.000079 0.003601 0.006360 +2753 1 0.000267 1560.000000 0.000124 0.000071 0.004519 +2754 1 0.000276 1560.000000 0.003053 -0.000112 0.008010 +2755 1 0.000251 1560.000000 0.001764 0.001721 0.002353 +2756 1 0.000204 1560.000000 -0.002780 -0.000368 0.000657 +2757 1 0.000196 1560.000000 0.001395 -0.000888 0.007140 +2758 1 0.000266 1560.000000 0.000173 -0.000853 0.005007 +2759 1 0.000210 1560.000000 0.002847 -0.000741 0.007664 +2760 1 0.000217 1560.000000 -0.001367 0.000129 0.006018 +2761 1 0.000194 1560.000000 0.002302 -0.001152 0.000500 +2762 1 0.000242 1560.000000 -0.000479 -0.001075 0.003446 +2763 1 0.000199 1560.000000 -0.000187 -0.000448 0.001856 +2764 1 0.000194 1560.000000 0.001200 0.000017 0.006036 +2765 1 0.000217 1560.000000 -0.000212 0.002937 0.008486 +2766 1 0.000246 1560.000000 0.002354 -0.001907 0.000310 +2767 1 0.000275 1560.000000 0.002701 0.001278 0.008387 +2768 1 0.000209 1560.000000 0.000124 0.000871 0.005648 +2769 1 0.000224 1560.000000 -0.002075 0.000000 0.009286 +2770 1 0.000274 1560.000000 -0.000701 0.000949 0.005127 +2771 1 0.000198 1560.000000 0.000754 -0.000904 0.008142 +2772 1 0.000252 1560.000000 0.001889 0.000435 0.000670 +2773 1 0.000201 1560.000000 0.000015 0.001002 0.000775 +2774 1 0.000242 1560.000000 0.002765 0.001176 0.003741 +2775 1 0.000208 1560.000000 -0.000523 0.003747 0.006331 +2776 1 0.000243 1560.000000 -0.003159 -0.001012 0.006164 +2777 1 0.000205 1560.000000 0.003028 -0.002249 0.004054 +2778 1 0.000237 1560.000000 -0.001451 0.002720 0.007522 +2779 1 0.000252 1560.000000 -0.000944 -0.002332 0.007587 +2780 1 0.000212 1560.000000 -0.001809 -0.002589 0.009290 +2781 1 0.000285 1560.000000 0.000767 0.001591 0.007620 +2782 1 0.000208 1560.000000 -0.001914 0.002982 0.009019 +2783 1 0.000209 1560.000000 -0.002359 -0.001777 0.002317 +2784 1 0.000258 1560.000000 0.001916 -0.002094 0.007278 +2785 1 0.000230 1560.000000 -0.001430 -0.001437 0.005730 +2786 1 0.000243 1560.000000 -0.000721 -0.001729 0.001083 +2787 1 0.000248 1560.000000 -0.001132 -0.000571 0.006348 +2788 1 0.000210 1560.000000 -0.000849 0.002806 0.006987 +2789 1 0.000211 1560.000000 -0.001651 0.001905 0.000445 +2790 1 0.000205 1560.000000 0.003508 0.000161 0.000842 +2791 1 0.000223 1560.000000 -0.001403 0.000889 0.006878 +2792 1 0.000199 1560.000000 0.003646 0.000122 0.004051 +2793 1 0.000250 1560.000000 0.002454 -0.002217 0.006294 +2794 1 0.000192 1560.000000 -0.002819 -0.002402 0.006313 +2795 1 0.000250 1560.000000 -0.001854 0.003279 0.001929 +2796 1 0.000204 1560.000000 -0.000421 -0.002690 0.006674 +2797 1 0.000288 1560.000000 0.000800 -0.000465 0.004977 +2798 1 0.000243 1560.000000 -0.002772 -0.001637 0.008410 +2799 1 0.000196 1560.000000 -0.001736 0.002310 0.006879 +2800 1 0.000206 1560.000000 -0.002465 -0.002723 0.001325 +2801 1 0.000224 1560.000000 0.001607 0.001681 0.004393 +2802 1 0.000223 1560.000000 0.002667 -0.000881 0.005078 +2803 1 0.000279 1560.000000 -0.001146 -0.000408 0.009751 +2804 1 0.000249 1560.000000 -0.000257 0.001105 0.001954 +2805 1 0.000226 1560.000000 0.000887 -0.001316 0.000903 +2806 1 0.000276 1560.000000 0.000975 0.002533 0.007317 +2807 1 0.000219 1560.000000 -0.002337 0.000371 0.008021 +2808 1 0.000251 1560.000000 0.001725 -0.001840 0.005729 +2809 1 0.000212 1560.000000 0.001476 0.002007 0.007961 +2810 1 0.000206 1560.000000 0.002909 -0.000088 0.002465 +2811 1 0.000201 1560.000000 -0.000850 -0.002716 0.003170 +2812 1 0.000258 1560.000000 0.002276 0.001621 0.006041 +2813 1 0.000222 1560.000000 -0.001207 0.000951 0.004511 +2814 1 0.000270 1560.000000 -0.000599 -0.001610 0.009284 +2815 1 0.000252 1560.000000 0.001177 0.003266 0.006969 +2816 1 0.000265 1560.000000 0.001765 0.001083 0.000380 +2817 1 0.000229 1560.000000 -0.000752 0.003511 0.007693 +2818 1 0.000225 1560.000000 -0.003203 -0.000496 0.007516 +2819 1 0.000207 1560.000000 -0.001437 0.002313 0.001341 +2820 1 0.000248 1560.000000 0.002427 -0.001580 0.001848 +2821 1 0.000242 1560.000000 -0.000186 -0.000068 0.007093 +2822 1 0.000215 1560.000000 -0.000899 -0.001826 0.005126 +2823 1 0.000240 1560.000000 0.001058 -0.000746 0.007082 +2824 1 0.000272 1560.000000 -0.000722 0.001255 0.002063 +2825 1 0.000227 1560.000000 -0.002372 0.000140 0.008803 +2826 1 0.000207 1560.000000 0.002682 0.000012 0.000324 +2827 1 0.000267 1560.000000 -0.001397 -0.002014 0.005418 +2828 1 0.000241 1560.000000 -0.000813 -0.000324 0.006659 +2829 1 0.000202 1560.000000 0.003767 -0.000067 0.005271 +2830 1 0.000240 1560.000000 0.002886 -0.000921 0.009482 +2831 1 0.000238 1560.000000 -0.000976 -0.001662 0.004329 +2832 1 0.000266 1560.000000 0.000596 -0.003775 0.003537 +2833 1 0.000245 1560.000000 -0.000406 0.001022 0.006892 +2834 1 0.000208 1560.000000 0.002557 -0.002459 0.002835 +2835 1 0.000267 1560.000000 0.000530 0.000640 0.005527 +2836 1 0.000214 1560.000000 -0.000269 -0.000238 0.005315 +2837 1 0.000195 1560.000000 0.002104 -0.001039 0.007352 +2838 1 0.000208 1560.000000 0.003222 0.000611 0.008137 +2839 1 0.000217 1560.000000 -0.000456 0.000496 0.004041 +2840 1 0.000243 1560.000000 -0.000652 -0.003395 0.004075 +2841 1 0.000207 1560.000000 0.003481 0.000019 0.006383 +2842 1 0.000206 1560.000000 -0.002269 0.000745 0.003607 +2843 1 0.000206 1560.000000 0.000556 -0.000496 0.007921 +2844 1 0.000243 1560.000000 -0.001129 -0.000831 0.006957 +2845 1 0.000212 1560.000000 -0.001151 -0.002546 0.006674 +2846 1 0.000219 1560.000000 0.003352 -0.000274 0.007876 +2847 1 0.000228 1560.000000 0.003100 0.000807 0.007707 +2848 1 0.000218 1560.000000 -0.001873 0.003354 0.003781 +2849 1 0.000254 1560.000000 -0.001231 -0.000590 0.009240 +2850 1 0.000199 1560.000000 0.001433 -0.000621 0.004479 +2851 1 0.000216 1560.000000 0.001435 -0.001054 0.007575 +2852 1 0.000212 1560.000000 0.003086 -0.001527 0.007408 +2853 1 0.000206 1560.000000 -0.000793 -0.003441 0.001162 +2854 1 0.000218 1560.000000 -0.001228 0.000963 0.001541 +2855 1 0.000205 1560.000000 -0.001877 0.000224 0.009099 +2856 1 0.000224 1560.000000 0.000100 0.002619 0.008644 +2857 1 0.000197 1560.000000 0.001747 -0.002610 0.001656 +2858 1 0.000228 1560.000000 -0.002487 0.000227 0.002747 +2859 1 0.000233 1560.000000 -0.001454 -0.001031 0.008537 +2860 1 0.000282 1560.000000 -0.000657 0.002503 0.002631 +2861 1 0.000273 1560.000000 -0.002951 0.002190 0.009422 +2862 1 0.000224 1560.000000 -0.000192 -0.001990 0.006712 +2863 1 0.000258 1560.000000 -0.003018 -0.001267 0.007561 +2864 1 0.000276 1560.000000 0.001504 0.001094 0.009191 +2865 1 0.000216 1560.000000 0.002361 -0.001567 0.002393 +2866 1 0.000284 1560.000000 -0.000156 -0.000287 0.004153 +2867 1 0.000252 1560.000000 0.000502 -0.000731 0.007578 +2868 1 0.000212 1560.000000 -0.000347 0.001604 0.008100 +2869 1 0.000281 1560.000000 0.001403 -0.001540 0.009021 +2870 1 0.000247 1560.000000 -0.000297 -0.002347 0.008117 +2871 1 0.000214 1560.000000 -0.000418 -0.002624 0.008674 +2872 1 0.000193 1560.000000 -0.001976 0.002801 0.003652 +2873 1 0.000266 1560.000000 0.003751 0.000090 0.004430 +2874 1 0.000233 1560.000000 0.000031 -0.002168 0.002014 +2875 1 0.000260 1560.000000 0.002340 0.000228 0.005098 +2876 1 0.000266 1560.000000 -0.000556 -0.001175 0.008222 +2877 1 0.000256 1560.000000 0.003362 0.001750 0.007945 +2878 1 0.000214 1560.000000 0.000572 -0.001662 0.005525 +2879 1 0.000212 1560.000000 -0.000546 0.002902 0.006600 +2880 1 0.000218 1560.000000 -0.000024 0.001157 0.009141 +2881 1 0.000262 1560.000000 0.001032 -0.000291 0.003788 +2882 1 0.000204 1560.000000 0.000737 -0.002256 0.000716 +2883 1 0.000243 1560.000000 -0.002268 -0.003086 0.002289 +2884 1 0.000240 1560.000000 0.000781 -0.002786 0.009414 +2885 1 0.000223 1560.000000 -0.001981 -0.002040 0.006887 +2886 1 0.000250 1560.000000 -0.000785 -0.000029 0.000765 +2887 1 0.000246 1560.000000 0.001809 -0.003091 0.002666 +2888 1 0.000201 1560.000000 0.000843 -0.003687 0.009779 +2889 1 0.000203 1560.000000 0.002418 0.000970 0.005523 +2890 1 0.000209 1560.000000 0.000668 0.000217 0.001196 +2891 1 0.000213 1560.000000 -0.003498 0.000075 0.006486 +2892 1 0.000227 1560.000000 -0.000859 0.003234 0.008629 +2893 1 0.000264 1560.000000 0.001620 -0.001393 0.006149 +2894 1 0.000200 1560.000000 0.000631 -0.003599 0.006429 +2895 1 0.000195 1560.000000 -0.001802 -0.001089 0.003817 +2896 1 0.000218 1560.000000 -0.000816 0.003274 0.009077 +2897 1 0.000198 1560.000000 -0.000045 -0.002671 0.007113 +2898 1 0.000204 1560.000000 -0.002181 0.001795 0.009690 +2899 1 0.000195 1560.000000 -0.000981 0.002647 0.001116 +2900 1 0.000219 1560.000000 0.001408 -0.000576 0.001327 +2901 1 0.000192 1560.000000 0.000029 -0.001351 0.003505 +2902 1 0.000219 1560.000000 -0.000015 0.001744 0.006719 +2903 1 0.000220 1560.000000 -0.001889 -0.001564 0.009454 +2904 1 0.000265 1560.000000 0.000930 0.001328 0.003783 +2905 1 0.000220 1560.000000 -0.000775 0.000487 0.004493 +2906 1 0.000280 1560.000000 0.001509 -0.000229 0.009614 +2907 1 0.000285 1560.000000 -0.001696 -0.000457 0.007701 +2908 1 0.000231 1560.000000 -0.001240 -0.000647 0.003029 +2909 1 0.000214 1560.000000 0.000441 0.000248 0.002840 +2910 1 0.000226 1560.000000 -0.003176 -0.001724 0.003703 +2911 1 0.000225 1560.000000 0.002501 -0.000401 0.006782 +2912 1 0.000217 1560.000000 -0.000367 -0.001594 0.006963 +2913 1 0.000213 1560.000000 0.001687 0.000385 0.009458 +2914 1 0.000284 1560.000000 0.002001 -0.001461 0.002235 +2915 1 0.000233 1560.000000 -0.000509 0.002482 0.004940 +2916 1 0.000202 1560.000000 0.001601 -0.001018 0.001066 +2917 1 0.000242 1560.000000 0.001915 0.002693 0.008868 +2918 1 0.000258 1560.000000 0.002246 -0.001868 0.008638 +2919 1 0.000223 1560.000000 0.000265 -0.002042 0.008936 +2920 1 0.000273 1560.000000 0.000012 0.000754 0.000752 +2921 1 0.000194 1560.000000 0.001401 -0.000421 0.001847 +2922 1 0.000212 1560.000000 0.000641 0.001904 0.006930 +2923 1 0.000215 1560.000000 -0.002476 0.002476 0.005857 +2924 1 0.000229 1560.000000 -0.000296 -0.000761 0.007961 +2925 1 0.000225 1560.000000 -0.002929 0.001117 0.005077 +2926 1 0.000250 1560.000000 0.000181 0.002352 0.005996 +2927 1 0.000234 1560.000000 0.000694 0.001423 0.001294 +2928 1 0.000202 1560.000000 0.000675 0.000213 0.008958 +2929 1 0.000201 1560.000000 0.001362 0.000752 0.004427 +2930 1 0.000205 1560.000000 0.003278 0.001668 0.001201 +2931 1 0.000241 1560.000000 0.002196 -0.003027 0.005099 +2932 1 0.000261 1560.000000 -0.002823 0.002264 0.004424 +2933 1 0.000220 1560.000000 -0.001746 0.002652 0.008816 +2934 1 0.000205 1560.000000 -0.002334 -0.002994 0.001631 +2935 1 0.000214 1560.000000 0.000355 0.003154 0.007478 +2936 1 0.000203 1560.000000 -0.001392 0.000830 0.003071 +2937 1 0.000266 1560.000000 0.002894 0.002477 0.005980 +2938 1 0.000212 1560.000000 0.002560 0.000682 0.004271 +2939 1 0.000273 1560.000000 0.001245 0.003421 0.006466 +2940 1 0.000214 1560.000000 -0.003708 -0.001041 0.001832 +2941 1 0.000263 1560.000000 -0.002528 0.001071 0.001928 +2942 1 0.000240 1560.000000 -0.001885 0.002230 0.002270 +2943 1 0.000202 1560.000000 0.000114 0.000078 0.001988 +2944 1 0.000227 1560.000000 -0.000625 0.001483 0.000938 +2945 1 0.000201 1560.000000 0.002471 -0.002865 0.006326 +2946 1 0.000216 1560.000000 0.003022 0.001435 0.009469 +2947 1 0.000206 1560.000000 -0.002825 -0.000864 0.004627 +2948 1 0.000255 1560.000000 0.001777 -0.002164 0.003044 +2949 1 0.000220 1560.000000 -0.000516 0.000639 0.001243 +2950 1 0.000193 1560.000000 -0.001790 -0.002824 0.006704 +2951 1 0.000229 1560.000000 -0.000694 0.002292 0.003194 +2952 1 0.000249 1560.000000 -0.000592 0.002521 0.009607 +2953 1 0.000203 1560.000000 -0.001896 -0.003213 0.004852 +2954 1 0.000238 1560.000000 0.000883 -0.002987 0.000159 +2955 1 0.000193 1560.000000 -0.002222 -0.002972 0.005018 +2956 1 0.000230 1560.000000 -0.001816 -0.001010 0.008202 +2957 1 0.000275 1560.000000 -0.000849 -0.000186 0.007038 +2958 1 0.000210 1560.000000 0.002563 -0.000916 0.002553 +2959 1 0.000198 1560.000000 0.001656 0.001460 0.002877 +2960 1 0.000196 1560.000000 0.000525 0.003061 0.000471 +2961 1 0.000252 1560.000000 -0.002216 -0.000219 0.009504 +2962 1 0.000209 1560.000000 -0.000066 0.000164 0.008367 +2963 1 0.000214 1560.000000 -0.002498 0.000262 0.000713 +2964 1 0.000271 1560.000000 0.000590 0.002135 0.004493 +2965 1 0.000229 1560.000000 -0.003786 0.000253 0.005915 +2966 1 0.000234 1560.000000 -0.003817 0.000061 0.009812 +2967 1 0.000235 1560.000000 -0.003497 -0.001606 0.004110 +2968 1 0.000213 1560.000000 0.002635 0.001335 0.007766 +2969 1 0.000271 1560.000000 -0.000951 -0.002410 0.000877 +2970 1 0.000258 1560.000000 0.003246 0.000650 0.002175 +2971 1 0.000259 1560.000000 0.000998 0.003522 0.009107 +2972 1 0.000215 1560.000000 0.001109 0.001490 0.004493 +2973 1 0.000218 1560.000000 0.000693 0.001594 0.009043 +2974 1 0.000285 1560.000000 -0.002054 0.002599 0.003898 +2975 1 0.000204 1560.000000 0.000578 0.003232 0.002888 +2976 1 0.000247 1560.000000 0.002817 0.000553 0.004342 +2977 1 0.000282 1560.000000 -0.001655 -0.001092 0.005105 +2978 1 0.000254 1560.000000 0.000708 0.001090 0.005066 +2979 1 0.000272 1560.000000 -0.001175 -0.002222 0.004272 +2980 1 0.000197 1560.000000 -0.003158 0.000592 0.005274 +2981 1 0.000287 1560.000000 -0.003021 0.000832 0.009317 +2982 1 0.000196 1560.000000 -0.000192 -0.003717 0.008189 +2983 1 0.000236 1560.000000 0.001337 0.001879 0.000950 +2984 1 0.000202 1560.000000 -0.000856 0.002178 0.002051 +2985 1 0.000257 1560.000000 -0.000516 -0.001661 0.008268 +2986 1 0.000258 1560.000000 0.001867 -0.000001 0.005542 +2987 1 0.000194 1560.000000 0.000793 -0.001778 0.007068 +2988 1 0.000237 1560.000000 -0.002514 -0.002504 0.004788 +2989 1 0.000205 1560.000000 -0.001625 0.001615 0.007130 +2990 1 0.000247 1560.000000 -0.001180 -0.002867 0.000777 +2991 1 0.000205 1560.000000 -0.001299 0.000153 0.002449 +2992 1 0.000219 1560.000000 0.001575 -0.001366 0.000428 +2993 1 0.000202 1560.000000 0.000651 -0.000488 0.001937 +2994 1 0.000238 1560.000000 -0.001032 -0.000407 0.005406 +2995 1 0.000206 1560.000000 -0.003292 0.000872 0.008195 +2996 1 0.000283 1560.000000 -0.000823 0.001131 0.008410 +2997 1 0.000261 1560.000000 -0.003486 -0.001506 0.009605 +2998 1 0.000222 1560.000000 0.001651 -0.000734 0.005654 +2999 1 0.000210 1560.000000 -0.000442 0.000402 0.004904 +3000 1 0.000286 1560.000000 0.002352 -0.001545 0.006301 +3001 1 0.000216 1560.000000 0.001104 -0.001966 0.000626 +3002 1 0.000220 1560.000000 -0.000586 0.001666 0.008297 +3003 1 0.000270 1560.000000 -0.003274 -0.001570 0.003109 +3004 1 0.000200 1560.000000 0.000882 0.002304 0.008236 +3005 1 0.000222 1560.000000 -0.003515 0.000805 0.002461 +3006 1 0.000213 1560.000000 -0.001330 0.001035 0.007027 +3007 1 0.000230 1560.000000 -0.002381 -0.001304 0.007781 +3008 1 0.000212 1560.000000 0.001890 -0.002324 0.000447 +3009 1 0.000212 1560.000000 0.000139 0.001921 0.006167 +3010 1 0.000199 1560.000000 -0.000913 0.000374 0.007853 +3011 1 0.000247 1560.000000 0.002501 0.001091 0.001472 +3012 1 0.000214 1560.000000 -0.001330 0.003467 0.001180 +3013 1 0.000197 1560.000000 0.000717 -0.000984 0.006911 +3014 1 0.000267 1560.000000 -0.002994 0.002015 0.005884 +3015 1 0.000224 1560.000000 0.002089 0.001838 0.002985 +3016 1 0.000266 1560.000000 0.000276 -0.000354 0.008754 +3017 1 0.000213 1560.000000 0.000538 -0.001925 0.000257 +3018 1 0.000220 1560.000000 0.001580 0.000148 0.004851 +3019 1 0.000232 1560.000000 -0.001215 -0.000725 0.000946 +3020 1 0.000195 1560.000000 0.000383 0.000628 0.000383 +3021 1 0.000206 1560.000000 0.001790 -0.001153 0.008509 +3022 1 0.000249 1560.000000 0.002777 0.001275 0.004436 +3023 1 0.000200 1560.000000 -0.002880 -0.002080 0.000537 +3024 1 0.000220 1560.000000 0.000446 0.001143 0.006157 +3025 1 0.000267 1560.000000 -0.001057 0.002354 0.004769 +3026 1 0.000254 1560.000000 0.000802 -0.000525 0.008135 +3027 1 0.000193 1560.000000 -0.002246 -0.001278 0.006550 +3028 1 0.000195 1560.000000 0.000718 0.001134 0.003003 +3029 1 0.000198 1560.000000 -0.001662 0.001850 0.001878 +3030 1 0.000242 1560.000000 0.001206 -0.000008 0.008989 +3031 1 0.000286 1560.000000 0.000333 0.002336 0.003442 +3032 1 0.000232 1560.000000 -0.000327 0.002449 0.006999 +3033 1 0.000263 1560.000000 0.000808 -0.003589 0.003465 +3034 1 0.000198 1560.000000 0.000498 0.001588 0.008336 +3035 1 0.000195 1560.000000 0.000043 0.000009 0.007018 +3036 1 0.000193 1560.000000 -0.000534 0.000029 0.003861 +3037 1 0.000195 1560.000000 0.002978 0.001337 0.008010 +3038 1 0.000196 1560.000000 0.000188 -0.001961 0.005084 +3039 1 0.000249 1560.000000 0.002295 -0.000316 0.004056 +3040 1 0.000218 1560.000000 -0.001096 -0.000331 0.002281 +3041 1 0.000216 1560.000000 0.000016 -0.001804 0.002355 +3042 1 0.000216 1560.000000 -0.000751 0.002078 0.008642 +3043 1 0.000224 1560.000000 -0.001482 0.001861 0.005690 +3044 1 0.000268 1560.000000 0.001046 0.000504 0.006268 +3045 1 0.000246 1560.000000 -0.002197 0.000759 0.002184 +3046 1 0.000263 1560.000000 -0.001358 0.000971 0.000730 +3047 1 0.000255 1560.000000 0.002457 0.000444 0.004862 +3048 1 0.000224 1560.000000 0.001565 -0.002317 0.009650 +3049 1 0.000256 1560.000000 -0.001435 0.001446 0.003203 +3050 1 0.000250 1560.000000 -0.001134 -0.003220 0.009550 +3051 1 0.000257 1560.000000 0.002189 -0.000704 0.006656 +3052 1 0.000287 1560.000000 0.002048 -0.001031 0.007024 +3053 1 0.000201 1560.000000 0.000067 -0.001755 0.001717 +3054 1 0.000259 1560.000000 0.001691 -0.000106 0.008481 +3055 1 0.000218 1560.000000 0.000574 -0.003574 0.007130 +3056 1 0.000208 1560.000000 0.000177 0.002660 0.009774 +3057 1 0.000284 1560.000000 0.003509 0.000500 0.002586 +3058 1 0.000197 1560.000000 -0.001800 0.000927 0.008335 +3059 1 0.000193 1560.000000 0.000624 0.000403 0.003353 +3060 1 0.000221 1560.000000 0.002609 0.000681 0.007128 +3061 1 0.000200 1560.000000 0.002632 0.001523 0.003333 +3062 1 0.000286 1560.000000 0.001690 -0.002091 0.005940 +3063 1 0.000223 1560.000000 -0.000971 -0.001088 0.001301 +3064 1 0.000229 1560.000000 0.001955 -0.000553 0.002609 +3065 1 0.000242 1560.000000 0.000311 0.000665 0.003076 +3066 1 0.000240 1560.000000 0.001818 -0.000818 0.007734 +3067 1 0.000226 1560.000000 -0.002366 -0.001180 0.004072 +3068 1 0.000232 1560.000000 0.001266 -0.002679 0.005115 +3069 1 0.000243 1560.000000 0.001783 0.001857 0.004236 +3070 1 0.000228 1560.000000 0.000695 -0.000264 0.001487 +3071 1 0.000225 1560.000000 0.000266 0.000228 0.000504 +3072 1 0.000227 1560.000000 0.002783 -0.001992 0.003437 +3073 1 0.000225 1560.000000 0.001011 0.002600 0.007662 +3074 1 0.000198 1560.000000 -0.000526 0.000464 0.001691 +3075 1 0.000252 1560.000000 -0.001878 0.002554 0.004527 +3076 1 0.000203 1560.000000 -0.002137 0.000429 0.006642 +3077 1 0.000284 1560.000000 -0.000240 -0.003671 0.007483 +3078 1 0.000225 1560.000000 0.001925 -0.000505 0.006402 +3079 1 0.000218 1560.000000 0.000391 0.002815 0.006257 +3080 1 0.000210 1560.000000 0.000688 0.000919 0.006379 +3081 1 0.000213 1560.000000 0.002501 0.001874 0.009594 +3082 1 0.000210 1560.000000 -0.002094 0.000402 0.000761 +3083 1 0.000256 1560.000000 -0.000907 0.003140 0.009677 +3084 1 0.000243 1560.000000 -0.000946 0.000773 0.005116 +3085 1 0.000264 1560.000000 0.001138 0.000407 0.001197 +3086 1 0.000230 1560.000000 0.000312 -0.003635 0.002753 +3087 1 0.000226 1560.000000 0.000456 -0.003457 0.009765 +3088 1 0.000204 1560.000000 -0.001139 -0.000751 0.005938 +3089 1 0.000215 1560.000000 0.000898 0.000186 0.008912 +3090 1 0.000268 1560.000000 -0.003187 -0.001218 0.008983 +3091 1 0.000259 1560.000000 0.002725 0.000275 0.002136 +3092 1 0.000268 1560.000000 0.001005 -0.003434 0.006638 +3093 1 0.000252 1560.000000 0.001849 -0.001709 0.001680 +3094 1 0.000217 1560.000000 0.000412 -0.000025 0.007934 +3095 1 0.000211 1560.000000 0.001215 0.001366 0.009215 +3096 1 0.000238 1560.000000 -0.001446 0.000922 0.008465 +3097 1 0.000240 1560.000000 0.000529 -0.000123 0.003565 +3098 1 0.000268 1560.000000 0.000650 -0.002930 0.002486 +3099 1 0.000232 1560.000000 0.002488 -0.000590 0.001573 +3100 1 0.000229 1560.000000 -0.000067 0.000728 0.009046 +3101 1 0.000211 1560.000000 0.003546 -0.000738 0.008791 +3102 1 0.000259 1560.000000 -0.001369 -0.003285 0.004965 +3103 1 0.000195 1560.000000 0.000061 0.000844 0.004074 +3104 1 0.000206 1560.000000 0.001142 -0.000915 0.004137 +3105 1 0.000246 1560.000000 0.000415 0.001730 0.006228 +3106 1 0.000238 1560.000000 0.001855 0.000614 0.000962 +3107 1 0.000203 1560.000000 0.001186 0.000971 0.003185 +3108 1 0.000216 1560.000000 0.000151 -0.000678 0.004081 +3109 1 0.000232 1560.000000 0.002925 -0.001239 0.002412 +3110 1 0.000259 1560.000000 0.000371 -0.002045 0.002211 +3111 1 0.000252 1560.000000 -0.002866 0.001998 0.007948 +3112 1 0.000210 1560.000000 -0.002241 -0.002794 0.003801 +3113 1 0.000203 1560.000000 -0.002867 -0.000854 0.004074 +3114 1 0.000213 1560.000000 0.001383 0.000579 0.002135 +3115 1 0.000219 1560.000000 0.000166 -0.000151 0.005063 +3116 1 0.000270 1560.000000 0.001008 0.001757 0.007185 +3117 1 0.000273 1560.000000 -0.002191 0.002742 0.006885 +3118 1 0.000194 1560.000000 -0.000147 0.000445 0.000164 +3119 1 0.000198 1560.000000 -0.000226 0.001784 0.000795 +3120 1 0.000261 1560.000000 0.002055 -0.001032 0.005432 +3121 1 0.000197 1560.000000 -0.000315 0.002903 0.007494 +3122 1 0.000195 1560.000000 -0.001512 0.001163 0.004127 +3123 1 0.000223 1560.000000 0.000044 0.002345 0.007996 +3124 1 0.000195 1560.000000 0.000569 0.000821 0.005211 +3125 1 0.000244 1560.000000 -0.000024 0.000934 0.006991 +3126 1 0.000288 1560.000000 0.001635 0.001565 0.008764 +3127 1 0.000239 1560.000000 0.000777 0.001080 0.005539 +3128 1 0.000206 1560.000000 -0.002648 -0.000141 0.007867 +3129 1 0.000198 1560.000000 0.000278 -0.001853 0.007027 +3130 1 0.000192 1560.000000 0.000290 0.001641 0.003898 +3131 1 0.000204 1560.000000 -0.001201 -0.003547 0.006841 +3132 1 0.000218 1560.000000 0.000573 0.001629 0.005579 +3133 1 0.000272 1560.000000 0.001750 0.002494 0.004954 +3134 1 0.000266 1560.000000 -0.002764 0.002535 0.000357 +3135 1 0.000283 1560.000000 -0.001851 0.003100 0.002513 +3136 1 0.000229 1560.000000 -0.000682 -0.001685 0.009511 +3137 1 0.000207 1560.000000 0.000790 0.000129 0.007787 +3138 1 0.000198 1560.000000 -0.000362 -0.000593 0.003121 +3139 1 0.000262 1560.000000 0.002099 -0.002731 0.006690 +3140 1 0.000199 1560.000000 -0.003614 -0.000599 0.000767 +3141 1 0.000226 1560.000000 -0.000017 0.001738 0.003562 +3142 1 0.000270 1560.000000 -0.000621 -0.000657 0.006177 +3143 1 0.000207 1560.000000 -0.000776 -0.001755 0.005324 +3144 1 0.000192 1560.000000 0.000793 -0.003055 0.001144 +3145 1 0.000268 1560.000000 0.001283 -0.002327 0.002833 +3146 1 0.000226 1560.000000 0.002671 0.000770 0.004687 +3147 1 0.000211 1560.000000 0.001551 -0.003292 0.002419 +3148 1 0.000268 1560.000000 0.001851 -0.001191 0.001921 +3149 1 0.000231 1560.000000 0.000188 0.001317 0.002401 +3150 1 0.000214 1560.000000 -0.000008 0.001632 0.003916 +3151 1 0.000232 1560.000000 0.001165 -0.002764 0.005811 +3152 1 0.000220 1560.000000 -0.001255 0.003183 0.007442 +3153 1 0.000207 1560.000000 0.003782 0.000368 0.008238 +3154 1 0.000241 1560.000000 -0.002704 0.001668 0.002095 +3155 1 0.000237 1560.000000 -0.001514 0.002151 0.002800 +3156 1 0.000214 1560.000000 0.001070 -0.000862 0.009678 +3157 1 0.000211 1560.000000 -0.000630 -0.000446 0.007202 +3158 1 0.000195 1560.000000 -0.001299 0.001962 0.003926 +3159 1 0.000282 1560.000000 -0.000633 -0.000348 0.004415 +3160 1 0.000277 1560.000000 -0.002940 -0.001230 0.009544 +3161 1 0.000208 1560.000000 -0.000745 0.001015 0.005441 +3162 1 0.000253 1560.000000 0.001156 0.002448 0.003007 +3163 1 0.000196 1560.000000 -0.002491 -0.000895 0.005836 +3164 1 0.000218 1560.000000 -0.001743 -0.002957 0.009393 +3165 1 0.000269 1560.000000 -0.001021 -0.000146 0.002028 +3166 1 0.000288 1560.000000 0.003440 -0.001402 0.001263 +3167 1 0.000193 1560.000000 -0.000337 -0.001702 0.005354 +3168 1 0.000237 1560.000000 0.001539 0.002510 0.000947 +3169 1 0.000221 1560.000000 0.002770 -0.001128 0.003982 +3170 1 0.000235 1560.000000 -0.000411 -0.003323 0.002185 +3171 1 0.000276 1560.000000 -0.002746 -0.000056 0.005789 +3172 1 0.000227 1560.000000 0.002512 -0.001262 0.001034 +3173 1 0.000263 1560.000000 0.003274 -0.000171 0.007585 +3174 1 0.000244 1560.000000 -0.001966 0.000009 0.005688 +3175 1 0.000273 1560.000000 -0.000763 0.001212 0.001567 +3176 1 0.000288 1560.000000 0.002447 0.001564 0.005107 +3177 1 0.000268 1560.000000 0.001673 0.000617 0.000311 +3178 1 0.000287 1560.000000 -0.000432 0.000202 0.004260 +3179 1 0.000281 1560.000000 -0.000616 -0.001794 0.000180 +3180 1 0.000263 1560.000000 0.001654 -0.001023 0.007674 +3181 1 0.000214 1560.000000 -0.000917 0.001465 0.006713 +3182 1 0.000226 1560.000000 0.000964 -0.001291 0.003213 +3183 1 0.000202 1560.000000 0.000341 -0.002157 0.004388 +3184 1 0.000237 1560.000000 -0.000775 -0.001163 0.001631 +3185 1 0.000235 1560.000000 -0.001041 -0.000639 0.007667 +3186 1 0.000193 1560.000000 -0.001218 -0.000525 0.008377 +3187 1 0.000231 1560.000000 0.000596 -0.002575 0.001116 +3188 1 0.000234 1560.000000 0.002373 -0.000375 0.003479 +3189 1 0.000247 1560.000000 0.000383 0.000579 0.002779 +3190 1 0.000195 1560.000000 -0.001728 0.000216 0.009583 +3191 1 0.000203 1560.000000 -0.000903 -0.003377 0.009633 +3192 1 0.000225 1560.000000 -0.002405 0.002944 0.005670 +3193 1 0.000226 1560.000000 0.001618 -0.000331 0.008958 +3194 1 0.000276 1560.000000 -0.001022 -0.000580 0.001615 +3195 1 0.000226 1560.000000 0.000743 0.000346 0.000819 +3196 1 0.000204 1560.000000 -0.001936 -0.002894 0.007908 +3197 1 0.000201 1560.000000 0.002526 0.000407 0.002534 +3198 1 0.000236 1560.000000 0.003519 0.000561 0.009054 +3199 1 0.000207 1560.000000 -0.000518 -0.001972 0.008837 +3200 1 0.000272 1560.000000 0.001766 0.000253 0.000140 +3201 1 0.000224 1560.000000 -0.001219 -0.001177 0.007929 +3202 1 0.000197 1560.000000 0.000034 -0.003154 0.000819 +3203 1 0.000196 1560.000000 0.000910 -0.002644 0.008211 +3204 1 0.000237 1560.000000 0.002841 -0.000238 0.009506 +3205 1 0.000213 1560.000000 0.000410 -0.001137 0.009667 +3206 1 0.000194 1560.000000 -0.001721 0.000066 0.003648 +3207 1 0.000231 1560.000000 -0.002830 0.002386 0.004722 +3208 1 0.000275 1560.000000 -0.003256 -0.000237 0.006313 +3209 1 0.000203 1560.000000 -0.000941 -0.000648 0.002176 +3210 1 0.000209 1560.000000 0.003025 0.000087 0.001040 +3211 1 0.000234 1560.000000 0.002953 -0.001509 0.006445 +3212 1 0.000256 1560.000000 0.002367 -0.002566 0.007595 +3213 1 0.000221 1560.000000 0.000099 -0.000459 0.006354 +3214 1 0.000203 1560.000000 0.002292 -0.002004 0.004075 +3215 1 0.000279 1560.000000 0.001732 -0.000857 0.001965 +3216 1 0.000192 1560.000000 0.002896 0.000417 0.007941 +3217 1 0.000193 1560.000000 -0.000365 -0.000812 0.002069 +3218 1 0.000192 1560.000000 0.002111 -0.002397 0.003746 +3219 1 0.000223 1560.000000 0.000038 -0.001875 0.000456 +3220 1 0.000200 1560.000000 0.001949 0.001706 0.009550 +3221 1 0.000196 1560.000000 0.002839 -0.000642 0.000584 +3222 1 0.000260 1560.000000 -0.001161 -0.002329 0.005066 +3223 1 0.000192 1560.000000 0.001848 -0.003043 0.000601 +3224 1 0.000209 1560.000000 0.002043 0.002251 0.004381 +3225 1 0.000263 1560.000000 -0.002320 0.002170 0.003625 +3226 1 0.000254 1560.000000 0.001462 0.000509 0.000152 +3227 1 0.000233 1560.000000 -0.001658 -0.001067 0.000822 +3228 1 0.000202 1560.000000 -0.003634 -0.000392 0.009388 +3229 1 0.000218 1560.000000 0.001581 0.000443 0.005348 +3230 1 0.000241 1560.000000 -0.003116 0.000743 0.004401 +3231 1 0.000226 1560.000000 0.002919 -0.001465 0.001152 +3232 1 0.000287 1560.000000 -0.001836 0.001706 0.008177 +3233 1 0.000261 1560.000000 -0.002822 -0.001496 0.007570 +3234 1 0.000217 1560.000000 0.003457 -0.001326 0.002886 +3235 1 0.000219 1560.000000 0.000814 -0.000911 0.009454 +3236 1 0.000253 1560.000000 0.002859 -0.001600 0.008456 +3237 1 0.000234 1560.000000 0.001143 -0.000354 0.004435 +3238 1 0.000194 1560.000000 -0.000843 -0.001351 0.004794 +3239 1 0.000215 1560.000000 -0.000022 -0.000504 0.004671 +3240 1 0.000220 1560.000000 -0.001166 0.001728 0.003212 +3241 1 0.000279 1560.000000 0.001971 -0.000152 0.000728 +3242 1 0.000271 1560.000000 0.003156 -0.000832 0.004741 +3243 1 0.000199 1560.000000 0.000197 0.000075 0.007140 +3244 1 0.000210 1560.000000 -0.001173 0.001735 0.007738 +3245 1 0.000216 1560.000000 0.000292 0.000381 0.000260 +3246 1 0.000198 1560.000000 0.002914 0.000619 0.003032 +3247 1 0.000284 1560.000000 0.000185 0.002379 0.006962 +3248 1 0.000225 1560.000000 -0.000991 -0.002304 0.008797 +3249 1 0.000195 1560.000000 0.002287 0.002830 0.009614 +3250 1 0.000205 1560.000000 -0.002264 0.001984 0.002563 +3251 1 0.000212 1560.000000 0.001039 -0.002847 0.002568 +3252 1 0.000235 1560.000000 -0.000852 -0.002560 0.005964 +3253 1 0.000195 1560.000000 0.002012 -0.000344 0.006909 +3254 1 0.000193 1560.000000 -0.001610 0.000040 0.009499 +3255 1 0.000193 1560.000000 -0.000554 -0.000642 0.002627 +3256 1 0.000261 1560.000000 0.002453 -0.001008 0.009537 +3257 1 0.000211 1560.000000 0.000103 -0.003748 0.003203 +3258 1 0.000282 1560.000000 -0.000194 0.001038 0.004199 +3259 1 0.000279 1560.000000 0.002829 0.000813 0.007138 +3260 1 0.000201 1560.000000 0.000955 0.001954 0.001184 +3261 1 0.000192 1560.000000 -0.002841 -0.001057 0.004964 +3262 1 0.000237 1560.000000 -0.001315 -0.001316 0.009462 +3263 1 0.000206 1560.000000 -0.002981 0.000968 0.002842 +3264 1 0.000280 1560.000000 -0.001679 0.002784 0.006676 +3265 1 0.000195 1560.000000 -0.000956 -0.002543 0.005066 +3266 1 0.000226 1560.000000 0.000794 0.000527 0.003926 +3267 1 0.000267 1560.000000 0.001873 0.002413 0.007103 +3268 1 0.000268 1560.000000 0.001804 -0.002845 0.007411 +3269 1 0.000232 1560.000000 0.002543 0.002556 0.007517 +3270 1 0.000212 1560.000000 0.000241 0.003607 0.001462 +3271 1 0.000271 1560.000000 -0.002221 0.000301 0.006953 +3272 1 0.000254 1560.000000 0.002229 -0.000060 0.003758 +3273 1 0.000199 1560.000000 0.000381 0.001926 0.009795 +3274 1 0.000207 1560.000000 0.003514 -0.000764 0.008553 +3275 1 0.000233 1560.000000 0.001431 -0.001218 0.009025 +3276 1 0.000195 1560.000000 0.003439 -0.000738 0.001456 +3277 1 0.000283 1560.000000 0.001223 0.003570 0.007350 +3278 1 0.000211 1560.000000 -0.001040 -0.002927 0.002365 +3279 1 0.000246 1560.000000 -0.000872 0.003702 0.001005 +3280 1 0.000202 1560.000000 -0.001966 0.001088 0.005208 +3281 1 0.000230 1560.000000 0.001070 -0.000427 0.005897 +3282 1 0.000232 1560.000000 -0.002185 0.002681 0.002590 +3283 1 0.000227 1560.000000 0.000763 0.002054 0.005948 +3284 1 0.000241 1560.000000 0.001224 -0.001516 0.000571 +3285 1 0.000211 1560.000000 0.000774 0.000787 0.002614 +3286 1 0.000222 1560.000000 0.000567 0.003347 0.001430 +3287 1 0.000202 1560.000000 -0.000705 0.000616 0.008132 +3288 1 0.000226 1560.000000 -0.000024 -0.000881 0.007731 +3289 1 0.000212 1560.000000 0.001384 -0.003418 0.006508 +3290 1 0.000255 1560.000000 0.000535 -0.001653 0.003212 +3291 1 0.000217 1560.000000 -0.000025 -0.002297 0.004382 +3292 1 0.000254 1560.000000 -0.000392 0.001282 0.007705 +3293 1 0.000228 1560.000000 -0.001599 -0.001060 0.009756 +3294 1 0.000287 1560.000000 -0.001879 0.001532 0.008579 +3295 1 0.000201 1560.000000 -0.000590 -0.000255 0.009789 +3296 1 0.000217 1560.000000 -0.000431 -0.000502 0.007616 +3297 1 0.000231 1560.000000 0.001120 -0.001959 0.001737 +3298 1 0.000239 1560.000000 -0.002008 0.001783 0.007696 +3299 1 0.000273 1560.000000 0.003123 0.000923 0.000376 +3300 1 0.000280 1560.000000 -0.001116 0.000712 0.003781 +3301 1 0.000231 1560.000000 0.000677 -0.001224 0.001681 +3302 1 0.000210 1560.000000 -0.000387 0.001355 0.000333 +3303 1 0.000213 1560.000000 -0.000995 -0.001804 0.005927 +3304 1 0.000252 1560.000000 -0.000311 -0.003196 0.005703 +3305 1 0.000233 1560.000000 0.001581 0.001965 0.009091 +3306 1 0.000214 1560.000000 0.002408 0.002450 0.008312 +3307 1 0.000253 1560.000000 0.002895 -0.002002 0.001448 +3308 1 0.000213 1560.000000 0.001380 0.000719 0.000549 +3309 1 0.000216 1560.000000 0.000735 0.000353 0.008763 +3310 1 0.000236 1560.000000 0.001941 0.003304 0.009196 +3311 1 0.000232 1560.000000 0.000777 0.000206 0.006166 +3312 1 0.000244 1560.000000 0.002186 -0.000965 0.009728 +3313 1 0.000231 1560.000000 0.000447 -0.002034 0.001721 +3314 1 0.000214 1560.000000 0.001212 0.000214 0.009737 +3315 1 0.000217 1560.000000 -0.000744 0.001112 0.002625 +3316 1 0.000192 1560.000000 0.000975 -0.003366 0.006003 +3317 1 0.000215 1560.000000 0.002894 0.002138 0.004134 +3318 1 0.000212 1560.000000 -0.001382 0.002721 0.009721 +3319 1 0.000276 1560.000000 0.001709 0.003201 0.001945 +3320 1 0.000247 1560.000000 -0.001342 0.003031 0.005011 +3321 1 0.000207 1560.000000 -0.000236 0.001431 0.006959 +3322 1 0.000210 1560.000000 0.000489 0.000904 0.005799 +3323 1 0.000214 1560.000000 -0.000319 0.003013 0.006698 +3324 1 0.000288 1560.000000 -0.001606 0.002208 0.006046 +3325 1 0.000271 1560.000000 -0.001988 -0.003005 0.003755 +3326 1 0.000219 1560.000000 0.000194 0.000758 0.006043 +3327 1 0.000217 1560.000000 0.000023 -0.002474 0.000434 +3328 1 0.000258 1560.000000 -0.000419 -0.003752 0.002864 +3329 1 0.000253 1560.000000 -0.001633 0.000186 0.006047 +3330 1 0.000197 1560.000000 0.003178 -0.000807 0.002596 +3331 1 0.000246 1560.000000 0.000258 -0.000260 0.007424 +3332 1 0.000247 1560.000000 0.000044 -0.001211 0.009126 +3333 1 0.000228 1560.000000 -0.000907 -0.002330 0.004344 +3334 1 0.000239 1560.000000 -0.000698 -0.003568 0.004453 +3335 1 0.000208 1560.000000 -0.000087 0.000368 0.001083 +3336 1 0.000284 1560.000000 0.001625 -0.001939 0.007709 +3337 1 0.000208 1560.000000 -0.000004 -0.001433 0.000633 +3338 1 0.000204 1560.000000 -0.000155 0.002144 0.006876 +3339 1 0.000249 1560.000000 0.000734 -0.000789 0.006011 +3340 1 0.000201 1560.000000 0.000476 -0.002835 0.009152 +3341 1 0.000251 1560.000000 -0.001666 -0.001987 0.008796 +3342 1 0.000239 1560.000000 0.003130 -0.001449 0.002656 +3343 1 0.000226 1560.000000 -0.000016 -0.003409 0.003075 +3344 1 0.000240 1560.000000 0.000577 0.000607 0.004827 +3345 1 0.000277 1560.000000 0.001459 -0.000232 0.005086 +3346 1 0.000239 1560.000000 0.001640 0.000290 0.002639 +3347 1 0.000210 1560.000000 -0.000235 -0.001798 0.004631 +3348 1 0.000226 1560.000000 0.001038 -0.000107 0.000910 +3349 1 0.000278 1560.000000 0.003675 -0.001153 0.008650 +3350 1 0.000267 1560.000000 -0.000455 0.003790 0.000159 +3351 1 0.000260 1560.000000 0.002389 0.001593 0.009697 +3352 1 0.000197 1560.000000 0.001269 0.003246 0.002933 +3353 1 0.000210 1560.000000 0.001812 0.002559 0.008708 +3354 1 0.000220 1560.000000 0.001473 0.000311 0.009374 +3355 1 0.000196 1560.000000 -0.001707 0.000917 0.009704 +3356 1 0.000251 1560.000000 -0.000890 0.000708 0.008243 +3357 1 0.000241 1560.000000 0.000282 0.000008 0.001444 +3358 1 0.000238 1560.000000 0.003750 -0.000107 0.001485 +3359 1 0.000231 1560.000000 -0.001330 0.002820 0.008955 +3360 1 0.000287 1560.000000 0.001443 -0.001062 0.002616 +3361 1 0.000228 1560.000000 0.001994 0.000631 0.002408 +3362 1 0.000217 1560.000000 -0.000572 -0.003314 0.001401 +3363 1 0.000204 1560.000000 -0.001719 0.002783 0.001762 +3364 1 0.000195 1560.000000 0.001137 -0.001558 0.009090 +3365 1 0.000247 1560.000000 -0.000200 0.000746 0.002680 +3366 1 0.000200 1560.000000 0.000765 -0.000433 0.006371 +3367 1 0.000239 1560.000000 0.001462 -0.000486 0.002071 +3368 1 0.000222 1560.000000 -0.000533 0.001813 0.003377 +3369 1 0.000256 1560.000000 0.000732 -0.002097 0.001996 +3370 1 0.000203 1560.000000 -0.000852 -0.000248 0.007924 +3371 1 0.000287 1560.000000 0.000094 0.003528 0.000989 +3372 1 0.000279 1560.000000 0.000924 0.002876 0.000194 +3373 1 0.000277 1560.000000 0.002341 -0.001034 0.000947 +3374 1 0.000207 1560.000000 0.000667 0.000858 0.008386 +3375 1 0.000276 1560.000000 0.001577 -0.000464 0.005482 +3376 1 0.000194 1560.000000 0.002089 -0.002576 0.006865 +3377 1 0.000263 1560.000000 -0.001122 0.000563 0.002407 +3378 1 0.000193 1560.000000 0.000514 -0.000227 0.001321 +3379 1 0.000284 1560.000000 0.001215 0.001818 0.001984 +3380 1 0.000273 1560.000000 0.003658 -0.000138 0.008510 +3381 1 0.000255 1560.000000 -0.002300 -0.000932 0.007321 +3382 1 0.000210 1560.000000 0.000100 0.001994 0.002995 +3383 1 0.000206 1560.000000 -0.000179 0.000071 0.003216 +3384 1 0.000217 1560.000000 -0.001195 0.003232 0.008333 +3385 1 0.000204 1560.000000 -0.002934 0.000154 0.002854 +3386 1 0.000283 1560.000000 -0.003254 -0.000491 0.005301 +3387 1 0.000203 1560.000000 0.001506 0.000387 0.006329 +3388 1 0.000258 1560.000000 -0.000053 -0.000673 0.003110 +3389 1 0.000245 1560.000000 -0.000442 -0.001392 0.004766 +3390 1 0.000198 1560.000000 0.002730 0.000349 0.006175 +3391 1 0.000202 1560.000000 0.001212 0.003215 0.006742 +3392 1 0.000195 1560.000000 0.000445 0.001864 0.007674 +3393 1 0.000194 1560.000000 0.000595 -0.003187 0.006023 +3394 1 0.000200 1560.000000 -0.001917 0.002530 0.005480 +3395 1 0.000192 1560.000000 -0.002444 -0.000853 0.000908 +3396 1 0.000227 1560.000000 -0.001735 0.001866 0.006664 +3397 1 0.000239 1560.000000 0.002750 -0.001518 0.001354 +3398 1 0.000226 1560.000000 -0.002691 -0.000723 0.002909 +3399 1 0.000205 1560.000000 -0.001736 -0.001458 0.008292 +3400 1 0.000250 1560.000000 0.000935 -0.001649 0.002485 +3401 1 0.000229 1560.000000 -0.001424 -0.001661 0.000984 +3402 1 0.000208 1560.000000 0.002482 0.001226 0.006512 +3403 1 0.000199 1560.000000 0.001262 0.003233 0.002491 +3404 1 0.000199 1560.000000 -0.002817 0.000004 0.009378 +3405 1 0.000198 1560.000000 -0.000355 0.000391 0.005605 +3406 1 0.000249 1560.000000 0.003284 0.001291 0.001609 +3407 1 0.000237 1560.000000 0.000690 0.002191 0.002425 +3408 1 0.000287 1560.000000 0.002418 0.001210 0.007905 +3409 1 0.000194 1560.000000 -0.000211 0.002743 0.001631 +3410 1 0.000195 1560.000000 -0.000686 0.000111 0.005072 +3411 1 0.000251 1560.000000 -0.000522 0.000177 0.000439 +3412 1 0.000196 1560.000000 0.002033 0.000821 0.003432 +3413 1 0.000233 1560.000000 -0.001413 -0.001099 0.004633 +3414 1 0.000197 1560.000000 0.000116 -0.002412 0.007525 +3415 1 0.000207 1560.000000 0.002213 0.001052 0.007731 +3416 1 0.000253 1560.000000 -0.001825 0.003044 0.001682 +3417 1 0.000214 1560.000000 -0.001209 0.000038 0.001806 +3418 1 0.000209 1560.000000 0.001428 0.000166 0.007330 +3419 1 0.000223 1560.000000 0.000583 0.000082 0.006894 +3420 1 0.000205 1560.000000 -0.002221 0.000518 0.001920 +3421 1 0.000236 1560.000000 0.003450 -0.001595 0.006891 +3422 1 0.000201 1560.000000 -0.001545 0.001118 0.003614 +3423 1 0.000286 1560.000000 0.002973 -0.000760 0.004474 +3424 1 0.000265 1560.000000 0.002816 -0.001004 0.002961 +3425 1 0.000214 1560.000000 0.003510 -0.000161 0.005300 +3426 1 0.000243 1560.000000 0.003223 -0.000879 0.006598 +3427 1 0.000283 1560.000000 0.000216 0.001215 0.008071 +3428 1 0.000249 1560.000000 0.002440 -0.002910 0.007468 +3429 1 0.000236 1560.000000 0.002032 -0.002649 0.006063 +3430 1 0.000214 1560.000000 -0.001959 0.001396 0.002407 +3431 1 0.000223 1560.000000 -0.003157 0.000074 0.005234 +3432 1 0.000214 1560.000000 -0.000853 0.002808 0.005409 +3433 1 0.000223 1560.000000 -0.000730 -0.001746 0.006883 +3434 1 0.000286 1560.000000 -0.001594 -0.000883 0.003641 +3435 1 0.000211 1560.000000 0.000946 -0.002983 0.003036 +3436 1 0.000211 1560.000000 0.002204 -0.002125 0.007115 +3437 1 0.000195 1560.000000 0.001524 -0.002443 0.000230 +3438 1 0.000262 1560.000000 -0.000855 -0.001550 0.007536 +3439 1 0.000227 1560.000000 -0.001980 -0.002806 0.009053 +3440 1 0.000246 1560.000000 0.000271 -0.000729 0.002844 +3441 1 0.000267 1560.000000 -0.000558 0.001039 0.007132 +3442 1 0.000270 1560.000000 0.000423 -0.002568 0.003954 +3443 1 0.000210 1560.000000 -0.000602 0.000365 0.003710 +3444 1 0.000195 1560.000000 0.002491 -0.000551 0.002494 +3445 1 0.000245 1560.000000 0.001774 0.000900 0.001154 +3446 1 0.000224 1560.000000 -0.003396 -0.000617 0.000670 +3447 1 0.000261 1560.000000 -0.001615 0.000550 0.006029 +3448 1 0.000209 1560.000000 0.000840 -0.002625 0.002769 +3449 1 0.000254 1560.000000 0.002845 -0.001732 0.006567 +3450 1 0.000193 1560.000000 -0.002392 -0.000089 0.001023 +3451 1 0.000217 1560.000000 0.003256 0.001882 0.001328 +3452 1 0.000226 1560.000000 -0.002311 0.000390 0.007200 +3453 1 0.000216 1560.000000 -0.002207 0.002757 0.003640 +3454 1 0.000256 1560.000000 0.002329 -0.002773 0.001072 +3455 1 0.000265 1560.000000 -0.001524 -0.002726 0.001930 +3456 1 0.000259 1560.000000 -0.000086 0.003273 0.008327 +3457 1 0.000284 1560.000000 0.001742 0.003048 0.007361 +3458 1 0.000277 1560.000000 0.000867 -0.000623 0.005833 +3459 1 0.000286 1560.000000 -0.000724 -0.003506 0.007399 +3460 1 0.000208 1560.000000 0.002938 0.000368 0.006124 +3461 1 0.000249 1560.000000 -0.000588 -0.000500 0.009583 +3462 1 0.000219 1560.000000 -0.001629 0.000991 0.007590 +3463 1 0.000232 1560.000000 0.003389 -0.001423 0.007838 +3464 1 0.000197 1560.000000 0.003310 -0.001913 0.008864 +3465 1 0.000223 1560.000000 0.003018 -0.002172 0.002765 +3466 1 0.000256 1560.000000 0.002732 -0.002356 0.002234 +3467 1 0.000280 1560.000000 0.000359 -0.003000 0.001774 +3468 1 0.000203 1560.000000 -0.002493 0.000454 0.007370 +3469 1 0.000214 1560.000000 0.002447 -0.000752 0.004808 +3470 1 0.000247 1560.000000 -0.001350 0.001363 0.006990 +3471 1 0.000261 1560.000000 -0.002219 0.001843 0.001213 +3472 1 0.000261 1560.000000 0.002849 -0.000111 0.006479 +3473 1 0.000215 1560.000000 0.000073 -0.000223 0.003311 +3474 1 0.000233 1560.000000 -0.002182 -0.000067 0.007016 +3475 1 0.000202 1560.000000 -0.000288 -0.002318 0.003584 +3476 1 0.000194 1560.000000 0.000324 -0.000112 0.006769 +3477 1 0.000253 1560.000000 0.001047 -0.001397 0.003662 +3478 1 0.000267 1560.000000 0.001486 0.000313 0.003548 +3479 1 0.000195 1560.000000 -0.002910 -0.001086 0.004623 +3480 1 0.000217 1560.000000 -0.001375 0.002327 0.008041 +3481 1 0.000215 1560.000000 -0.001248 0.002916 0.002336 +3482 1 0.000260 1560.000000 0.000277 -0.000990 0.007594 +3483 1 0.000230 1560.000000 0.000175 -0.000720 0.001818 +3484 1 0.000236 1560.000000 -0.001775 -0.001734 0.002631 +3485 1 0.000236 1560.000000 0.001739 0.001399 0.009351 +3486 1 0.000253 1560.000000 0.000299 -0.000209 0.004559 +3487 1 0.000192 1560.000000 -0.000018 -0.003226 0.007903 +3488 1 0.000239 1560.000000 -0.001659 0.002755 0.002498 +3489 1 0.000197 1560.000000 -0.003382 0.001492 0.003750 +3490 1 0.000233 1560.000000 0.001896 0.001934 0.007348 +3491 1 0.000235 1560.000000 -0.000428 0.001495 0.000148 +3492 1 0.000270 1560.000000 0.002387 -0.001593 0.009370 +3493 1 0.000250 1560.000000 -0.002402 0.001481 0.001961 +3494 1 0.000249 1560.000000 -0.000724 0.002207 0.007528 +3495 1 0.000271 1560.000000 0.001462 0.001942 0.002655 +3496 1 0.000192 1560.000000 0.000813 -0.002107 0.000228 +3497 1 0.000223 1560.000000 -0.000322 -0.000154 0.008606 +3498 1 0.000209 1560.000000 0.002855 -0.000592 0.004245 +3499 1 0.000245 1560.000000 0.000852 -0.000834 0.007286 +3500 1 0.000212 1560.000000 -0.002267 0.000855 0.009055 +3501 1 0.000194 1560.000000 -0.001326 -0.003281 0.005830 +3502 1 0.000229 1560.000000 0.001837 -0.001026 0.003622 +3503 1 0.000198 1560.000000 -0.000831 -0.003721 0.001019 +3504 1 0.000218 1560.000000 0.002670 -0.001681 0.006884 +3505 1 0.000286 1560.000000 -0.002233 0.000660 0.004479 +3506 1 0.000224 1560.000000 -0.000625 0.001355 0.003873 +3507 1 0.000199 1560.000000 0.000994 0.002978 0.002350 +3508 1 0.000200 1560.000000 -0.002810 -0.001561 0.007882 +3509 1 0.000258 1560.000000 0.000878 -0.002430 0.006622 +3510 1 0.000204 1560.000000 -0.000673 0.000727 0.007578 +3511 1 0.000201 1560.000000 0.001402 0.002857 0.003837 +3512 1 0.000215 1560.000000 -0.001307 0.003075 0.002859 +3513 1 0.000228 1560.000000 0.001464 0.002494 0.006747 +3514 1 0.000224 1560.000000 -0.000333 -0.001352 0.005224 +3515 1 0.000207 1560.000000 0.002321 0.000423 0.006731 +3516 1 0.000273 1560.000000 -0.000169 0.000617 0.004741 +3517 1 0.000233 1560.000000 -0.002618 -0.002678 0.000793 +3518 1 0.000222 1560.000000 0.001212 -0.002698 0.009364 +3519 1 0.000235 1560.000000 -0.001351 0.001479 0.002880 +3520 1 0.000232 1560.000000 -0.002593 0.000246 0.009321 +3521 1 0.000278 1560.000000 -0.001406 -0.000983 0.002005 +3522 1 0.000249 1560.000000 0.001515 -0.002525 0.006594 +3523 1 0.000267 1560.000000 0.002576 0.000443 0.008034 +3524 1 0.000201 1560.000000 0.002346 0.001754 0.002214 +3525 1 0.000205 1560.000000 -0.002302 -0.002205 0.007875 +3526 1 0.000274 1560.000000 -0.000475 0.000564 0.006867 +3527 1 0.000196 1560.000000 -0.001323 0.000325 0.003373 +3528 1 0.000242 1560.000000 -0.001756 0.001629 0.007438 +3529 1 0.000229 1560.000000 -0.001103 -0.001671 0.000691 +3530 1 0.000258 1560.000000 -0.001754 0.002132 0.004787 +3531 1 0.000193 1560.000000 -0.001813 0.000372 0.006890 +3532 1 0.000197 1560.000000 0.000505 0.000373 0.004395 +3533 1 0.000246 1560.000000 0.000558 0.001943 0.001806 +3534 1 0.000195 1560.000000 -0.001230 0.002209 0.002834 +3535 1 0.000223 1560.000000 0.000055 -0.001420 0.003191 +3536 1 0.000262 1560.000000 -0.002015 0.000434 0.005125 +3537 1 0.000250 1560.000000 -0.000334 -0.000607 0.007003 +3538 1 0.000234 1560.000000 0.000868 0.000353 0.004849 +3539 1 0.000229 1560.000000 0.000075 0.001569 0.004296 +3540 1 0.000211 1560.000000 0.000201 0.000881 0.001214 +3541 1 0.000236 1560.000000 0.000953 -0.000777 0.001586 +3542 1 0.000232 1560.000000 0.000512 0.001911 0.001042 +3543 1 0.000241 1560.000000 0.001682 0.000942 0.009795 +3544 1 0.000271 1560.000000 0.002261 0.000451 0.002663 +3545 1 0.000221 1560.000000 -0.002617 0.000207 0.002552 +3546 1 0.000208 1560.000000 -0.001723 -0.002672 0.006104 +3547 1 0.000286 1560.000000 -0.000341 -0.003184 0.006388 +3548 1 0.000253 1560.000000 0.001359 0.001430 0.008498 +3549 1 0.000212 1560.000000 -0.001672 0.001319 0.007050 +3550 1 0.000214 1560.000000 -0.000044 0.000487 0.008953 +3551 1 0.000203 1560.000000 0.003522 -0.001222 0.005689 +3552 1 0.000202 1560.000000 0.001812 -0.000021 0.007422 +3553 1 0.000228 1560.000000 -0.000220 -0.000269 0.009370 +3554 1 0.000230 1560.000000 -0.000577 0.001106 0.009396 +3555 1 0.000195 1560.000000 0.001446 0.003501 0.001788 +3556 1 0.000210 1560.000000 -0.002248 -0.002113 0.009798 +3557 1 0.000283 1560.000000 0.001567 -0.000044 0.009240 +3558 1 0.000194 1560.000000 -0.000585 -0.000597 0.004133 +3559 1 0.000205 1560.000000 0.001419 -0.002208 0.000704 +3560 1 0.000284 1560.000000 0.000183 0.001401 0.003290 +3561 1 0.000204 1560.000000 -0.000552 -0.001440 0.001982 +3562 1 0.000267 1560.000000 0.000111 0.001335 0.002897 +3563 1 0.000207 1560.000000 0.002226 0.002087 0.006870 +3564 1 0.000194 1560.000000 0.001915 -0.001971 0.003942 +3565 1 0.000269 1560.000000 0.001101 -0.003209 0.006347 +3566 1 0.000219 1560.000000 0.002351 -0.002542 0.005242 +3567 1 0.000200 1560.000000 -0.001929 0.002862 0.001919 +3568 1 0.000214 1560.000000 0.000094 -0.000181 0.005609 +3569 1 0.000231 1560.000000 0.000478 -0.001654 0.000167 +3570 1 0.000273 1560.000000 0.000278 -0.001789 0.000246 +3571 1 0.000206 1560.000000 0.000638 0.001051 0.008304 +3572 1 0.000203 1560.000000 -0.000754 -0.001239 0.000682 +3573 1 0.000216 1560.000000 -0.001371 0.000430 0.000816 +3574 1 0.000239 1560.000000 -0.000387 -0.000848 0.003303 +3575 1 0.000234 1560.000000 0.000054 -0.000959 0.008589 +3576 1 0.000203 1560.000000 -0.001265 -0.003135 0.003740 +3577 1 0.000269 1560.000000 0.001610 0.000312 0.008851 +3578 1 0.000273 1560.000000 0.001832 0.002339 0.006568 +3579 1 0.000281 1560.000000 -0.000222 -0.001363 0.005999 +3580 1 0.000221 1560.000000 -0.002833 0.001544 0.003411 +3581 1 0.000247 1560.000000 -0.002431 0.001555 0.005317 +3582 1 0.000251 1560.000000 -0.000839 -0.001944 0.007480 +3583 1 0.000228 1560.000000 0.000766 -0.000423 0.003748 +3584 1 0.000195 1560.000000 -0.000118 0.002295 0.009537 +3585 1 0.000233 1560.000000 -0.003422 0.000066 0.004229 +3586 1 0.000240 1560.000000 0.000256 -0.003495 0.004356 +3587 1 0.000210 1560.000000 0.001917 0.000762 0.004347 +3588 1 0.000250 1560.000000 0.001445 -0.001509 0.001176 +3589 1 0.000264 1560.000000 0.000026 -0.001474 0.002898 +3590 1 0.000209 1560.000000 -0.000842 0.000289 0.002713 +3591 1 0.000257 1560.000000 0.000198 0.000957 0.006794 +3592 1 0.000242 1560.000000 0.000629 -0.000807 0.009165 +3593 1 0.000247 1560.000000 0.001129 0.001093 0.009403 +3594 1 0.000236 1560.000000 -0.000674 0.000525 0.008985 +3595 1 0.000203 1560.000000 -0.002907 0.001861 0.001063 +3596 1 0.000275 1560.000000 -0.001834 0.000635 0.005761 +3597 1 0.000252 1560.000000 0.001320 -0.000268 0.005972 +3598 1 0.000210 1560.000000 0.003643 0.000267 0.008565 +3599 1 0.000196 1560.000000 -0.000722 0.001300 0.004256 +3600 1 0.000209 1560.000000 0.000133 -0.000050 0.007312 +3601 1 0.000234 1560.000000 0.003177 0.000783 0.000656 +3602 1 0.000261 1560.000000 -0.001896 -0.002100 0.001347 +3603 1 0.000208 1560.000000 -0.000191 0.002252 0.002705 +3604 1 0.000250 1560.000000 0.000101 -0.000536 0.005725 +3605 1 0.000206 1560.000000 -0.001386 -0.003172 0.001442 +3606 1 0.000282 1560.000000 0.001652 0.000573 0.009296 +3607 1 0.000285 1560.000000 0.000061 0.001215 0.005578 +3608 1 0.000196 1560.000000 0.000625 -0.001549 0.004031 +3609 1 0.000212 1560.000000 -0.000282 0.002344 0.000350 +3610 1 0.000217 1560.000000 -0.001431 0.003318 0.004027 +3611 1 0.000226 1560.000000 0.001610 -0.003503 0.009578 +3612 1 0.000253 1560.000000 0.001930 -0.003060 0.004121 +3613 1 0.000243 1560.000000 -0.001657 -0.001112 0.006710 +3614 1 0.000192 1560.000000 -0.002961 -0.000935 0.005415 +3615 1 0.000281 1560.000000 0.001171 0.002481 0.000956 +3616 1 0.000233 1560.000000 -0.003151 0.000304 0.004811 +3617 1 0.000278 1560.000000 0.003492 -0.001595 0.009396 +3618 1 0.000222 1560.000000 0.000175 0.000439 0.002787 +3619 1 0.000274 1560.000000 0.001949 -0.002479 0.004985 +3620 1 0.000254 1560.000000 -0.000479 -0.003655 0.005129 +3621 1 0.000256 1560.000000 -0.003290 -0.001657 0.003438 +3622 1 0.000208 1560.000000 -0.002394 0.002669 0.001641 +3623 1 0.000245 1560.000000 0.001105 0.001292 0.007979 +3624 1 0.000224 1560.000000 -0.000023 -0.003008 0.006248 +3625 1 0.000219 1560.000000 0.001310 -0.001765 0.000873 +3626 1 0.000233 1560.000000 0.000774 -0.000699 0.003548 +3627 1 0.000284 1560.000000 -0.000153 0.000928 0.002445 +3628 1 0.000240 1560.000000 0.002285 -0.000920 0.007224 +3629 1 0.000209 1560.000000 -0.002572 0.001943 0.006905 +3630 1 0.000244 1560.000000 -0.000112 0.001668 0.007893 +3631 1 0.000193 1560.000000 -0.001266 0.000137 0.003675 +3632 1 0.000216 1560.000000 0.001653 -0.000380 0.002215 +3633 1 0.000257 1560.000000 0.001754 0.001791 0.005963 +3634 1 0.000214 1560.000000 -0.002799 -0.001494 0.003946 +3635 1 0.000252 1560.000000 0.001822 -0.003123 0.004408 +3636 1 0.000266 1560.000000 0.003384 0.001467 0.006465 +3637 1 0.000215 1560.000000 0.000598 -0.001200 0.002951 +3638 1 0.000218 1560.000000 -0.000552 0.000681 0.008651 +3639 1 0.000229 1560.000000 0.001342 0.001410 0.006575 +3640 1 0.000281 1560.000000 -0.000880 0.003124 0.000395 +3641 1 0.000200 1560.000000 0.001696 -0.000987 0.007124 +3642 1 0.000230 1560.000000 0.000644 -0.003267 0.009484 +3643 1 0.000217 1560.000000 0.000760 -0.000622 0.006206 +3644 1 0.000272 1560.000000 -0.000491 0.000950 0.005892 +3645 1 0.000276 1560.000000 -0.002175 0.002773 0.004473 +3646 1 0.000213 1560.000000 0.003133 0.000021 0.008311 +3647 1 0.000224 1560.000000 0.002487 -0.000608 0.000806 +3648 1 0.000215 1560.000000 -0.000281 -0.000169 0.002730 +3649 1 0.000277 1560.000000 -0.002064 0.002043 0.001021 +3650 1 0.000229 1560.000000 0.000397 -0.000066 0.004069 +3651 1 0.000212 1560.000000 0.001649 -0.000032 0.006446 +3652 1 0.000201 1560.000000 -0.001022 0.000604 0.000500 +3653 1 0.000215 1560.000000 0.003170 -0.002159 0.000611 +3654 1 0.000273 1560.000000 0.001879 -0.000470 0.003484 +3655 1 0.000196 1560.000000 0.002744 0.001629 0.003585 +3656 1 0.000241 1560.000000 0.001387 0.003258 0.002106 +3657 1 0.000274 1560.000000 -0.002968 -0.002005 0.004413 +3658 1 0.000259 1560.000000 -0.001183 0.001526 0.005266 +3659 1 0.000266 1560.000000 0.000637 -0.003304 0.007462 +3660 1 0.000198 1560.000000 -0.000962 0.003470 0.003641 +3661 1 0.000224 1560.000000 -0.001822 0.001411 0.006424 +3662 1 0.000234 1560.000000 0.002424 0.001553 0.004776 +3663 1 0.000198 1560.000000 0.000573 0.000682 0.000601 +3664 1 0.000224 1560.000000 0.000715 0.000159 0.002790 +3665 1 0.000251 1560.000000 0.000593 -0.000222 0.007435 +3666 1 0.000255 1560.000000 -0.000865 0.002069 0.004210 +3667 1 0.000230 1560.000000 0.000765 -0.001457 0.004822 +3668 1 0.000195 1560.000000 0.000867 -0.003120 0.004672 +3669 1 0.000212 1560.000000 0.001407 -0.002820 0.008663 +3670 1 0.000261 1560.000000 0.000268 -0.001550 0.001852 +3671 1 0.000255 1560.000000 -0.001801 0.000053 0.004478 +3672 1 0.000286 1560.000000 -0.001377 -0.001531 0.002170 +3673 1 0.000200 1560.000000 0.000177 -0.002565 0.004768 +3674 1 0.000274 1560.000000 0.002096 -0.002882 0.008826 +3675 1 0.000209 1560.000000 0.000509 -0.002766 0.002043 +3676 1 0.000214 1560.000000 -0.000306 -0.001791 0.000948 +3677 1 0.000199 1560.000000 -0.002034 -0.001277 0.006619 +3678 1 0.000267 1560.000000 0.000439 0.002586 0.004744 +3679 1 0.000240 1560.000000 -0.000992 0.000861 0.008687 +3680 1 0.000266 1560.000000 0.000803 0.000033 0.001014 +3681 1 0.000234 1560.000000 0.000545 -0.003297 0.001754 +3682 1 0.000221 1560.000000 0.003745 0.000767 0.003171 +3683 1 0.000240 1560.000000 0.002482 -0.000158 0.004476 +3684 1 0.000222 1560.000000 0.001650 -0.001473 0.008897 +3685 1 0.000254 1560.000000 -0.001634 -0.000163 0.009657 +3686 1 0.000200 1560.000000 -0.000522 0.002420 0.000732 +3687 1 0.000284 1560.000000 0.000856 -0.001794 0.006008 +3688 1 0.000234 1560.000000 0.003026 0.001088 0.000634 +3689 1 0.000279 1560.000000 0.002783 0.002350 0.009122 +3690 1 0.000220 1560.000000 -0.000652 -0.000064 0.007972 +3691 1 0.000225 1560.000000 -0.002394 0.002564 0.002902 +3692 1 0.000259 1560.000000 -0.001914 0.001543 0.004739 +3693 1 0.000256 1560.000000 -0.001355 -0.000385 0.008543 +3694 1 0.000287 1560.000000 -0.002850 -0.000052 0.005077 +3695 1 0.000287 1560.000000 0.000617 -0.000492 0.004524 +3696 1 0.000210 1560.000000 -0.002315 -0.001005 0.005984 +3697 1 0.000205 1560.000000 -0.000415 0.000445 0.000734 +3698 1 0.000249 1560.000000 0.002520 0.000153 0.004004 +3699 1 0.000266 1560.000000 0.000540 -0.002767 0.005279 +3700 1 0.000266 1560.000000 -0.001962 0.002492 0.000744 +3701 1 0.000209 1560.000000 -0.000407 -0.000208 0.006206 +3702 1 0.000194 1560.000000 0.003364 0.000941 0.004984 +3703 1 0.000230 1560.000000 0.000351 0.001820 0.007940 +3704 1 0.000211 1560.000000 -0.000561 0.000287 0.008613 +3705 1 0.000240 1560.000000 0.000691 -0.001397 0.009460 +3706 1 0.000250 1560.000000 0.003133 -0.001348 0.008652 +3707 1 0.000193 1560.000000 0.003062 0.002098 0.006666 +3708 1 0.000263 1560.000000 0.000301 0.000145 0.005382 +3709 1 0.000244 1560.000000 -0.002259 -0.001382 0.008931 +3710 1 0.000194 1560.000000 -0.000944 -0.002839 0.000725 +3711 1 0.000261 1560.000000 0.000791 0.000319 0.004163 +3712 1 0.000217 1560.000000 0.002463 0.001180 0.002146 +3713 1 0.000249 1560.000000 0.000632 -0.000120 0.005483 +3714 1 0.000198 1560.000000 0.000349 -0.002320 0.008309 +3715 1 0.000230 1560.000000 0.000696 0.002069 0.003220 +3716 1 0.000193 1560.000000 -0.000732 -0.001223 0.000330 +3717 1 0.000232 1560.000000 -0.000408 0.000114 0.009253 +3718 1 0.000205 1560.000000 0.000501 0.001965 0.008765 +3719 1 0.000195 1560.000000 0.002657 -0.000737 0.003560 +3720 1 0.000227 1560.000000 0.001411 -0.000983 0.005381 +3721 1 0.000277 1560.000000 -0.002888 0.000559 0.005522 +3722 1 0.000194 1560.000000 -0.002879 0.000635 0.003505 +3723 1 0.000193 1560.000000 -0.002124 -0.000446 0.007051 +3724 1 0.000247 1560.000000 0.002717 -0.000444 0.007407 +3725 1 0.000215 1560.000000 -0.001713 0.002368 0.009813 +3726 1 0.000223 1560.000000 0.000036 -0.001924 0.009644 +3727 1 0.000209 1560.000000 0.001815 0.000800 0.002050 +3728 1 0.000207 1560.000000 -0.001476 -0.000145 0.008567 +3729 1 0.000270 1560.000000 -0.002040 0.000370 0.002623 +3730 1 0.000204 1560.000000 0.002979 -0.001715 0.008840 +3731 1 0.000203 1560.000000 0.002478 -0.000129 0.009436 +3732 1 0.000264 1560.000000 0.001523 0.003145 0.006220 +3733 1 0.000287 1560.000000 -0.003309 0.000051 0.000708 +3734 1 0.000243 1560.000000 -0.003568 -0.001130 0.005256 +3735 1 0.000265 1560.000000 -0.000901 -0.002389 0.008328 +3736 1 0.000211 1560.000000 0.000040 -0.001910 0.002011 +3737 1 0.000204 1560.000000 0.000405 -0.002089 0.008688 +3738 1 0.000284 1560.000000 0.002624 0.001253 0.001799 +3739 1 0.000203 1560.000000 -0.000456 -0.000711 0.000295 +3740 1 0.000223 1560.000000 -0.001063 -0.001954 0.002679 +3741 1 0.000215 1560.000000 -0.001047 -0.001249 0.007418 +3742 1 0.000222 1560.000000 -0.000439 -0.001309 0.006911 +3743 1 0.000236 1560.000000 0.000555 -0.002387 0.002629 +3744 1 0.000245 1560.000000 0.003147 0.000943 0.004889 +3745 1 0.000284 1560.000000 0.000347 0.000164 0.006137 +3746 1 0.000223 1560.000000 -0.001462 0.002136 0.008590 +3747 1 0.000270 1560.000000 -0.003105 0.002086 0.003200 +3748 1 0.000223 1560.000000 -0.000447 -0.003410 0.009228 +3749 1 0.000197 1560.000000 -0.000248 0.000375 0.008891 +3750 1 0.000202 1560.000000 -0.000093 -0.002220 0.008237 +3751 1 0.000202 1560.000000 0.001656 0.000994 0.009527 +3752 1 0.000197 1560.000000 -0.000957 -0.003096 0.002696 +3753 1 0.000214 1560.000000 -0.000424 -0.002839 0.001858 +3754 1 0.000258 1560.000000 -0.000777 -0.000359 0.001499 +3755 1 0.000255 1560.000000 -0.003230 -0.000184 0.002195 +3756 1 0.000284 1560.000000 0.000508 0.001383 0.006395 +3757 1 0.000234 1560.000000 -0.002951 -0.000290 0.000538 +3758 1 0.000249 1560.000000 0.000653 -0.002940 0.006435 +3759 1 0.000195 1560.000000 -0.000256 -0.002179 0.007250 +3760 1 0.000222 1560.000000 0.000492 -0.003617 0.006223 +3761 1 0.000206 1560.000000 0.000662 -0.002318 0.009721 +3762 1 0.000258 1560.000000 -0.001765 -0.003052 0.006491 +3763 1 0.000200 1560.000000 -0.000049 -0.000064 0.005074 +3764 1 0.000211 1560.000000 -0.003300 -0.000987 0.005437 +3765 1 0.000208 1560.000000 -0.002346 0.001563 0.001309 +3766 1 0.000221 1560.000000 0.001038 0.002927 0.004677 +3767 1 0.000210 1560.000000 -0.002857 -0.000667 0.005361 +3768 1 0.000202 1560.000000 -0.002559 0.000271 0.006267 +3769 1 0.000196 1560.000000 0.001424 -0.001733 0.008014 +3770 1 0.000217 1560.000000 0.000763 -0.001697 0.007602 +3771 1 0.000204 1560.000000 0.000308 0.001263 0.006735 +3772 1 0.000227 1560.000000 0.000305 -0.000155 0.002029 +3773 1 0.000286 1560.000000 0.000920 -0.003727 0.007116 +3774 1 0.000224 1560.000000 -0.002051 0.001185 0.005424 +3775 1 0.000256 1560.000000 0.001516 0.003452 0.008234 +3776 1 0.000279 1560.000000 0.000542 -0.000905 0.005864 +3777 1 0.000218 1560.000000 -0.001943 0.001655 0.008940 +3778 1 0.000247 1560.000000 0.003214 -0.001246 0.006094 +3779 1 0.000255 1560.000000 -0.003324 -0.000076 0.006991 +3780 1 0.000199 1560.000000 -0.001096 0.001963 0.004239 +3781 1 0.000222 1560.000000 0.002086 0.001772 0.006602 +3782 1 0.000196 1560.000000 0.002569 0.001504 0.008986 +3783 1 0.000256 1560.000000 -0.002852 0.002366 0.001276 +3784 1 0.000208 1560.000000 0.000402 0.000753 0.009140 +3785 1 0.000275 1560.000000 0.002643 0.000467 0.003903 +3786 1 0.000281 1560.000000 0.000398 -0.001866 0.001343 +3787 1 0.000246 1560.000000 0.001421 -0.001763 0.004715 +3788 1 0.000239 1560.000000 0.002286 0.000616 0.006042 +3789 1 0.000216 1560.000000 0.003152 -0.000498 0.008052 +3790 1 0.000268 1560.000000 -0.001984 0.001906 0.002708 +3791 1 0.000229 1560.000000 0.001751 -0.001486 0.001899 +3792 1 0.000252 1560.000000 -0.000599 0.001685 0.006383 +3793 1 0.000209 1560.000000 0.000662 0.000965 0.003112 +3794 1 0.000283 1560.000000 -0.001462 0.000890 0.007975 +3795 1 0.000287 1560.000000 -0.001300 0.003045 0.007891 +3796 1 0.000214 1560.000000 0.002412 -0.001845 0.001993 +3797 1 0.000230 1560.000000 -0.002275 -0.002417 0.003398 +3798 1 0.000196 1560.000000 -0.000155 0.001450 0.008440 +3799 1 0.000200 1560.000000 -0.000862 -0.002288 0.003723 +3800 1 0.000271 1560.000000 0.001921 -0.000539 0.007708 +3801 1 0.000244 1560.000000 0.000894 0.001367 0.008456 +3802 1 0.000199 1560.000000 0.000322 0.002508 0.003044 +3803 1 0.000202 1560.000000 0.000244 0.000852 0.004444 +3804 1 0.000277 1560.000000 -0.001287 0.000814 0.001079 +3805 1 0.000235 1560.000000 -0.000060 -0.000997 0.003216 +3806 1 0.000252 1560.000000 0.002661 0.002262 0.001282 +3807 1 0.000206 1560.000000 0.002420 0.001228 0.002955 +3808 1 0.000225 1560.000000 -0.001317 0.001531 0.004779 +3809 1 0.000215 1560.000000 -0.001351 -0.001378 0.007470 +3810 1 0.000233 1560.000000 0.002745 0.000646 0.001274 +3811 1 0.000234 1560.000000 0.001352 -0.000509 0.006453 +3812 1 0.000225 1560.000000 0.002611 -0.001661 0.006671 +3813 1 0.000206 1560.000000 0.000368 0.002008 0.006116 +3814 1 0.000255 1560.000000 -0.002682 0.000281 0.007958 +3815 1 0.000231 1560.000000 -0.002628 -0.001005 0.002568 +3816 1 0.000272 1560.000000 0.003577 -0.000111 0.002846 +3817 1 0.000254 1560.000000 -0.000288 -0.000232 0.007921 +3818 1 0.000240 1560.000000 0.001673 0.001144 0.004312 +3819 1 0.000202 1560.000000 -0.000130 0.000574 0.008368 +3820 1 0.000278 1560.000000 0.000414 -0.000999 0.000757 +3821 1 0.000266 1560.000000 -0.000000 0.000922 0.002720 +3822 1 0.000195 1560.000000 -0.001986 -0.000822 0.004713 +3823 1 0.000195 1560.000000 -0.001388 -0.000083 0.000298 +3824 1 0.000275 1560.000000 0.000371 0.000337 0.001124 +3825 1 0.000200 1560.000000 -0.000937 -0.003143 0.009315 +3826 1 0.000285 1560.000000 -0.001148 -0.001632 0.008576 +3827 1 0.000226 1560.000000 -0.001498 0.002216 0.002016 +3828 1 0.000286 1560.000000 0.001623 0.000021 0.001412 +3829 1 0.000245 1560.000000 0.002247 -0.000159 0.005230 +3830 1 0.000259 1560.000000 0.002974 0.001401 0.007453 +3831 1 0.000243 1560.000000 -0.001945 0.002730 0.002112 +3832 1 0.000194 1560.000000 -0.001875 0.002772 0.009686 +3833 1 0.000220 1560.000000 0.000791 -0.000350 0.007603 +3834 1 0.000239 1560.000000 0.001463 -0.003166 0.007629 +3835 1 0.000284 1560.000000 -0.000720 0.003420 0.000732 +3836 1 0.000200 1560.000000 0.002413 0.001677 0.005630 +3837 1 0.000250 1560.000000 -0.000335 -0.000596 0.009280 +3838 1 0.000262 1560.000000 0.002852 -0.000157 0.002694 +3839 1 0.000228 1560.000000 0.002326 -0.002287 0.004048 +3840 1 0.000248 1560.000000 0.002245 0.000056 0.003480 +3841 1 0.000267 1560.000000 0.002228 0.002880 0.005246 +3842 1 0.000256 1560.000000 -0.002585 0.001372 0.007136 +3843 1 0.000281 1560.000000 -0.003530 0.000953 0.005202 +3844 1 0.000206 1560.000000 0.001526 -0.001791 0.001912 +3845 1 0.000200 1560.000000 -0.000137 -0.000711 0.009680 +3846 1 0.000274 1560.000000 -0.001027 -0.002082 0.002144 +3847 1 0.000220 1560.000000 0.002630 -0.001950 0.006649 +3848 1 0.000212 1560.000000 0.002391 -0.000883 0.004175 +3849 1 0.000286 1560.000000 0.001606 0.000225 0.009139 +3850 1 0.000197 1560.000000 0.000365 -0.001723 0.006458 +3851 1 0.000228 1560.000000 0.000632 -0.002936 0.008977 +3852 1 0.000194 1560.000000 -0.002654 -0.000912 0.006000 +3853 1 0.000235 1560.000000 0.002452 0.000590 0.003061 +3854 1 0.000205 1560.000000 0.000348 0.001877 0.003193 +3855 1 0.000198 1560.000000 -0.001223 0.001177 0.009290 +3856 1 0.000240 1560.000000 0.002814 0.002373 0.009806 +3857 1 0.000199 1560.000000 -0.003236 0.001912 0.004898 +3858 1 0.000242 1560.000000 0.002178 -0.000946 0.009391 +3859 1 0.000217 1560.000000 0.001375 0.003596 0.004015 +3860 1 0.000199 1560.000000 0.000242 0.000694 0.007707 +3861 1 0.000266 1560.000000 -0.002175 0.001850 0.008298 +3862 1 0.000214 1560.000000 0.000236 -0.003166 0.008287 +3863 1 0.000236 1560.000000 -0.000736 -0.000371 0.005843 +3864 1 0.000200 1560.000000 -0.002967 -0.001007 0.002617 +3865 1 0.000227 1560.000000 0.003088 -0.000309 0.009688 +3866 1 0.000201 1560.000000 0.002012 -0.000330 0.001647 +3867 1 0.000251 1560.000000 0.003737 -0.000380 0.001960 +3868 1 0.000252 1560.000000 0.001248 -0.000081 0.009793 +3869 1 0.000194 1560.000000 0.002567 -0.000284 0.004681 +3870 1 0.000241 1560.000000 -0.000379 -0.002541 0.009092 +3871 1 0.000215 1560.000000 -0.000947 -0.000753 0.009121 +3872 1 0.000235 1560.000000 0.003041 0.001826 0.009384 +3873 1 0.000260 1560.000000 -0.000439 0.000778 0.009679 +3874 1 0.000288 1560.000000 -0.000677 0.003773 0.001910 +3875 1 0.000244 1560.000000 0.003535 -0.000880 0.008047 +3876 1 0.000240 1560.000000 -0.000347 0.001809 0.001149 +3877 1 0.000236 1560.000000 -0.002496 -0.000402 0.007979 +3878 1 0.000240 1560.000000 0.000015 -0.001554 0.002238 +3879 1 0.000240 1560.000000 -0.003060 -0.001017 0.007845 +3880 1 0.000222 1560.000000 -0.002457 0.002084 0.002662 +3881 1 0.000245 1560.000000 0.000132 0.002298 0.001040 +3882 1 0.000226 1560.000000 0.001132 0.000838 0.000232 +3883 1 0.000221 1560.000000 0.001797 0.002050 0.002849 +3884 1 0.000267 1560.000000 -0.002081 0.000846 0.007550 +3885 1 0.000268 1560.000000 -0.002029 0.000938 0.004233 +3886 1 0.000251 1560.000000 -0.001216 0.002001 0.003517 +3887 1 0.000203 1560.000000 -0.000752 0.000395 0.008752 +3888 1 0.000199 1560.000000 -0.001685 -0.002483 0.003658 +3889 1 0.000217 1560.000000 -0.002379 -0.002912 0.007171 +3890 1 0.000268 1560.000000 0.000329 0.001617 0.007411 +3891 1 0.000245 1560.000000 -0.003140 0.001591 0.008802 +3892 1 0.000272 1560.000000 0.001812 -0.002595 0.008366 +3893 1 0.000280 1560.000000 -0.001941 0.000367 0.007776 +3894 1 0.000197 1560.000000 0.000376 -0.001117 0.007952 +3895 1 0.000213 1560.000000 0.002674 -0.001947 0.007767 +3896 1 0.000230 1560.000000 -0.000077 -0.000167 0.006880 +3897 1 0.000214 1560.000000 0.001097 -0.002747 0.001110 +3898 1 0.000233 1560.000000 0.003095 0.001951 0.002970 +3899 1 0.000195 1560.000000 -0.002407 -0.001451 0.005615 +3900 1 0.000203 1560.000000 -0.000018 -0.001328 0.004200 +3901 1 0.000266 1560.000000 0.002566 -0.002025 0.002629 +3902 1 0.000265 1560.000000 -0.000093 0.002239 0.005430 +3903 1 0.000270 1560.000000 -0.002018 -0.001843 0.003763 +3904 1 0.000233 1560.000000 0.001061 0.002727 0.001726 +3905 1 0.000201 1560.000000 -0.001836 -0.001782 0.001182 +3906 1 0.000277 1560.000000 -0.001510 -0.002374 0.009293 +3907 1 0.000269 1560.000000 -0.001825 -0.000114 0.002934 +3908 1 0.000275 1560.000000 0.000171 0.001428 0.003999 +3909 1 0.000210 1560.000000 0.000464 0.003110 0.008814 +3910 1 0.000227 1560.000000 -0.000836 -0.001394 0.004563 +3911 1 0.000246 1560.000000 0.000397 0.003567 0.008970 +3912 1 0.000197 1560.000000 -0.001327 -0.001240 0.004020 +3913 1 0.000195 1560.000000 0.000688 -0.003686 0.000255 +3914 1 0.000235 1560.000000 -0.001896 -0.002147 0.003910 +3915 1 0.000283 1560.000000 -0.001635 0.003432 0.005550 +3916 1 0.000218 1560.000000 -0.002608 0.000526 0.006155 +3917 1 0.000223 1560.000000 -0.000484 -0.002856 0.009299 +3918 1 0.000207 1560.000000 -0.002295 -0.000662 0.001883 +3919 1 0.000214 1560.000000 -0.000665 -0.001017 0.000144 +3920 1 0.000197 1560.000000 -0.001275 -0.001332 0.008926 +3921 1 0.000208 1560.000000 -0.002009 -0.000318 0.003863 +3922 1 0.000197 1560.000000 -0.000543 -0.002496 0.001071 +3923 1 0.000193 1560.000000 -0.001742 0.001159 0.007547 +3924 1 0.000209 1560.000000 -0.001497 0.001898 0.009115 +3925 1 0.000278 1560.000000 0.001642 -0.000242 0.005851 +3926 1 0.000244 1560.000000 0.003502 0.001046 0.000467 +3927 1 0.000202 1560.000000 0.001733 0.001504 0.004509 +3928 1 0.000227 1560.000000 -0.000164 -0.000350 0.003141 +3929 1 0.000213 1560.000000 0.001825 0.002118 0.009253 +3930 1 0.000225 1560.000000 -0.002168 0.000504 0.007528 +3931 1 0.000204 1560.000000 -0.000151 -0.002392 0.008563 +3932 1 0.000206 1560.000000 -0.001811 0.001799 0.003410 +3933 1 0.000214 1560.000000 0.000962 -0.001609 0.003410 +3934 1 0.000251 1560.000000 0.000952 -0.001466 0.000581 +3935 1 0.000221 1560.000000 -0.001941 -0.002342 0.005155 +3936 1 0.000276 1560.000000 -0.000197 0.002936 0.008932 +3937 1 0.000216 1560.000000 -0.002389 0.001571 0.006744 +3938 1 0.000240 1560.000000 -0.003657 -0.000022 0.005586 +3939 1 0.000260 1560.000000 -0.000855 0.002737 0.000413 +3940 1 0.000268 1560.000000 -0.002874 -0.001213 0.001415 +3941 1 0.000238 1560.000000 0.000942 -0.003028 0.001368 +3942 1 0.000210 1560.000000 -0.000391 -0.000005 0.002625 +3943 1 0.000239 1560.000000 0.000724 -0.002096 0.006718 +3944 1 0.000203 1560.000000 -0.000123 -0.000523 0.003330 +3945 1 0.000245 1560.000000 -0.001896 0.002333 0.003511 +3946 1 0.000211 1560.000000 0.000965 0.002710 0.001347 +3947 1 0.000220 1560.000000 -0.000156 -0.000591 0.008219 +3948 1 0.000217 1560.000000 0.000412 0.002131 0.001177 +3949 1 0.000275 1560.000000 0.002951 -0.001369 0.003999 +3950 1 0.000193 1560.000000 0.001512 0.001083 0.006842 +3951 1 0.000236 1560.000000 -0.001028 0.001124 0.001626 +3952 1 0.000253 1560.000000 0.001793 0.001835 0.008711 +3953 1 0.000202 1560.000000 0.003609 0.001008 0.000759 +3954 1 0.000196 1560.000000 -0.003124 0.000373 0.002006 +3955 1 0.000238 1560.000000 -0.000698 0.001678 0.003669 +3956 1 0.000279 1560.000000 -0.000093 0.001397 0.003881 +3957 1 0.000216 1560.000000 0.001946 -0.001306 0.006363 +3958 1 0.000286 1560.000000 -0.002367 0.000141 0.005100 +3959 1 0.000212 1560.000000 -0.000876 0.000005 0.005231 +3960 1 0.000210 1560.000000 0.000700 -0.000171 0.001965 +3961 1 0.000217 1560.000000 -0.000195 -0.002576 0.005993 +3962 1 0.000275 1560.000000 0.002190 -0.001651 0.000583 +3963 1 0.000280 1560.000000 0.001272 0.000110 0.007938 +3964 1 0.000205 1560.000000 -0.000020 -0.001499 0.009108 +3965 1 0.000227 1560.000000 -0.000217 -0.002760 0.009318 +3966 1 0.000240 1560.000000 0.002088 0.001815 0.003745 +3967 1 0.000231 1560.000000 0.002895 0.001978 0.006331 +3968 1 0.000254 1560.000000 -0.001532 -0.002279 0.008917 +3969 1 0.000269 1560.000000 -0.001054 0.000490 0.000939 +3970 1 0.000275 1560.000000 -0.000720 -0.001574 0.003638 +3971 1 0.000227 1560.000000 0.001277 -0.002861 0.004678 +3972 1 0.000273 1560.000000 0.002279 -0.001126 0.004685 +3973 1 0.000249 1560.000000 -0.001254 0.001202 0.006282 +3974 1 0.000265 1560.000000 0.002726 0.000180 0.009693 +3975 1 0.000198 1560.000000 0.000252 0.003520 0.002605 +3976 1 0.000236 1560.000000 0.000886 -0.000542 0.009689 +3977 1 0.000208 1560.000000 0.001490 0.002299 0.004351 +3978 1 0.000259 1560.000000 -0.002981 0.000012 0.002192 +3979 1 0.000254 1560.000000 -0.003730 0.000287 0.008159 +3980 1 0.000256 1560.000000 -0.003336 0.000941 0.001538 +3981 1 0.000284 1560.000000 0.000570 0.001289 0.009822 +3982 1 0.000206 1560.000000 -0.000527 -0.002658 0.001788 +3983 1 0.000262 1560.000000 -0.001889 0.000626 0.008110 +3984 1 0.000204 1560.000000 -0.000841 -0.003653 0.005840 +3985 1 0.000209 1560.000000 -0.000993 -0.003725 0.005439 +3986 1 0.000230 1560.000000 0.000208 0.001579 0.006072 +3987 1 0.000197 1560.000000 -0.002024 0.001051 0.007992 +3988 1 0.000203 1560.000000 0.000921 0.000810 0.003734 +3989 1 0.000260 1560.000000 0.002239 -0.001263 0.005077 +3990 1 0.000279 1560.000000 -0.000739 0.001228 0.004738 +3991 1 0.000247 1560.000000 0.001538 0.000439 0.001413 +3992 1 0.000210 1560.000000 -0.002302 -0.001845 0.000547 +3993 1 0.000228 1560.000000 0.002939 -0.001969 0.008700 +3994 1 0.000199 1560.000000 0.000824 -0.001158 0.003086 +3995 1 0.000255 1560.000000 -0.000856 -0.001971 0.006740 +3996 1 0.000269 1560.000000 0.001557 0.001178 0.003659 +3997 1 0.000252 1560.000000 0.000430 0.000143 0.001589 +3998 1 0.000197 1560.000000 0.000092 -0.000297 0.002819 +3999 1 0.000280 1560.000000 -0.000431 0.000718 0.001700 +4000 1 0.000202 1560.000000 0.000139 0.001344 0.007500 +4001 1 0.000276 1560.000000 -0.001848 -0.000285 0.006453 +4002 1 0.000212 1560.000000 0.000461 -0.000279 0.001838 +4003 1 0.000196 1560.000000 -0.002539 0.002655 0.006848 +4004 1 0.000217 1560.000000 0.000830 -0.002631 0.001865 +4005 1 0.000239 1560.000000 -0.002419 -0.000300 0.005543 +4006 1 0.000206 1560.000000 -0.000299 0.001953 0.007330 +4007 1 0.000209 1560.000000 0.001220 0.003108 0.008107 +4008 1 0.000222 1560.000000 -0.001503 -0.001265 0.002567 +4009 1 0.000212 1560.000000 -0.000576 0.002468 0.007244 +4010 1 0.000196 1560.000000 -0.000263 -0.002874 0.006507 +4011 1 0.000279 1560.000000 0.000087 -0.003762 0.006365 +4012 1 0.000205 1560.000000 0.000371 -0.001864 0.002924 +4013 1 0.000209 1560.000000 -0.002114 0.002433 0.004148 +4014 1 0.000217 1560.000000 0.000769 0.003486 0.006922 +4015 1 0.000279 1560.000000 -0.001811 -0.003240 0.009242 +4016 1 0.000267 1560.000000 0.002829 0.000158 0.009317 +4017 1 0.000206 1560.000000 0.000225 -0.001303 0.006146 +4018 1 0.000219 1560.000000 0.003048 0.001913 0.009765 +4019 1 0.000197 1560.000000 -0.001922 0.003221 0.000288 +4020 1 0.000235 1560.000000 0.000150 -0.002068 0.006714 +4021 1 0.000207 1560.000000 -0.000750 0.003050 0.002559 +4022 1 0.000265 1560.000000 0.001632 0.002188 0.007504 +4023 1 0.000224 1560.000000 -0.002336 0.000293 0.008991 +4024 1 0.000219 1560.000000 -0.001056 0.000070 0.007253 +4025 1 0.000254 1560.000000 -0.000281 0.002485 0.003388 +4026 1 0.000195 1560.000000 -0.000564 0.000187 0.005767 +4027 1 0.000197 1560.000000 -0.003409 -0.001155 0.009645 +4028 1 0.000269 1560.000000 -0.001596 -0.001380 0.004782 +4029 1 0.000204 1560.000000 0.000529 -0.000518 0.000542 +4030 1 0.000281 1560.000000 0.000456 -0.000384 0.005399 +4031 1 0.000238 1560.000000 0.001088 -0.000577 0.007383 +4032 1 0.000196 1560.000000 -0.002796 -0.000680 0.007440 +4033 1 0.000199 1560.000000 -0.001331 0.000254 0.007043 +4034 1 0.000242 1560.000000 -0.000058 -0.002630 0.008499 +4035 1 0.000251 1560.000000 0.001007 -0.001949 0.007225 +4036 1 0.000248 1560.000000 -0.000083 -0.002306 0.001441 +4037 1 0.000193 1560.000000 -0.000314 -0.000334 0.007426 +4038 1 0.000217 1560.000000 0.001830 -0.001545 0.006996 +4039 1 0.000255 1560.000000 0.001779 0.001144 0.007137 +4040 1 0.000199 1560.000000 0.001443 -0.001913 0.007489 +4041 1 0.000226 1560.000000 0.002486 0.000822 0.006509 +4042 1 0.000245 1560.000000 0.000741 0.001488 0.006072 +4043 1 0.000270 1560.000000 0.001244 -0.003514 0.008740 +4044 1 0.000244 1560.000000 0.001033 -0.003185 0.007325 +4045 1 0.000227 1560.000000 0.000726 -0.001786 0.001225 +4046 1 0.000244 1560.000000 -0.003453 -0.000832 0.000241 +4047 1 0.000229 1560.000000 0.000110 0.003094 0.007674 +4048 1 0.000254 1560.000000 0.002408 0.001410 0.005870 +4049 1 0.000258 1560.000000 -0.003309 0.001389 0.001164 +4050 1 0.000214 1560.000000 -0.001496 0.000978 0.007216 +4051 1 0.000201 1560.000000 0.001884 0.001749 0.007143 +4052 1 0.000239 1560.000000 -0.002396 0.000028 0.001732 +4053 1 0.000199 1560.000000 0.001788 0.001103 0.005511 +4054 1 0.000261 1560.000000 0.000641 0.003777 0.002223 +4055 1 0.000206 1560.000000 -0.000774 0.002254 0.004502 +4056 1 0.000270 1560.000000 -0.000288 0.001745 0.004400 +4057 1 0.000249 1560.000000 -0.003523 0.001030 0.001374 +4058 1 0.000239 1560.000000 -0.001266 -0.001257 0.002681 +4059 1 0.000210 1560.000000 0.000044 0.001506 0.000821 +4060 1 0.000271 1560.000000 0.001119 0.000139 0.005147 +4061 1 0.000262 1560.000000 0.001301 0.000443 0.004528 +4062 1 0.000200 1560.000000 -0.000302 -0.000429 0.006056 +4063 1 0.000267 1560.000000 0.000494 -0.002286 0.006026 +4064 1 0.000266 1560.000000 -0.001466 -0.003426 0.000801 +4065 1 0.000248 1560.000000 0.000245 -0.000689 0.005918 +4066 1 0.000198 1560.000000 -0.001409 -0.001007 0.004938 +4067 1 0.000202 1560.000000 0.001357 0.001771 0.002811 +4068 1 0.000223 1560.000000 -0.002066 -0.000666 0.008355 +4069 1 0.000262 1560.000000 0.002083 -0.001999 0.007591 +4070 1 0.000262 1560.000000 0.001815 -0.003268 0.001525 +4071 1 0.000225 1560.000000 -0.000278 0.003174 0.003270 +4072 1 0.000253 1560.000000 -0.002616 -0.001284 0.008317 +4073 1 0.000286 1560.000000 0.000663 -0.001602 0.008218 +4074 1 0.000227 1560.000000 -0.002480 -0.001935 0.005655 +4075 1 0.000235 1560.000000 0.000463 -0.000742 0.001240 +4076 1 0.000212 1560.000000 -0.001690 0.000086 0.008577 +4077 1 0.000231 1560.000000 -0.002245 0.000001 0.002707 +4078 1 0.000200 1560.000000 0.002200 -0.003057 0.007499 +4079 1 0.000250 1560.000000 -0.000266 0.003329 0.003965 +4080 1 0.000228 1560.000000 0.000296 0.001615 0.007098 +4081 1 0.000233 1560.000000 0.000456 0.000520 0.008292 +4082 1 0.000203 1560.000000 -0.003810 0.000035 0.001866 +4083 1 0.000237 1560.000000 0.000850 0.001720 0.003401 +4084 1 0.000201 1560.000000 -0.000376 0.001639 0.007835 +4085 1 0.000239 1560.000000 0.001307 -0.002310 0.003227 +4086 1 0.000228 1560.000000 -0.001289 0.003186 0.001922 +4087 1 0.000213 1560.000000 0.001129 -0.001966 0.003709 +4088 1 0.000287 1560.000000 0.001049 0.002025 0.000270 +4089 1 0.000261 1560.000000 0.000417 -0.000820 0.000150 +4090 1 0.000247 1560.000000 -0.000568 -0.001604 0.005307 +4091 1 0.000226 1560.000000 0.000434 0.000898 0.000232 +4092 1 0.000250 1560.000000 0.001277 -0.001270 0.004767 +4093 1 0.000276 1560.000000 0.002799 0.000956 0.004147 +4094 1 0.000217 1560.000000 -0.001654 -0.000684 0.007297 +4095 1 0.000205 1560.000000 -0.001720 0.001360 0.008916 +4096 1 0.000202 1560.000000 0.000026 -0.002035 0.000977 +4097 1 0.000222 1560.000000 0.001015 0.003375 0.002576 +4098 1 0.000231 1560.000000 -0.000636 -0.000465 0.003491 +4099 1 0.000247 1560.000000 0.000547 -0.000733 0.005146 +4100 1 0.000255 1560.000000 0.002954 -0.002021 0.005162 +4101 1 0.000235 1560.000000 0.001343 -0.003408 0.009226 +4102 1 0.000193 1560.000000 0.000609 0.001483 0.001555 +4103 1 0.000263 1560.000000 0.001866 0.000313 0.006712 +4104 1 0.000272 1560.000000 -0.003573 -0.000790 0.008937 +4105 1 0.000252 1560.000000 -0.001323 -0.002086 0.002644 +4106 1 0.000216 1560.000000 -0.000562 0.002382 0.000341 +4107 1 0.000270 1560.000000 0.001283 -0.002323 0.008527 +4108 1 0.000231 1560.000000 0.001061 0.000598 0.004609 +4109 1 0.000193 1560.000000 -0.001531 -0.000409 0.005432 +4110 1 0.000235 1560.000000 0.001374 0.000670 0.000975 +4111 1 0.000241 1560.000000 0.002446 -0.000890 0.005850 +4112 1 0.000195 1560.000000 0.002948 -0.000072 0.007568 +4113 1 0.000201 1560.000000 0.001972 0.003085 0.009698 +4114 1 0.000207 1560.000000 -0.000868 -0.001334 0.007916 +4115 1 0.000208 1560.000000 0.002706 -0.001076 0.001431 +4116 1 0.000236 1560.000000 0.001864 0.001516 0.000567 +4117 1 0.000242 1560.000000 0.002281 -0.000084 0.000679 +4118 1 0.000275 1560.000000 -0.001786 -0.000031 0.006787 +4119 1 0.000212 1560.000000 0.000802 0.001305 0.007244 +4120 1 0.000210 1560.000000 0.003586 -0.000435 0.001040 +4121 1 0.000225 1560.000000 0.001187 0.001039 0.009065 +4122 1 0.000256 1560.000000 0.002736 0.001708 0.002212 +4123 1 0.000280 1560.000000 -0.002052 -0.002493 0.007518 +4124 1 0.000207 1560.000000 -0.003285 0.000744 0.003657 +4125 1 0.000195 1560.000000 -0.001634 0.000290 0.009411 +4126 1 0.000210 1560.000000 0.000743 -0.002671 0.009612 +4127 1 0.000214 1560.000000 0.001906 0.001015 0.008520 +4128 1 0.000199 1560.000000 -0.001519 -0.000581 0.005744 +4129 1 0.000242 1560.000000 -0.001078 0.000923 0.006833 +4130 1 0.000242 1560.000000 -0.001742 -0.002102 0.000731 +4131 1 0.000195 1560.000000 -0.001348 -0.000458 0.000244 +4132 1 0.000233 1560.000000 0.000030 0.000794 0.005090 +4133 1 0.000249 1560.000000 -0.002136 -0.002373 0.003963 +4134 1 0.000276 1560.000000 -0.001863 -0.002092 0.005115 +4135 1 0.000253 1560.000000 0.002227 -0.002324 0.000507 +4136 1 0.000288 1560.000000 0.001608 0.002306 0.001677 +4137 1 0.000216 1560.000000 -0.001347 0.002604 0.005968 +4138 1 0.000218 1560.000000 0.000503 0.000492 0.003532 +4139 1 0.000267 1560.000000 -0.002931 -0.002421 0.006887 +4140 1 0.000228 1560.000000 -0.002605 -0.002512 0.005802 +4141 1 0.000209 1560.000000 0.002331 0.000786 0.008775 +4142 1 0.000225 1560.000000 -0.000860 0.002856 0.005913 +4143 1 0.000248 1560.000000 0.002066 -0.000415 0.003741 +4144 1 0.000209 1560.000000 0.001060 0.000160 0.002746 +4145 1 0.000222 1560.000000 -0.001174 -0.002390 0.005930 +4146 1 0.000249 1560.000000 0.001778 -0.000709 0.006769 +4147 1 0.000226 1560.000000 -0.000186 -0.000578 0.002357 +4148 1 0.000202 1560.000000 0.002628 0.002443 0.000748 +4149 1 0.000253 1560.000000 0.001061 -0.000486 0.008116 +4150 1 0.000196 1560.000000 -0.000353 0.000661 0.002465 +4151 1 0.000199 1560.000000 -0.000741 -0.000012 0.009710 +4152 1 0.000203 1560.000000 -0.000563 -0.002873 0.003411 +4153 1 0.000272 1560.000000 0.001931 0.002241 0.008662 +4154 1 0.000240 1560.000000 0.001194 -0.002387 0.008155 +4155 1 0.000239 1560.000000 0.001416 -0.000772 0.008222 +4156 1 0.000286 1560.000000 0.002301 0.002038 0.003406 +4157 1 0.000211 1560.000000 -0.001034 -0.001638 0.002359 +4158 1 0.000228 1560.000000 -0.001318 0.002140 0.005640 +4159 1 0.000267 1560.000000 0.002492 -0.001199 0.007062 +4160 1 0.000207 1560.000000 -0.000799 0.000851 0.003691 +4161 1 0.000231 1560.000000 -0.000106 0.002893 0.004920 +4162 1 0.000197 1560.000000 -0.002290 -0.000360 0.006495 +4163 1 0.000205 1560.000000 -0.002374 -0.001969 0.007208 +4164 1 0.000288 1560.000000 -0.003139 -0.001011 0.005028 +4165 1 0.000265 1560.000000 -0.001371 0.000306 0.003843 +4166 1 0.000209 1560.000000 -0.001790 0.001403 0.005147 +4167 1 0.000209 1560.000000 -0.001032 -0.000089 0.008925 +4168 1 0.000271 1560.000000 -0.000771 0.002537 0.003078 +4169 1 0.000231 1560.000000 0.001514 0.001218 0.002474 +4170 1 0.000234 1560.000000 -0.003397 0.001030 0.001779 +4171 1 0.000278 1560.000000 -0.000070 -0.003786 0.003781 +4172 1 0.000230 1560.000000 0.002034 -0.000629 0.001557 +4173 1 0.000251 1560.000000 0.001462 -0.001676 0.006611 +4174 1 0.000199 1560.000000 -0.001309 -0.001732 0.006794 +4175 1 0.000221 1560.000000 -0.001896 -0.002783 0.003062 +4176 1 0.000282 1560.000000 0.000928 -0.003623 0.001831 +4177 1 0.000286 1560.000000 -0.002584 -0.000994 0.004386 +4178 1 0.000220 1560.000000 -0.002185 -0.000742 0.005063 +4179 1 0.000248 1560.000000 0.003702 0.000691 0.000509 +4180 1 0.000284 1560.000000 0.000017 -0.002882 0.004454 +4181 1 0.000208 1560.000000 0.000029 0.003409 0.003931 +4182 1 0.000195 1560.000000 -0.000390 -0.003823 0.005289 +4183 1 0.000277 1560.000000 0.002829 0.000008 0.006997 +4184 1 0.000194 1560.000000 -0.002452 -0.000716 0.003480 +4185 1 0.000288 1560.000000 0.001000 -0.000946 0.006179 +4186 1 0.000248 1560.000000 0.001726 -0.000684 0.002612 +4187 1 0.000200 1560.000000 0.002260 0.000744 0.008471 +4188 1 0.000225 1560.000000 0.002447 0.002965 0.002061 +4189 1 0.000198 1560.000000 -0.000038 -0.002843 0.008670 +4190 1 0.000283 1560.000000 -0.001048 0.002375 0.005285 +4191 1 0.000195 1560.000000 -0.001072 0.003001 0.008525 +4192 1 0.000263 1560.000000 0.000680 -0.002653 0.004929 +4193 1 0.000198 1560.000000 -0.002189 -0.001198 0.002121 +4194 1 0.000203 1560.000000 0.001905 0.001482 0.007432 +4195 1 0.000273 1560.000000 0.002552 0.002801 0.007357 +4196 1 0.000264 1560.000000 -0.000548 0.001600 0.002479 +4197 1 0.000202 1560.000000 -0.000064 -0.002196 0.006009 +4198 1 0.000205 1560.000000 -0.002400 0.002315 0.002582 +4199 1 0.000266 1560.000000 -0.001452 -0.001477 0.002809 +4200 1 0.000274 1560.000000 -0.000833 0.002783 0.001667 +4201 1 0.000212 1560.000000 -0.000656 0.001132 0.003371 +4202 1 0.000201 1560.000000 -0.003024 -0.001595 0.003875 +4203 1 0.000201 1560.000000 0.000475 -0.000746 0.002599 +4204 1 0.000248 1560.000000 -0.000984 0.000473 0.009092 +4205 1 0.000256 1560.000000 0.002882 -0.001205 0.008790 +4206 1 0.000228 1560.000000 -0.000069 -0.001127 0.002781 +4207 1 0.000208 1560.000000 0.001079 0.000361 0.005818 +4208 1 0.000236 1560.000000 -0.002333 -0.002952 0.008181 +4209 1 0.000208 1560.000000 -0.002064 -0.001157 0.007394 +4210 1 0.000230 1560.000000 -0.001950 0.001349 0.003173 +4211 1 0.000224 1560.000000 -0.003280 -0.000680 0.008168 +4212 1 0.000196 1560.000000 0.003132 0.002149 0.001989 +4213 1 0.000205 1560.000000 -0.002643 0.001549 0.009122 +4214 1 0.000227 1560.000000 -0.000846 -0.002656 0.007715 +4215 1 0.000246 1560.000000 -0.000406 0.000435 0.008464 +4216 1 0.000194 1560.000000 -0.002049 -0.001616 0.004034 +4217 1 0.000265 1560.000000 0.003736 0.000067 0.003556 +4218 1 0.000236 1560.000000 -0.001272 0.002242 0.001513 +4219 1 0.000207 1560.000000 0.000187 0.001125 0.000845 +4220 1 0.000216 1560.000000 -0.001041 0.002305 0.000887 +4221 1 0.000236 1560.000000 0.002819 -0.002042 0.009726 +4222 1 0.000211 1560.000000 0.000054 -0.000652 0.001389 +4223 1 0.000202 1560.000000 0.000512 -0.003443 0.009307 +4224 1 0.000199 1560.000000 -0.000370 0.000745 0.009011 +4225 1 0.000282 1560.000000 0.002210 -0.001294 0.003714 +4226 1 0.000263 1560.000000 -0.001140 -0.000236 0.006296 +4227 1 0.000243 1560.000000 0.000471 0.003042 0.003527 +4228 1 0.000211 1560.000000 -0.002153 -0.003101 0.009619 +4229 1 0.000261 1560.000000 0.002785 0.000082 0.004022 +4230 1 0.000204 1560.000000 0.003172 -0.000162 0.000964 +4231 1 0.000270 1560.000000 0.002337 0.001108 0.009076 +4232 1 0.000256 1560.000000 0.001419 -0.003047 0.000779 +4233 1 0.000195 1560.000000 -0.000310 0.001593 0.006501 +4234 1 0.000270 1560.000000 -0.001960 0.001635 0.002236 +4235 1 0.000194 1560.000000 -0.001088 0.000903 0.000799 +4236 1 0.000261 1560.000000 0.002183 -0.002804 0.002973 +4237 1 0.000213 1560.000000 0.003656 0.000250 0.004895 +4238 1 0.000211 1560.000000 -0.002791 -0.000662 0.008012 +4239 1 0.000223 1560.000000 0.003783 0.000005 0.002598 +4240 1 0.000248 1560.000000 -0.002332 -0.000374 0.002863 +4241 1 0.000229 1560.000000 -0.002936 0.001507 0.008996 +4242 1 0.000223 1560.000000 0.002544 0.001241 0.006776 +4243 1 0.000221 1560.000000 0.001409 -0.001981 0.001570 +4244 1 0.000199 1560.000000 -0.001110 0.000240 0.003229 +4245 1 0.000214 1560.000000 0.003215 0.000750 0.002860 +4246 1 0.000272 1560.000000 0.003100 0.002089 0.000838 +4247 1 0.000220 1560.000000 -0.000039 0.000215 0.005246 +4248 1 0.000250 1560.000000 -0.001046 0.001595 0.004403 +4249 1 0.000213 1560.000000 -0.001959 -0.001300 0.001690 +4250 1 0.000265 1560.000000 -0.000483 0.002031 0.008386 +4251 1 0.000280 1560.000000 0.001720 0.001639 0.007751 +4252 1 0.000269 1560.000000 0.000309 0.001507 0.002664 +4253 1 0.000256 1560.000000 0.002457 -0.001329 0.009711 +4254 1 0.000281 1560.000000 -0.000602 0.001647 0.009292 +4255 1 0.000225 1560.000000 0.001218 -0.002360 0.006357 +4256 1 0.000204 1560.000000 0.001706 -0.001402 0.006477 +4257 1 0.000210 1560.000000 -0.000958 -0.000416 0.003051 +4258 1 0.000214 1560.000000 0.001331 -0.000366 0.001459 +4259 1 0.000246 1560.000000 -0.000842 0.003543 0.009709 +4260 1 0.000224 1560.000000 0.002350 0.001876 0.001416 +4261 1 0.000218 1560.000000 -0.001095 0.003040 0.003059 +4262 1 0.000225 1560.000000 -0.001053 -0.001129 0.003033 +4263 1 0.000272 1560.000000 0.002827 -0.001805 0.000563 +4264 1 0.000193 1560.000000 0.000555 -0.000187 0.007910 +4265 1 0.000244 1560.000000 -0.002123 0.001024 0.003725 +4266 1 0.000232 1560.000000 0.001136 0.001077 0.008338 +4267 1 0.000221 1560.000000 0.003607 0.000279 0.006774 +4268 1 0.000266 1560.000000 0.001531 -0.000840 0.004313 +4269 1 0.000225 1560.000000 -0.002060 0.001256 0.002610 +4270 1 0.000218 1560.000000 0.002796 0.001514 0.005436 +4271 1 0.000214 1560.000000 0.000395 -0.001350 0.003495 +4272 1 0.000210 1560.000000 0.002129 -0.001325 0.004804 +4273 1 0.000275 1560.000000 0.000129 0.002139 0.002780 +4274 1 0.000220 1560.000000 0.000490 -0.000947 0.007797 +4275 1 0.000193 1560.000000 0.000538 0.000844 0.004838 +4276 1 0.000193 1560.000000 0.000222 0.002519 0.001328 +4277 1 0.000232 1560.000000 0.003597 -0.001236 0.005471 +4278 1 0.000273 1560.000000 0.000336 -0.002212 0.009788 +4279 1 0.000193 1560.000000 -0.002013 0.002609 0.009063 +4280 1 0.000284 1560.000000 0.001048 0.000105 0.002331 +4281 1 0.000246 1560.000000 0.000860 0.001289 0.006207 +4282 1 0.000217 1560.000000 -0.001973 -0.000211 0.007682 +4283 1 0.000285 1560.000000 -0.000003 0.001643 0.000407 +4284 1 0.000274 1560.000000 -0.003532 0.000571 0.001099 +4285 1 0.000239 1560.000000 -0.000372 0.002775 0.007090 +4286 1 0.000199 1560.000000 -0.001919 0.000835 0.004462 +4287 1 0.000221 1560.000000 0.000426 -0.002297 0.006618 +4288 1 0.000207 1560.000000 -0.000910 -0.001170 0.004417 +4289 1 0.000248 1560.000000 0.000660 -0.000335 0.000810 +4290 1 0.000266 1560.000000 0.000046 0.001206 0.000536 +4291 1 0.000216 1560.000000 -0.001857 0.000778 0.004690 +4292 1 0.000195 1560.000000 -0.002131 0.001024 0.002756 +4293 1 0.000281 1560.000000 -0.001319 -0.001152 0.005417 +4294 1 0.000273 1560.000000 -0.002728 0.001841 0.005561 +4295 1 0.000285 1560.000000 -0.002119 -0.001713 0.005537 +4296 1 0.000272 1560.000000 0.000770 0.002534 0.009681 +4297 1 0.000194 1560.000000 -0.001216 -0.000671 0.000395 +4298 1 0.000270 1560.000000 -0.003361 -0.001368 0.002406 +4299 1 0.000286 1560.000000 0.001819 -0.001275 0.008996 +4300 1 0.000223 1560.000000 0.000790 -0.001189 0.004846 +4301 1 0.000205 1560.000000 0.001411 -0.000732 0.007865 +4302 1 0.000267 1560.000000 0.001430 -0.000117 0.006158 +4303 1 0.000204 1560.000000 0.000374 0.003321 0.007151 +4304 1 0.000197 1560.000000 -0.002843 -0.001195 0.009759 +4305 1 0.000281 1560.000000 -0.000110 0.003461 0.007256 +4306 1 0.000213 1560.000000 -0.002704 -0.001882 0.003591 +4307 1 0.000240 1560.000000 0.002486 -0.002799 0.006871 +4308 1 0.000211 1560.000000 0.001489 0.002376 0.003823 +4309 1 0.000195 1560.000000 0.000057 -0.000222 0.005228 +4310 1 0.000221 1560.000000 0.001227 0.003008 0.002338 +4311 1 0.000233 1560.000000 0.000751 -0.001151 0.000150 +4312 1 0.000194 1560.000000 -0.001046 -0.001992 0.000819 +4313 1 0.000244 1560.000000 0.000218 -0.001673 0.003252 +4314 1 0.000244 1560.000000 0.002240 0.000551 0.007852 +4315 1 0.000282 1560.000000 -0.001612 0.003040 0.003269 +4316 1 0.000226 1560.000000 0.002943 -0.000241 0.006132 +4317 1 0.000267 1560.000000 0.003301 0.001223 0.009070 +4318 1 0.000217 1560.000000 0.000129 0.002752 0.004820 +4319 1 0.000264 1560.000000 -0.000410 0.002048 0.001298 +4320 1 0.000195 1560.000000 -0.002130 0.002357 0.007015 +4321 1 0.000200 1560.000000 -0.001080 0.003007 0.004346 +4322 1 0.000234 1560.000000 -0.000368 0.003510 0.006674 +4323 1 0.000212 1560.000000 0.000204 0.002841 0.008238 +4324 1 0.000243 1560.000000 0.002298 0.000616 0.009766 +4325 1 0.000285 1560.000000 -0.001482 -0.002631 0.003715 +4326 1 0.000221 1560.000000 -0.000225 0.002483 0.002934 +4327 1 0.000279 1560.000000 -0.003077 -0.000406 0.002077 +4328 1 0.000193 1560.000000 0.000040 0.002708 0.001590 +4329 1 0.000208 1560.000000 0.000497 0.001586 0.003341 +4330 1 0.000220 1560.000000 0.000544 0.003201 0.005466 +4331 1 0.000231 1560.000000 0.002402 -0.001627 0.000283 +4332 1 0.000244 1560.000000 -0.002587 0.002583 0.005609 +4333 1 0.000218 1560.000000 -0.001558 -0.002199 0.002521 +4334 1 0.000228 1560.000000 -0.000735 -0.000500 0.002041 +4335 1 0.000227 1560.000000 0.002128 0.001345 0.001119 +4336 1 0.000197 1560.000000 -0.000344 -0.003696 0.005689 +4337 1 0.000251 1560.000000 0.000568 -0.001709 0.000473 +4338 1 0.000286 1560.000000 0.000291 0.000036 0.002493 +4339 1 0.000215 1560.000000 -0.002835 -0.002340 0.003406 +4340 1 0.000218 1560.000000 0.000214 -0.002300 0.009001 +4341 1 0.000199 1560.000000 -0.000843 -0.000664 0.003287 +4342 1 0.000223 1560.000000 0.000313 0.001895 0.001179 +4343 1 0.000246 1560.000000 -0.000846 0.003516 0.008822 +4344 1 0.000209 1560.000000 0.001229 0.001217 0.003196 +4345 1 0.000252 1560.000000 0.001351 -0.002857 0.004934 +4346 1 0.000195 1560.000000 0.000562 0.001913 0.009365 +4347 1 0.000217 1560.000000 -0.001524 -0.000705 0.008540 +4348 1 0.000210 1560.000000 -0.002799 -0.001731 0.001774 +4349 1 0.000214 1560.000000 0.001931 -0.001764 0.006401 +4350 1 0.000269 1560.000000 -0.002085 -0.002128 0.002039 +4351 1 0.000222 1560.000000 -0.000964 0.001322 0.004970 +4352 1 0.000221 1560.000000 -0.002826 -0.001463 0.003422 +4353 1 0.000235 1560.000000 -0.003473 0.000991 0.004065 +4354 1 0.000201 1560.000000 0.000409 -0.000821 0.003904 +4355 1 0.000263 1560.000000 0.001876 -0.002544 0.000293 +4356 1 0.000275 1560.000000 0.002788 0.002468 0.004506 +4357 1 0.000213 1560.000000 -0.002585 0.001606 0.003386 +4358 1 0.000216 1560.000000 0.001508 -0.001276 0.001528 +4359 1 0.000219 1560.000000 -0.000671 0.000767 0.007887 +4360 1 0.000258 1560.000000 0.001381 -0.002883 0.000242 +4361 1 0.000251 1560.000000 0.000168 -0.003690 0.001198 +4362 1 0.000226 1560.000000 0.002830 -0.001425 0.009224 +4363 1 0.000216 1560.000000 -0.001108 0.001482 0.007401 +4364 1 0.000282 1560.000000 0.000159 -0.000908 0.008858 +4365 1 0.000212 1560.000000 -0.001637 -0.000617 0.005976 +4366 1 0.000288 1560.000000 -0.000792 -0.003362 0.007897 +4367 1 0.000255 1560.000000 -0.002232 -0.002415 0.000767 +4368 1 0.000229 1560.000000 0.001535 -0.000237 0.004094 +4369 1 0.000220 1560.000000 0.000894 0.002274 0.007086 +4370 1 0.000254 1560.000000 -0.000800 0.000121 0.001670 +4371 1 0.000196 1560.000000 0.002237 -0.002590 0.005068 +4372 1 0.000208 1560.000000 -0.000176 -0.001210 0.006568 +4373 1 0.000234 1560.000000 -0.001371 -0.003038 0.000743 +4374 1 0.000273 1560.000000 0.000429 0.000520 0.008926 +4375 1 0.000211 1560.000000 -0.003801 0.000584 0.007856 +4376 1 0.000227 1560.000000 -0.002198 0.001532 0.005763 +4377 1 0.000198 1560.000000 0.000882 0.003027 0.004427 +4378 1 0.000233 1560.000000 0.001027 -0.002041 0.007605 +4379 1 0.000250 1560.000000 -0.003106 -0.001121 0.008315 +4380 1 0.000199 1560.000000 0.000696 0.000371 0.007664 +4381 1 0.000277 1560.000000 -0.003361 0.000139 0.009063 +4382 1 0.000230 1560.000000 -0.000350 0.002365 0.001963 +4383 1 0.000273 1560.000000 0.001882 -0.000224 0.003319 +4384 1 0.000238 1560.000000 -0.002268 -0.000467 0.000136 +4385 1 0.000266 1560.000000 0.001345 0.000967 0.003856 +4386 1 0.000279 1560.000000 0.001088 0.000484 0.002589 +4387 1 0.000264 1560.000000 0.000357 0.000660 0.000843 +4388 1 0.000253 1560.000000 0.002443 0.001115 0.002747 +4389 1 0.000260 1560.000000 -0.001034 0.000569 0.003202 +4390 1 0.000195 1560.000000 -0.002340 -0.000202 0.008889 +4391 1 0.000193 1560.000000 0.000588 0.001002 0.007505 +4392 1 0.000197 1560.000000 0.001874 0.000430 0.000406 +4393 1 0.000224 1560.000000 -0.000118 -0.000132 0.004688 +4394 1 0.000213 1560.000000 -0.000963 -0.002782 0.002017 +4395 1 0.000242 1560.000000 0.000967 -0.002013 0.008045 +4396 1 0.000269 1560.000000 0.001738 -0.000568 0.003790 +4397 1 0.000228 1560.000000 -0.000802 0.000126 0.008785 +4398 1 0.000272 1560.000000 0.000133 0.002368 0.002467 +4399 1 0.000210 1560.000000 0.003152 0.001572 0.009710 +4400 1 0.000264 1560.000000 0.001303 0.000093 0.005782 +4401 1 0.000223 1560.000000 -0.001732 0.000761 0.006367 +4402 1 0.000209 1560.000000 0.000155 -0.000806 0.009397 +4403 1 0.000264 1560.000000 0.001675 0.001748 0.009751 +4404 1 0.000207 1560.000000 0.001678 -0.000720 0.007465 +4405 1 0.000195 1560.000000 0.002645 -0.001531 0.001125 +4406 1 0.000231 1560.000000 -0.001975 -0.001019 0.002404 +4407 1 0.000252 1560.000000 0.003557 0.000344 0.009420 +4408 1 0.000277 1560.000000 0.001769 0.002157 0.004265 +4409 1 0.000214 1560.000000 -0.000241 0.000510 0.001929 +4410 1 0.000204 1560.000000 -0.000337 -0.001298 0.006282 +4411 1 0.000209 1560.000000 -0.000472 -0.001562 0.003587 +4412 1 0.000228 1560.000000 0.000240 0.000401 0.003346 +4413 1 0.000211 1560.000000 0.003309 -0.000096 0.004630 +4414 1 0.000264 1560.000000 0.002989 -0.000422 0.000193 +4415 1 0.000207 1560.000000 0.000922 0.001942 0.002742 +4416 1 0.000239 1560.000000 0.000586 -0.001367 0.003361 +4417 1 0.000201 1560.000000 -0.000121 0.003470 0.006198 +4418 1 0.000254 1560.000000 -0.000471 0.002916 0.002450 +4419 1 0.000194 1560.000000 -0.001238 0.002575 0.007938 +4420 1 0.000221 1560.000000 -0.001962 -0.001192 0.001004 +4421 1 0.000238 1560.000000 0.000559 0.000875 0.004343 +4422 1 0.000209 1560.000000 0.000981 -0.001843 0.009367 +4423 1 0.000214 1560.000000 0.000285 -0.002695 0.000689 +4424 1 0.000215 1560.000000 0.003573 -0.000454 0.007661 +4425 1 0.000284 1560.000000 0.001328 0.000412 0.002422 +4426 1 0.000210 1560.000000 -0.000543 0.000434 0.001322 +4427 1 0.000207 1560.000000 -0.002336 0.002723 0.003418 +4428 1 0.000250 1560.000000 -0.002554 -0.000829 0.006374 +4429 1 0.000237 1560.000000 0.001515 0.000176 0.005905 +4430 1 0.000216 1560.000000 -0.000071 -0.001682 0.007910 +4431 1 0.000225 1560.000000 -0.002187 -0.001340 0.003910 +4432 1 0.000263 1560.000000 -0.003006 -0.000286 0.002622 +4433 1 0.000281 1560.000000 -0.001282 -0.001844 0.001297 +4434 1 0.000201 1560.000000 0.002402 0.001499 0.002663 +4435 1 0.000196 1560.000000 0.000391 0.000905 0.003126 +4436 1 0.000220 1560.000000 -0.002371 0.001124 0.004635 +4437 1 0.000236 1560.000000 -0.000114 -0.002612 0.000688 +4438 1 0.000253 1560.000000 0.001671 -0.002318 0.009437 +4439 1 0.000238 1560.000000 0.000765 -0.000438 0.000260 +4440 1 0.000196 1560.000000 0.001900 -0.001126 0.004747 +4441 1 0.000193 1560.000000 -0.003456 0.001393 0.003565 +4442 1 0.000197 1560.000000 0.000579 0.000452 0.006210 +4443 1 0.000223 1560.000000 -0.002850 -0.000354 0.003241 +4444 1 0.000267 1560.000000 0.001503 -0.001993 0.004190 +4445 1 0.000226 1560.000000 0.000255 0.000089 0.001037 +4446 1 0.000211 1560.000000 0.002500 0.002689 0.008841 +4447 1 0.000281 1560.000000 0.001808 0.002047 0.006210 +4448 1 0.000275 1560.000000 -0.000650 -0.002708 0.002410 +4449 1 0.000194 1560.000000 -0.003425 -0.000514 0.003481 +4450 1 0.000246 1560.000000 0.000839 0.002344 0.006576 +4451 1 0.000246 1560.000000 -0.000318 0.000841 0.005072 +4452 1 0.000256 1560.000000 -0.001974 0.001806 0.005987 +4453 1 0.000254 1560.000000 -0.000719 -0.002742 0.003650 +4454 1 0.000204 1560.000000 -0.002402 -0.000190 0.006470 +4455 1 0.000193 1560.000000 0.003504 -0.001588 0.008825 +4456 1 0.000208 1560.000000 0.001051 -0.000198 0.004798 +4457 1 0.000281 1560.000000 -0.002111 0.001483 0.009570 +4458 1 0.000201 1560.000000 0.001066 -0.000680 0.004655 +4459 1 0.000260 1560.000000 0.000780 -0.003637 0.003807 +4460 1 0.000224 1560.000000 0.001418 -0.002383 0.003878 +4461 1 0.000206 1560.000000 0.001292 0.000958 0.000543 +4462 1 0.000225 1560.000000 0.000293 0.002314 0.008804 +4463 1 0.000214 1560.000000 -0.001005 0.000836 0.007371 +4464 1 0.000214 1560.000000 0.000611 0.000780 0.002883 +4465 1 0.000262 1560.000000 -0.002777 -0.001451 0.008971 +4466 1 0.000207 1560.000000 0.001515 0.001307 0.003029 +4467 1 0.000253 1560.000000 0.000884 -0.001820 0.005528 +4468 1 0.000231 1560.000000 -0.001282 -0.000828 0.008570 +4469 1 0.000269 1560.000000 -0.000217 0.001762 0.008572 +4470 1 0.000267 1560.000000 -0.000447 0.001300 0.006527 +4471 1 0.000274 1560.000000 -0.003368 -0.000576 0.006362 +4472 1 0.000220 1560.000000 -0.001705 -0.001913 0.005698 +4473 1 0.000253 1560.000000 0.001081 0.002897 0.005819 +4474 1 0.000225 1560.000000 -0.002567 0.001845 0.002631 +4475 1 0.000217 1560.000000 -0.002339 -0.002174 0.004861 +4476 1 0.000264 1560.000000 -0.002334 -0.000854 0.008258 +4477 1 0.000222 1560.000000 0.000969 -0.001060 0.002652 +4478 1 0.000207 1560.000000 -0.001077 0.002114 0.008691 +4479 1 0.000247 1560.000000 0.001381 0.001630 0.004610 +4480 1 0.000197 1560.000000 0.003077 -0.001854 0.005431 +4481 1 0.000223 1560.000000 0.000167 -0.000779 0.008385 +4482 1 0.000233 1560.000000 0.003077 -0.000844 0.006807 +4483 1 0.000223 1560.000000 0.003438 -0.001514 0.004725 +4484 1 0.000260 1560.000000 -0.001345 0.000270 0.008235 +4485 1 0.000206 1560.000000 -0.002271 -0.002691 0.009678 +4486 1 0.000234 1560.000000 -0.002697 0.002692 0.004510 +4487 1 0.000203 1560.000000 -0.002226 0.002771 0.005387 +4488 1 0.000196 1560.000000 0.002760 0.001782 0.000257 +4489 1 0.000236 1560.000000 -0.003816 0.000410 0.008618 +4490 1 0.000269 1560.000000 0.000890 -0.000428 0.000492 +4491 1 0.000216 1560.000000 -0.001309 -0.000197 0.005072 +4492 1 0.000198 1560.000000 -0.000053 -0.000715 0.005803 +4493 1 0.000202 1560.000000 0.002677 0.001141 0.004238 +4494 1 0.000264 1560.000000 0.001319 0.002278 0.007898 +4495 1 0.000240 1560.000000 -0.002068 0.002958 0.000150 +4496 1 0.000280 1560.000000 0.001103 -0.000893 0.009321 +4497 1 0.000210 1560.000000 0.001571 -0.002267 0.005258 +4498 1 0.000276 1560.000000 0.000524 -0.001468 0.009651 +4499 1 0.000197 1560.000000 -0.000151 0.001983 0.003070 +4500 1 0.000230 1560.000000 -0.000050 -0.000625 0.009238 +4501 1 0.000286 1560.000000 -0.002716 0.000787 0.001822 +4502 1 0.000216 1560.000000 -0.000951 -0.000706 0.006420 +4503 1 0.000209 1560.000000 -0.000717 0.000196 0.008228 +4504 1 0.000234 1560.000000 -0.001690 -0.001541 0.006279 +4505 1 0.000215 1560.000000 0.000541 0.000445 0.005380 +4506 1 0.000244 1560.000000 -0.002519 0.002421 0.003661 +4507 1 0.000207 1560.000000 0.000509 0.001168 0.003593 +4508 1 0.000200 1560.000000 0.003060 -0.001311 0.009519 +4509 1 0.000232 1560.000000 0.001125 0.001705 0.004920 +4510 1 0.000281 1560.000000 -0.002235 -0.002239 0.008823 +4511 1 0.000197 1560.000000 0.000141 -0.001493 0.001227 +4512 1 0.000225 1560.000000 0.002717 0.001076 0.002074 +4513 1 0.000233 1560.000000 0.000364 -0.002685 0.002517 +4514 1 0.000250 1560.000000 0.002077 0.000930 0.006988 +4515 1 0.000225 1560.000000 0.002233 -0.001079 0.007861 +4516 1 0.000288 1560.000000 -0.000403 -0.002849 0.007040 +4517 1 0.000244 1560.000000 0.000411 -0.002405 0.007801 +4518 1 0.000245 1560.000000 -0.003708 -0.000686 0.001274 +4519 1 0.000272 1560.000000 -0.000508 -0.002308 0.008580 +4520 1 0.000206 1560.000000 0.001437 -0.000488 0.009803 +4521 1 0.000207 1560.000000 -0.001864 -0.001941 0.002302 +4522 1 0.000245 1560.000000 -0.001088 0.000328 0.001315 +4523 1 0.000238 1560.000000 -0.001810 -0.002392 0.008666 +4524 1 0.000271 1560.000000 -0.001580 -0.002583 0.006892 +4525 1 0.000206 1560.000000 0.000575 -0.001162 0.009389 +4526 1 0.000245 1560.000000 -0.000831 0.001535 0.004225 +4527 1 0.000280 1560.000000 -0.000826 0.001780 0.007598 +4528 1 0.000247 1560.000000 -0.000880 -0.002288 0.009111 +4529 1 0.000231 1560.000000 -0.002067 0.001128 0.009268 +4530 1 0.000261 1560.000000 0.002554 -0.001228 0.000785 +4531 1 0.000277 1560.000000 0.001421 -0.003497 0.002660 +4532 1 0.000224 1560.000000 0.001363 0.000151 0.002558 +4533 1 0.000214 1560.000000 -0.003522 0.001232 0.006663 +4534 1 0.000199 1560.000000 -0.002504 -0.002011 0.001761 +4535 1 0.000215 1560.000000 -0.000076 0.002372 0.009307 +4536 1 0.000256 1560.000000 0.000788 -0.002903 0.003222 +4537 1 0.000247 1560.000000 -0.002408 -0.001541 0.003162 +4538 1 0.000248 1560.000000 -0.001514 -0.001840 0.001904 +4539 1 0.000211 1560.000000 0.003396 -0.001057 0.005014 +4540 1 0.000227 1560.000000 0.001466 -0.001955 0.009109 +4541 1 0.000205 1560.000000 -0.000670 -0.000777 0.005198 +4542 1 0.000243 1560.000000 0.001490 0.003008 0.003546 +4543 1 0.000222 1560.000000 -0.002818 0.002604 0.006986 +4544 1 0.000219 1560.000000 0.001685 0.000513 0.001626 +4545 1 0.000225 1560.000000 -0.001887 -0.002187 0.008589 +4546 1 0.000244 1560.000000 0.002139 0.002024 0.002084 +4547 1 0.000215 1560.000000 0.002352 0.000667 0.007229 +4548 1 0.000202 1560.000000 -0.000717 -0.000332 0.008405 +4549 1 0.000261 1560.000000 0.001483 0.001985 0.001736 +4550 1 0.000261 1560.000000 -0.001851 0.000283 0.003679 +4551 1 0.000202 1560.000000 0.000099 -0.001023 0.003921 +4552 1 0.000272 1560.000000 -0.000718 0.000724 0.009170 +4553 1 0.000194 1560.000000 -0.001213 0.000188 0.006519 +4554 1 0.000196 1560.000000 0.000227 0.001916 0.002294 +4555 1 0.000194 1560.000000 -0.000535 0.003069 0.001970 +4556 1 0.000212 1560.000000 -0.001578 0.001418 0.005307 +4557 1 0.000201 1560.000000 -0.000822 0.001216 0.006161 +4558 1 0.000232 1560.000000 -0.000174 -0.003822 0.007955 +4559 1 0.000214 1560.000000 -0.002546 -0.000760 0.009289 +4560 1 0.000232 1560.000000 -0.001758 0.001618 0.009818 +4561 1 0.000243 1560.000000 -0.000819 -0.001292 0.002598 +4562 1 0.000239 1560.000000 -0.000625 0.001951 0.000268 +4563 1 0.000209 1560.000000 0.000395 0.002068 0.007084 +4564 1 0.000285 1560.000000 -0.003035 0.000584 0.004196 +4565 1 0.000218 1560.000000 0.000276 -0.001464 0.006752 +4566 1 0.000264 1560.000000 0.000238 -0.002911 0.005072 +4567 1 0.000278 1560.000000 0.003796 0.000022 0.006016 +4568 1 0.000268 1560.000000 0.000622 -0.003656 0.004020 +4569 1 0.000200 1560.000000 0.002991 -0.000895 0.005318 +4570 1 0.000201 1560.000000 0.003063 -0.001147 0.004029 +4571 1 0.000228 1560.000000 0.002905 0.000121 0.002831 +4572 1 0.000267 1560.000000 -0.001995 -0.003161 0.000971 +4573 1 0.000247 1560.000000 0.001320 -0.001438 0.001628 +4574 1 0.000213 1560.000000 0.003339 0.001878 0.002392 +4575 1 0.000285 1560.000000 -0.002883 0.001473 0.001331 +4576 1 0.000253 1560.000000 -0.001554 0.000971 0.002120 +4577 1 0.000222 1560.000000 0.000038 0.001956 0.005868 +4578 1 0.000200 1560.000000 -0.000726 0.003326 0.007564 +4579 1 0.000253 1560.000000 -0.002634 0.001435 0.002763 +4580 1 0.000227 1560.000000 -0.000986 0.000700 0.004004 +4581 1 0.000236 1560.000000 0.002103 0.001682 0.002468 +4582 1 0.000268 1560.000000 -0.001729 0.002798 0.001399 +4583 1 0.000284 1560.000000 -0.001436 0.000979 0.001785 +4584 1 0.000237 1560.000000 0.003005 0.001010 0.002401 +4585 1 0.000267 1560.000000 -0.001165 0.000738 0.007718 +4586 1 0.000223 1560.000000 0.000984 0.003270 0.009544 +4587 1 0.000258 1560.000000 -0.003194 -0.001387 0.003622 +4588 1 0.000196 1560.000000 0.001650 0.003431 0.001592 +4589 1 0.000245 1560.000000 -0.000183 -0.002735 0.004289 +4590 1 0.000208 1560.000000 0.002835 -0.001642 0.002453 +4591 1 0.000217 1560.000000 -0.000174 -0.002659 0.000399 +4592 1 0.000273 1560.000000 0.000676 -0.003157 0.001554 +4593 1 0.000202 1560.000000 0.000226 -0.002353 0.000961 +4594 1 0.000267 1560.000000 -0.002301 0.001215 0.002816 +4595 1 0.000241 1560.000000 0.003082 0.000522 0.009141 +4596 1 0.000286 1560.000000 0.003248 -0.001248 0.003081 +4597 1 0.000250 1560.000000 -0.000583 -0.000408 0.002735 +4598 1 0.000243 1560.000000 -0.001984 0.001328 0.007499 +4599 1 0.000200 1560.000000 0.001395 0.003080 0.009368 +4600 1 0.000281 1560.000000 -0.001074 -0.001925 0.009071 +4601 1 0.000247 1560.000000 -0.001198 0.003401 0.000846 +4602 1 0.000219 1560.000000 -0.001031 0.000210 0.001986 +4603 1 0.000199 1560.000000 -0.000108 0.000520 0.006277 +4604 1 0.000193 1560.000000 -0.000137 0.000123 0.000112 +4605 1 0.000234 1560.000000 -0.001321 -0.001314 0.008175 +4606 1 0.000206 1560.000000 -0.003162 -0.001262 0.005844 +4607 1 0.000202 1560.000000 0.003569 0.000975 0.008186 +4608 1 0.000197 1560.000000 0.001853 -0.001055 0.002604 +4609 1 0.000221 1560.000000 0.001260 -0.000751 0.003330 +4610 1 0.000215 1560.000000 -0.001222 -0.001900 0.002879 +4611 1 0.000195 1560.000000 0.000969 -0.000600 0.008813 +4612 1 0.000212 1560.000000 0.000756 0.001839 0.004654 +4613 1 0.000202 1560.000000 -0.001249 0.001195 0.007850 +4614 1 0.000197 1560.000000 0.000206 -0.001115 0.002137 +4615 1 0.000272 1560.000000 -0.002919 0.001784 0.009819 +4616 1 0.000212 1560.000000 0.000282 -0.000714 0.003450 +4617 1 0.000242 1560.000000 0.000137 0.000772 0.001646 +4618 1 0.000268 1560.000000 0.000915 -0.002745 0.005537 +4619 1 0.000225 1560.000000 -0.002993 0.001000 0.005542 +4620 1 0.000252 1560.000000 -0.001454 -0.000481 0.003225 +4621 1 0.000210 1560.000000 -0.002738 -0.001268 0.003365 +4622 1 0.000197 1560.000000 0.001681 0.001669 0.003006 +4623 1 0.000269 1560.000000 -0.001532 0.001567 0.003704 +4624 1 0.000242 1560.000000 -0.001368 -0.000987 0.003506 +4625 1 0.000206 1560.000000 -0.001261 0.000968 0.003318 +4626 1 0.000223 1560.000000 -0.001544 0.001985 0.002118 +4627 1 0.000246 1560.000000 0.000065 0.000839 0.009594 +4628 1 0.000224 1560.000000 -0.002747 0.000734 0.001557 +4629 1 0.000220 1560.000000 -0.001460 0.003110 0.007505 +4630 1 0.000211 1560.000000 -0.000870 0.000398 0.007365 +4631 1 0.000239 1560.000000 -0.002685 0.002140 0.008777 +4632 1 0.000271 1560.000000 0.001509 -0.002320 0.009148 +4633 1 0.000234 1560.000000 -0.000374 -0.001277 0.005522 +4634 1 0.000200 1560.000000 -0.000150 -0.000849 0.005009 +4635 1 0.000198 1560.000000 -0.000022 0.000231 0.009451 +4636 1 0.000223 1560.000000 0.002564 -0.002128 0.004025 +4637 1 0.000224 1560.000000 0.000843 0.000732 0.000845 +4638 1 0.000221 1560.000000 -0.000186 -0.000409 0.004797 +4639 1 0.000230 1560.000000 0.001287 -0.003309 0.006803 +4640 1 0.000272 1560.000000 0.000508 -0.001872 0.005317 +4641 1 0.000260 1560.000000 -0.000541 0.001239 0.002877 +4642 1 0.000203 1560.000000 -0.000772 0.001658 0.001669 +4643 1 0.000210 1560.000000 -0.000354 0.002978 0.006974 +4644 1 0.000225 1560.000000 -0.001938 0.001819 0.000382 +4645 1 0.000278 1560.000000 0.000824 0.000794 0.004282 +4646 1 0.000219 1560.000000 0.002500 0.002372 0.005055 +4647 1 0.000195 1560.000000 0.001210 -0.002931 0.005300 +4648 1 0.000282 1560.000000 0.001577 -0.002360 0.008815 +4649 1 0.000226 1560.000000 0.000089 -0.000359 0.001056 +4650 1 0.000243 1560.000000 0.000807 -0.003682 0.000612 +4651 1 0.000197 1560.000000 -0.000785 -0.002020 0.002631 +4652 1 0.000201 1560.000000 0.002839 -0.001086 0.006057 +4653 1 0.000275 1560.000000 -0.003429 -0.001233 0.007249 +4654 1 0.000273 1560.000000 -0.003227 0.001630 0.009630 +4655 1 0.000283 1560.000000 0.001615 -0.002976 0.005610 +4656 1 0.000211 1560.000000 0.001523 -0.001036 0.001695 +4657 1 0.000258 1560.000000 0.003526 0.000759 0.004060 +4658 1 0.000217 1560.000000 0.001712 -0.001929 0.000706 +4659 1 0.000195 1560.000000 -0.002704 0.000721 0.006327 +4660 1 0.000214 1560.000000 0.002045 0.001832 0.009192 +4661 1 0.000221 1560.000000 -0.001145 0.002330 0.008389 +4662 1 0.000250 1560.000000 -0.001289 0.000945 0.008936 +4663 1 0.000226 1560.000000 0.001144 -0.001444 0.005952 +4664 1 0.000280 1560.000000 -0.002131 0.000035 0.003383 +4665 1 0.000273 1560.000000 0.003246 -0.000834 0.007679 +4666 1 0.000216 1560.000000 0.002031 -0.000067 0.006542 +4667 1 0.000217 1560.000000 0.000545 0.002047 0.007246 +4668 1 0.000287 1560.000000 0.002870 0.001596 0.004644 +4669 1 0.000201 1560.000000 0.000783 -0.001249 0.006664 +4670 1 0.000207 1560.000000 -0.000170 -0.002014 0.004247 +4671 1 0.000261 1560.000000 -0.002298 0.002440 0.001884 +4672 1 0.000211 1560.000000 -0.003252 -0.000603 0.008531 +4673 1 0.000205 1560.000000 0.003300 0.000916 0.007000 +4674 1 0.000265 1560.000000 0.000851 0.001701 0.000698 +4675 1 0.000210 1560.000000 -0.002456 0.000406 0.002267 +4676 1 0.000263 1560.000000 -0.001561 -0.002972 0.002300 +4677 1 0.000251 1560.000000 -0.002547 -0.001823 0.007428 +4678 1 0.000220 1560.000000 -0.002761 0.000253 0.009652 +4679 1 0.000252 1560.000000 0.001406 -0.003452 0.001081 +4680 1 0.000254 1560.000000 -0.000894 -0.001303 0.008167 +4681 1 0.000202 1560.000000 0.002982 0.001066 0.007962 +4682 1 0.000266 1560.000000 -0.002881 -0.001942 0.001623 +4683 1 0.000276 1560.000000 -0.000524 0.000994 0.002472 +4684 1 0.000258 1560.000000 -0.000893 0.000066 0.008472 +4685 1 0.000258 1560.000000 -0.001292 -0.000659 0.004083 +4686 1 0.000273 1560.000000 -0.002305 0.002105 0.005865 +4687 1 0.000208 1560.000000 0.001061 0.001339 0.006305 +4688 1 0.000211 1560.000000 0.000489 0.000231 0.000132 +4689 1 0.000222 1560.000000 -0.000332 0.001132 0.001260 +4690 1 0.000287 1560.000000 -0.000796 0.000222 0.005684 +4691 1 0.000241 1560.000000 -0.000133 0.002214 0.006252 +4692 1 0.000233 1560.000000 -0.002246 -0.000068 0.001213 +4693 1 0.000276 1560.000000 0.000024 0.000394 0.005041 +4694 1 0.000279 1560.000000 0.000570 0.001761 0.002041 +4695 1 0.000240 1560.000000 0.000311 -0.001077 0.006783 +4696 1 0.000258 1560.000000 -0.000725 -0.002655 0.007030 +4697 1 0.000273 1560.000000 -0.002135 -0.001473 0.001801 +4698 1 0.000264 1560.000000 -0.003148 -0.001771 0.004665 +4699 1 0.000288 1560.000000 0.002258 -0.000615 0.008196 +4700 1 0.000192 1560.000000 -0.000100 0.001215 0.002794 +4701 1 0.000251 1560.000000 0.001780 0.002999 0.002949 +4702 1 0.000244 1560.000000 0.001363 -0.000230 0.004841 +4703 1 0.000213 1560.000000 -0.000494 -0.000081 0.001244 +4704 1 0.000238 1560.000000 0.003325 0.001709 0.004968 +4705 1 0.000209 1560.000000 0.000423 0.003492 0.007750 +4706 1 0.000203 1560.000000 0.002816 -0.002434 0.001051 +4707 1 0.000239 1560.000000 -0.001187 0.002236 0.002575 +4708 1 0.000237 1560.000000 -0.000946 -0.002950 0.003402 +4709 1 0.000196 1560.000000 -0.000877 0.000099 0.007714 +4710 1 0.000238 1560.000000 -0.000037 0.000449 0.009534 +4711 1 0.000281 1560.000000 0.000715 -0.000202 0.006305 +4712 1 0.000219 1560.000000 -0.003433 0.000587 0.006932 +4713 1 0.000217 1560.000000 -0.002307 -0.000738 0.003168 +4714 1 0.000222 1560.000000 -0.001666 0.001766 0.003913 +4715 1 0.000219 1560.000000 -0.001093 -0.003042 0.001987 +4716 1 0.000228 1560.000000 -0.000848 0.000095 0.002204 +4717 1 0.000225 1560.000000 0.001204 -0.001403 0.006512 +4718 1 0.000218 1560.000000 -0.000958 -0.001735 0.000280 +4719 1 0.000203 1560.000000 0.000268 0.000498 0.001809 +4720 1 0.000200 1560.000000 0.001530 0.001803 0.001918 +4721 1 0.000257 1560.000000 -0.003202 -0.001710 0.005656 +4722 1 0.000247 1560.000000 -0.001529 -0.001026 0.008988 +4723 1 0.000242 1560.000000 -0.001880 0.002504 0.002290 +4724 1 0.000216 1560.000000 -0.001529 0.002408 0.000835 +4725 1 0.000195 1560.000000 0.000853 0.000316 0.003526 +4726 1 0.000212 1560.000000 0.003111 0.002273 0.003550 +4727 1 0.000283 1560.000000 -0.002589 0.001982 0.006478 +4728 1 0.000253 1560.000000 -0.001515 -0.002141 0.006896 +4729 1 0.000247 1560.000000 0.002028 -0.001455 0.006150 +4730 1 0.000208 1560.000000 -0.001095 -0.001220 0.001041 +4731 1 0.000238 1560.000000 -0.000373 -0.002321 0.001650 +4732 1 0.000282 1560.000000 -0.002511 0.002084 0.000691 +4733 1 0.000251 1560.000000 -0.002897 0.000773 0.007453 +4734 1 0.000197 1560.000000 -0.001380 0.002579 0.005712 +4735 1 0.000207 1560.000000 0.001911 -0.003253 0.006404 +4736 1 0.000279 1560.000000 0.000138 0.001386 0.008904 +4737 1 0.000234 1560.000000 -0.003187 -0.000924 0.002022 +4738 1 0.000220 1560.000000 0.000168 0.000193 0.002854 +4739 1 0.000194 1560.000000 -0.000919 0.002252 0.009201 +4740 1 0.000265 1560.000000 -0.000478 0.003514 0.006191 +4741 1 0.000210 1560.000000 -0.000543 0.000733 0.008307 +4742 1 0.000283 1560.000000 0.001590 -0.000781 0.003587 +4743 1 0.000229 1560.000000 0.002619 -0.002370 0.004358 +4744 1 0.000213 1560.000000 0.000343 0.001714 0.009733 +4745 1 0.000200 1560.000000 -0.002579 0.001580 0.000734 +4746 1 0.000203 1560.000000 -0.001380 0.000567 0.004443 +4747 1 0.000228 1560.000000 0.003187 0.001355 0.006315 +4748 1 0.000233 1560.000000 0.000371 0.002282 0.002675 +4749 1 0.000202 1560.000000 0.001462 0.000981 0.006239 +4750 1 0.000258 1560.000000 -0.001605 -0.001866 0.009267 +4751 1 0.000213 1560.000000 0.001011 -0.002838 0.008479 +4752 1 0.000217 1560.000000 0.000594 -0.002205 0.008175 +4753 1 0.000211 1560.000000 0.001441 -0.001285 0.009319 +4754 1 0.000196 1560.000000 -0.001602 -0.000916 0.001480 +4755 1 0.000277 1560.000000 0.000662 -0.001576 0.003712 +4756 1 0.000275 1560.000000 -0.002774 -0.002260 0.001186 +4757 1 0.000220 1560.000000 -0.001526 -0.001700 0.007733 +4758 1 0.000209 1560.000000 0.000559 0.001472 0.000563 +4759 1 0.000213 1560.000000 0.003420 0.000954 0.002729 +4760 1 0.000212 1560.000000 -0.000104 0.003626 0.001424 +4761 1 0.000197 1560.000000 -0.002624 0.001004 0.005945 +4762 1 0.000198 1560.000000 0.001352 -0.001651 0.009350 +4763 1 0.000263 1560.000000 0.000958 0.001850 0.005082 +4764 1 0.000286 1560.000000 -0.002650 -0.000587 0.007670 +4765 1 0.000218 1560.000000 -0.000969 0.002797 0.001326 +4766 1 0.000254 1560.000000 0.000022 0.002867 0.003604 +4767 1 0.000277 1560.000000 -0.002260 -0.000725 0.007012 +4768 1 0.000203 1560.000000 0.000717 0.001824 0.004079 +4769 1 0.000207 1560.000000 -0.000341 0.000086 0.007257 +4770 1 0.000233 1560.000000 0.000847 -0.001137 0.001929 +4771 1 0.000267 1560.000000 -0.001900 -0.000957 0.009248 +4772 1 0.000259 1560.000000 -0.000019 0.000925 0.006051 +4773 1 0.000249 1560.000000 0.000622 -0.000984 0.008510 +4774 1 0.000256 1560.000000 0.001121 0.000377 0.003542 +4775 1 0.000224 1560.000000 0.001849 0.001588 0.006803 +4776 1 0.000206 1560.000000 0.000543 0.002988 0.007593 +4777 1 0.000288 1560.000000 -0.002585 0.000976 0.004194 +4778 1 0.000288 1560.000000 0.001978 -0.000905 0.004480 +4779 1 0.000279 1560.000000 0.000770 0.002619 0.001646 +4780 1 0.000205 1560.000000 -0.001832 0.002018 0.002087 +4781 1 0.000247 1560.000000 -0.000421 -0.001119 0.009412 +4782 1 0.000194 1560.000000 -0.000027 0.001909 0.009128 +4783 1 0.000206 1560.000000 -0.000770 0.002041 0.009647 +4784 1 0.000236 1560.000000 0.000328 -0.002889 0.003825 +4785 1 0.000215 1560.000000 0.000349 -0.000319 0.004251 +4786 1 0.000208 1560.000000 0.001523 -0.002884 0.002174 +4787 1 0.000268 1560.000000 -0.001710 0.003145 0.005190 +4788 1 0.000286 1560.000000 0.002680 -0.000195 0.008225 +4789 1 0.000240 1560.000000 0.000474 0.000180 0.006491 +4790 1 0.000252 1560.000000 -0.000485 -0.001724 0.007553 +4791 1 0.000208 1560.000000 -0.001369 0.002996 0.006532 +4792 1 0.000230 1560.000000 0.001855 0.001296 0.002634 +4793 1 0.000219 1560.000000 0.001469 -0.002988 0.002497 +4794 1 0.000288 1560.000000 0.001215 0.002496 0.009286 +4795 1 0.000224 1560.000000 -0.000560 -0.002907 0.003031 +4796 1 0.000228 1560.000000 0.003642 -0.000018 0.007735 +4797 1 0.000230 1560.000000 0.003425 -0.001609 0.004206 +4798 1 0.000275 1560.000000 0.002153 -0.003111 0.009330 +4799 1 0.000284 1560.000000 -0.000345 -0.000748 0.009532 +4800 1 0.000198 1560.000000 0.000839 -0.000881 0.000418 +4801 1 0.000237 1560.000000 -0.002737 -0.001122 0.006064 +4802 1 0.000251 1560.000000 0.002920 -0.002476 0.004485 +4803 1 0.000262 1560.000000 0.002231 0.002668 0.009780 +4804 1 0.000241 1560.000000 0.000031 -0.001168 0.009775 +4805 1 0.000236 1560.000000 -0.002222 -0.000415 0.004248 +4806 1 0.000222 1560.000000 0.002249 -0.000505 0.004634 +4807 1 0.000275 1560.000000 0.000834 0.002485 0.000618 +4808 1 0.000232 1560.000000 0.003338 0.000243 0.002723 +4809 1 0.000195 1560.000000 -0.001958 0.002269 0.007454 +4810 1 0.000273 1560.000000 0.000965 0.003273 0.005460 +4811 1 0.000272 1560.000000 0.000078 -0.001213 0.006457 +4812 1 0.000247 1560.000000 0.000833 -0.002296 0.008365 +4813 1 0.000220 1560.000000 0.001061 0.000589 0.003973 +4814 1 0.000253 1560.000000 -0.001005 0.000645 0.006787 +4815 1 0.000235 1560.000000 -0.002318 -0.000252 0.005016 +4816 1 0.000251 1560.000000 0.002306 -0.001822 0.008336 +4817 1 0.000193 1560.000000 0.003597 -0.000754 0.001000 +4818 1 0.000253 1560.000000 0.002443 0.000216 0.009429 +4819 1 0.000198 1560.000000 -0.002397 0.000139 0.003756 +4820 1 0.000202 1560.000000 0.003605 -0.000449 0.000533 +4821 1 0.000218 1560.000000 0.000545 -0.002308 0.001356 +4822 1 0.000195 1560.000000 0.000627 0.001923 0.003755 +4823 1 0.000241 1560.000000 0.002001 -0.002016 0.002444 +4824 1 0.000208 1560.000000 0.000317 0.002453 0.004584 +4825 1 0.000267 1560.000000 -0.000707 -0.003417 0.006767 +4826 1 0.000212 1560.000000 0.000440 -0.000914 0.002117 +4827 1 0.000218 1560.000000 -0.000799 -0.002829 0.006400 +4828 1 0.000202 1560.000000 -0.000383 0.001440 0.004587 +4829 1 0.000268 1560.000000 -0.000510 -0.002110 0.002795 +4830 1 0.000249 1560.000000 0.002077 0.000366 0.001221 +4831 1 0.000219 1560.000000 -0.000259 -0.000548 0.002137 +4832 1 0.000223 1560.000000 -0.000664 -0.000908 0.007389 +4833 1 0.000265 1560.000000 0.001614 -0.000406 0.004819 +4834 1 0.000205 1560.000000 -0.002900 -0.002028 0.003626 +4835 1 0.000288 1560.000000 0.002783 -0.001266 0.005525 +4836 1 0.000271 1560.000000 -0.001064 0.001622 0.000548 +4837 1 0.000229 1560.000000 0.003253 -0.000206 0.001337 +4838 1 0.000193 1560.000000 0.001521 0.002627 0.004442 +4839 1 0.000213 1560.000000 -0.000126 -0.000667 0.003605 +4840 1 0.000210 1560.000000 0.000245 0.003515 0.004194 +4841 1 0.000213 1560.000000 -0.002739 -0.001786 0.001280 +4842 1 0.000221 1560.000000 -0.001564 0.002386 0.002362 +4843 1 0.000280 1560.000000 -0.001579 0.001570 0.004114 +4844 1 0.000244 1560.000000 -0.000600 -0.001987 0.006389 +4845 1 0.000208 1560.000000 0.001862 -0.000568 0.008686 +4846 1 0.000279 1560.000000 0.002743 -0.002489 0.002618 +4847 1 0.000237 1560.000000 0.002153 -0.001493 0.003239 +4848 1 0.000242 1560.000000 -0.002125 0.001996 0.007620 +4849 1 0.000194 1560.000000 -0.000596 0.003012 0.009622 +4850 1 0.000199 1560.000000 -0.000616 -0.000139 0.009247 +4851 1 0.000266 1560.000000 0.001483 0.000809 0.004166 +4852 1 0.000231 1560.000000 -0.002575 0.001807 0.001153 +4853 1 0.000202 1560.000000 0.000993 -0.001166 0.003884 +4854 1 0.000204 1560.000000 0.000615 -0.000439 0.001369 +4855 1 0.000212 1560.000000 0.000998 0.001235 0.002417 +4856 1 0.000226 1560.000000 0.001168 0.000991 0.005423 +4857 1 0.000232 1560.000000 -0.001622 0.000288 0.005226 +4858 1 0.000207 1560.000000 -0.001776 -0.002533 0.004931 +4859 1 0.000239 1560.000000 0.002024 0.000078 0.008429 +4860 1 0.000279 1560.000000 -0.000215 -0.000947 0.009128 +4861 1 0.000277 1560.000000 0.001142 0.002192 0.004716 +4862 1 0.000232 1560.000000 0.002879 0.001475 0.008350 +4863 1 0.000280 1560.000000 -0.003574 0.000189 0.002317 +4864 1 0.000216 1560.000000 0.000982 -0.002677 0.001353 +4865 1 0.000203 1560.000000 -0.001893 -0.002449 0.007217 +4866 1 0.000224 1560.000000 -0.000599 -0.002968 0.001541 +4867 1 0.000286 1560.000000 -0.002656 0.000906 0.009152 +4868 1 0.000200 1560.000000 0.001722 -0.002199 0.007460 +4869 1 0.000261 1560.000000 0.001393 -0.000224 0.007149 +4870 1 0.000225 1560.000000 0.002205 -0.001269 0.009265 +4871 1 0.000251 1560.000000 0.001352 -0.003451 0.000432 +4872 1 0.000261 1560.000000 -0.002839 0.001145 0.007574 +4873 1 0.000234 1560.000000 0.000858 0.001148 0.006545 +4874 1 0.000200 1560.000000 -0.003406 -0.001712 0.005926 +4875 1 0.000257 1560.000000 0.001520 0.000404 0.007275 +4876 1 0.000204 1560.000000 0.002530 -0.002372 0.005157 +4877 1 0.000211 1560.000000 0.001997 0.001679 0.005882 +4878 1 0.000221 1560.000000 -0.002431 -0.000239 0.004188 +4879 1 0.000268 1560.000000 -0.001176 0.003152 0.001059 +4880 1 0.000285 1560.000000 0.000239 0.000438 0.007977 +4881 1 0.000230 1560.000000 0.002727 -0.002176 0.001551 +4882 1 0.000260 1560.000000 -0.000228 -0.001423 0.002155 +4883 1 0.000245 1560.000000 0.002573 -0.002073 0.002355 +4884 1 0.000244 1560.000000 -0.000900 0.000650 0.007996 +4885 1 0.000198 1560.000000 0.001102 -0.001406 0.001197 +4886 1 0.000261 1560.000000 0.002195 0.000389 0.000299 +4887 1 0.000283 1560.000000 -0.003451 0.001429 0.009267 +4888 1 0.000248 1560.000000 0.003400 -0.000915 0.001187 +4889 1 0.000274 1560.000000 0.000565 0.000171 0.007546 +4890 1 0.000275 1560.000000 -0.000342 -0.000876 0.007153 +4891 1 0.000232 1560.000000 -0.001032 -0.001025 0.007619 +4892 1 0.000260 1560.000000 0.001323 0.001376 0.000210 +4893 1 0.000227 1560.000000 -0.003066 0.002088 0.004558 +4894 1 0.000202 1560.000000 0.000162 -0.002590 0.003621 +4895 1 0.000225 1560.000000 -0.001867 0.001342 0.004317 +4896 1 0.000283 1560.000000 0.000484 -0.001662 0.001985 +4897 1 0.000280 1560.000000 -0.001728 -0.000309 0.004375 +4898 1 0.000220 1560.000000 0.000081 0.002843 0.005675 +4899 1 0.000241 1560.000000 -0.002205 0.001329 0.007600 +4900 1 0.000228 1560.000000 -0.001144 -0.000083 0.002243 +4901 1 0.000224 1560.000000 0.001034 -0.001139 0.006010 +4902 1 0.000221 1560.000000 -0.000055 -0.003096 0.003251 +4903 1 0.000210 1560.000000 0.000705 0.000727 0.003717 +4904 1 0.000221 1560.000000 0.002679 0.000338 0.003474 +4905 1 0.000192 1560.000000 -0.001929 -0.000573 0.005184 +4906 1 0.000219 1560.000000 0.000295 -0.001489 0.006340 +4907 1 0.000233 1560.000000 0.001092 0.002752 0.008118 +4908 1 0.000195 1560.000000 0.000895 0.000349 0.007829 +4909 1 0.000239 1560.000000 0.001514 -0.002216 0.005572 +4910 1 0.000233 1560.000000 0.001087 0.000106 0.005628 +4911 1 0.000254 1560.000000 0.000840 0.000812 0.006629 +4912 1 0.000217 1560.000000 0.001591 0.001509 0.002156 +4913 1 0.000192 1560.000000 -0.001420 0.000802 0.004354 +4914 1 0.000229 1560.000000 -0.000336 0.000263 0.002295 +4915 1 0.000195 1560.000000 0.001609 -0.001698 0.005046 +4916 1 0.000253 1560.000000 0.002545 -0.002882 0.001889 +4917 1 0.000231 1560.000000 0.001274 -0.000791 0.008555 +4918 1 0.000217 1560.000000 -0.001509 0.000551 0.001081 +4919 1 0.000246 1560.000000 0.000419 0.000050 0.003794 +4920 1 0.000200 1560.000000 -0.000089 0.000995 0.001093 +4921 1 0.000195 1560.000000 0.000915 -0.000098 0.002650 +4922 1 0.000193 1560.000000 0.000432 0.000481 0.006075 +4923 1 0.000226 1560.000000 -0.001315 0.000278 0.008512 +4924 1 0.000271 1560.000000 -0.001467 0.001814 0.009837 +4925 1 0.000213 1560.000000 0.002071 0.002018 0.008995 +4926 1 0.000208 1560.000000 0.003029 0.001336 0.006630 +4927 1 0.000231 1560.000000 0.002135 0.000599 0.003664 +4928 1 0.000265 1560.000000 -0.001355 -0.000090 0.004786 +4929 1 0.000243 1560.000000 -0.002208 0.003022 0.008820 +4930 1 0.000203 1560.000000 0.000083 -0.000452 0.009553 +4931 1 0.000204 1560.000000 0.002228 0.002834 0.008694 +4932 1 0.000284 1560.000000 -0.000763 0.001291 0.007933 +4933 1 0.000217 1560.000000 -0.000461 -0.000621 0.005434 +4934 1 0.000250 1560.000000 -0.001913 0.001604 0.005203 +4935 1 0.000194 1560.000000 -0.000474 -0.001206 0.006098 +4936 1 0.000197 1560.000000 -0.000352 0.000029 0.001408 +4937 1 0.000256 1560.000000 -0.000625 0.003076 0.005339 +4938 1 0.000268 1560.000000 0.001687 -0.000969 0.009254 +4939 1 0.000248 1560.000000 -0.000469 0.001015 0.002140 +4940 1 0.000250 1560.000000 0.003694 0.000705 0.006566 +4941 1 0.000222 1560.000000 0.000151 0.000229 0.006334 +4942 1 0.000201 1560.000000 0.001026 0.000715 0.007303 +4943 1 0.000221 1560.000000 0.001612 0.000341 0.006934 +4944 1 0.000276 1560.000000 0.001325 -0.001031 0.002152 +4945 1 0.000269 1560.000000 0.000426 0.003066 0.006407 +4946 1 0.000202 1560.000000 0.001388 -0.001980 0.003586 +4947 1 0.000202 1560.000000 -0.001382 0.000971 0.005566 +4948 1 0.000196 1560.000000 -0.002279 -0.000992 0.008808 +4949 1 0.000237 1560.000000 -0.000475 -0.002777 0.002840 +4950 1 0.000274 1560.000000 0.001817 0.002868 0.004013 +4951 1 0.000240 1560.000000 -0.003560 0.000548 0.004839 +4952 1 0.000216 1560.000000 0.001552 -0.000416 0.003448 +4953 1 0.000200 1560.000000 0.002946 -0.001072 0.004546 +4954 1 0.000200 1560.000000 0.000515 -0.000669 0.001989 +4955 1 0.000210 1560.000000 0.001616 0.003259 0.004825 +4956 1 0.000271 1560.000000 0.001088 -0.002705 0.000190 +4957 1 0.000234 1560.000000 -0.001386 -0.001089 0.007399 +4958 1 0.000226 1560.000000 0.000718 0.001421 0.005093 +4959 1 0.000285 1560.000000 -0.001560 -0.001157 0.006173 +4960 1 0.000234 1560.000000 0.002821 -0.000141 0.001144 +4961 1 0.000242 1560.000000 0.002212 0.000779 0.004460 +4962 1 0.000205 1560.000000 -0.000393 0.000760 0.002173 +4963 1 0.000202 1560.000000 0.000528 -0.001859 0.003426 +4964 1 0.000278 1560.000000 0.001038 0.001294 0.004837 +4965 1 0.000201 1560.000000 -0.002593 0.000090 0.000294 +4966 1 0.000239 1560.000000 -0.001037 -0.003627 0.004626 +4967 1 0.000271 1560.000000 -0.000570 0.001502 0.008808 +4968 1 0.000263 1560.000000 0.001916 -0.000565 0.005066 +4969 1 0.000230 1560.000000 -0.001396 0.003588 0.009750 +4970 1 0.000237 1560.000000 0.000064 0.002902 0.003136 +4971 1 0.000221 1560.000000 0.003104 -0.001126 0.004315 +4972 1 0.000213 1560.000000 -0.002944 -0.000112 0.007919 +4973 1 0.000244 1560.000000 0.000813 0.000408 0.005740 +4974 1 0.000197 1560.000000 -0.000863 -0.003230 0.006363 +4975 1 0.000269 1560.000000 -0.002645 0.001329 0.006640 +4976 1 0.000211 1560.000000 0.003633 -0.000248 0.007394 +4977 1 0.000206 1560.000000 0.000853 -0.002681 0.004351 +4978 1 0.000225 1560.000000 -0.002675 -0.001756 0.007717 +4979 1 0.000250 1560.000000 -0.001109 0.001023 0.007778 +4980 1 0.000198 1560.000000 -0.002876 -0.001836 0.008353 +4981 1 0.000200 1560.000000 -0.001854 0.000933 0.005784 +4982 1 0.000246 1560.000000 -0.001260 0.001597 0.007015 +4983 1 0.000214 1560.000000 0.001095 -0.003369 0.007100 +4984 1 0.000233 1560.000000 0.000972 -0.002621 0.004734 +4985 1 0.000243 1560.000000 -0.002513 -0.000583 0.001550 +4986 1 0.000276 1560.000000 0.000112 0.003802 0.000620 +4987 1 0.000229 1560.000000 -0.003545 -0.000236 0.006881 +4988 1 0.000268 1560.000000 0.003012 -0.002386 0.009713 +4989 1 0.000235 1560.000000 -0.000639 0.002053 0.005522 +4990 1 0.000222 1560.000000 0.000495 0.001193 0.007034 +4991 1 0.000215 1560.000000 0.002306 0.000323 0.001842 +4992 1 0.000243 1560.000000 -0.000830 -0.000668 0.009827 +4993 1 0.000246 1560.000000 -0.003424 -0.001603 0.006729 +4994 1 0.000255 1560.000000 0.003341 0.000950 0.005304 +4995 1 0.000234 1560.000000 0.002285 0.002980 0.004868 +4996 1 0.000264 1560.000000 -0.000939 0.000354 0.007063 +4997 1 0.000199 1560.000000 -0.000508 0.003627 0.009462 +4998 1 0.000249 1560.000000 0.000080 0.002252 0.003113 +4999 1 0.000216 1560.000000 -0.003519 0.000305 0.007606 +5000 1 0.000271 1560.000000 0.003480 0.001422 0.007117 +5001 1 0.000236 1560.000000 0.000262 -0.002496 0.001574 +5002 1 0.000208 1560.000000 -0.003446 0.000303 0.003170 +5003 1 0.000263 1560.000000 0.000155 -0.002289 0.008696 +5004 1 0.000232 1560.000000 -0.002012 0.001310 0.007262 +5005 1 0.000204 1560.000000 -0.000934 0.002609 0.007014 +5006 1 0.000206 1560.000000 0.002124 0.000418 0.008239 +5007 1 0.000243 1560.000000 0.000891 -0.003189 0.009640 +5008 1 0.000277 1560.000000 0.002009 -0.001347 0.000565 +5009 1 0.000222 1560.000000 0.000894 0.003708 0.005775 +5010 1 0.000274 1560.000000 -0.000798 -0.003126 0.000703 +5011 1 0.000228 1560.000000 0.000304 0.000476 0.005817 +5012 1 0.000269 1560.000000 -0.002145 -0.002635 0.000427 +5013 1 0.000216 1560.000000 0.001305 0.003541 0.006196 +5014 1 0.000198 1560.000000 0.003504 -0.000232 0.005857 +5015 1 0.000255 1560.000000 -0.002622 0.001428 0.006345 +5016 1 0.000264 1560.000000 0.000363 0.003755 0.000310 +5017 1 0.000243 1560.000000 0.002434 0.000172 0.002309 +5018 1 0.000215 1560.000000 -0.001488 -0.002965 0.000395 +5019 1 0.000214 1560.000000 -0.002489 -0.001577 0.007732 +5020 1 0.000245 1560.000000 -0.001398 -0.002901 0.009283 +5021 1 0.000231 1560.000000 -0.001603 -0.000620 0.002394 +5022 1 0.000218 1560.000000 0.003514 -0.001209 0.006966 +5023 1 0.000197 1560.000000 0.001137 -0.003063 0.009492 +5024 1 0.000283 1560.000000 -0.001188 -0.001387 0.003616 +5025 1 0.000215 1560.000000 -0.002672 -0.001853 0.003122 +5026 1 0.000237 1560.000000 0.003300 -0.001504 0.000366 +5027 1 0.000265 1560.000000 0.001635 -0.001266 0.009764 +5028 1 0.000211 1560.000000 -0.001285 0.002620 0.001743 +5029 1 0.000250 1560.000000 -0.000183 -0.003785 0.000558 +5030 1 0.000223 1560.000000 -0.001741 0.003045 0.003585 +5031 1 0.000217 1560.000000 -0.002456 -0.002899 0.009210 +5032 1 0.000237 1560.000000 -0.001006 0.002253 0.007292 +5033 1 0.000197 1560.000000 0.001923 0.003321 0.005323 +5034 1 0.000233 1560.000000 -0.001262 0.002614 0.007094 +5035 1 0.000212 1560.000000 -0.000280 -0.000648 0.005905 +5036 1 0.000241 1560.000000 0.002681 -0.001755 0.004752 +5037 1 0.000214 1560.000000 -0.002570 0.001159 0.000298 +5038 1 0.000209 1560.000000 -0.001166 -0.003191 0.006336 +5039 1 0.000218 1560.000000 0.002677 -0.002257 0.009418 +5040 1 0.000204 1560.000000 0.003106 0.000508 0.002632 +5041 1 0.000199 1560.000000 -0.003117 -0.001572 0.009543 +5042 1 0.000239 1560.000000 0.001798 -0.000345 0.008493 +5043 1 0.000199 1560.000000 0.002952 -0.001293 0.003738 +5044 1 0.000221 1560.000000 -0.001498 -0.002362 0.002223 +5045 1 0.000243 1560.000000 -0.003491 -0.000453 0.003280 +5046 1 0.000242 1560.000000 -0.002979 0.001092 0.003670 +5047 1 0.000199 1560.000000 -0.000776 -0.001942 0.003540 +5048 1 0.000270 1560.000000 -0.000242 0.001747 0.001647 +5049 1 0.000221 1560.000000 0.001599 0.003151 0.002473 +5050 1 0.000288 1560.000000 0.002144 -0.001136 0.008320 +5051 1 0.000197 1560.000000 0.001940 0.002889 0.006478 +5052 1 0.000198 1560.000000 -0.000912 -0.002003 0.000107 +5053 1 0.000219 1560.000000 0.001331 -0.000316 0.009300 +5054 1 0.000206 1560.000000 0.000580 0.000193 0.001786 +5055 1 0.000269 1560.000000 0.002199 -0.000177 0.002714 +5056 1 0.000204 1560.000000 0.000371 0.002834 0.005191 +5057 1 0.000256 1560.000000 -0.000397 -0.000872 0.001580 +5058 1 0.000271 1560.000000 -0.001699 -0.003011 0.007837 +5059 1 0.000206 1560.000000 -0.000526 -0.000523 0.008461 +5060 1 0.000222 1560.000000 -0.003653 -0.000414 0.000115 +5061 1 0.000197 1560.000000 -0.002467 0.001227 0.003402 +5062 1 0.000202 1560.000000 0.000454 0.002241 0.001919 +5063 1 0.000209 1560.000000 -0.002499 0.000138 0.003274 +5064 1 0.000284 1560.000000 -0.000223 -0.001415 0.009275 +5065 1 0.000228 1560.000000 -0.003291 0.001950 0.003971 +5066 1 0.000244 1560.000000 0.002274 -0.002096 0.001986 +5067 1 0.000286 1560.000000 -0.000033 -0.002879 0.002649 +5068 1 0.000200 1560.000000 -0.002002 0.000047 0.004725 +5069 1 0.000197 1560.000000 -0.000431 0.000242 0.007055 +5070 1 0.000219 1560.000000 0.001611 0.000606 0.003583 +5071 1 0.000194 1560.000000 0.000225 -0.003824 0.005994 +5072 1 0.000223 1560.000000 -0.000175 0.002809 0.006827 +5073 1 0.000197 1560.000000 -0.001536 -0.000680 0.003121 +5074 1 0.000223 1560.000000 0.001036 0.000276 0.000929 +5075 1 0.000202 1560.000000 -0.002090 0.003182 0.005284 +5076 1 0.000259 1560.000000 -0.001382 -0.000177 0.003337 +5077 1 0.000229 1560.000000 0.000664 -0.001282 0.003565 +5078 1 0.000203 1560.000000 -0.002952 -0.000862 0.009719 +5079 1 0.000215 1560.000000 0.000064 -0.003312 0.004109 +5080 1 0.000279 1560.000000 0.001010 0.000849 0.002790 +5081 1 0.000225 1560.000000 0.000816 0.001162 0.006879 +5082 1 0.000202 1560.000000 0.003595 -0.001227 0.009286 +5083 1 0.000265 1560.000000 0.002205 -0.000553 0.005870 +5084 1 0.000206 1560.000000 0.001748 0.000096 0.003053 +5085 1 0.000263 1560.000000 -0.000436 -0.000904 0.006076 +5086 1 0.000208 1560.000000 0.003187 0.000872 0.003732 +5087 1 0.000197 1560.000000 0.000515 -0.002905 0.003655 +5088 1 0.000220 1560.000000 0.001009 -0.003538 0.003206 +5089 1 0.000220 1560.000000 -0.001364 0.002465 0.008525 +5090 1 0.000222 1560.000000 0.002466 -0.002255 0.000179 +5091 1 0.000196 1560.000000 0.003517 -0.001210 0.006560 +5092 1 0.000254 1560.000000 0.002129 -0.003118 0.002997 +5093 1 0.000213 1560.000000 0.001410 0.001206 0.005840 +5094 1 0.000234 1560.000000 0.002649 -0.001377 0.002500 +5095 1 0.000203 1560.000000 0.002478 -0.000668 0.006453 +5096 1 0.000212 1560.000000 -0.000501 -0.001705 0.005068 +5097 1 0.000197 1560.000000 -0.000520 -0.003108 0.003370 +5098 1 0.000247 1560.000000 -0.003189 0.001423 0.006227 +5099 1 0.000218 1560.000000 0.001820 0.000918 0.004623 +5100 1 0.000232 1560.000000 0.001243 0.002068 0.003918 +5101 1 0.000221 1560.000000 -0.002526 -0.002196 0.002629 +5102 1 0.000225 1560.000000 -0.001489 0.002248 0.005205 +5103 1 0.000271 1560.000000 -0.000361 0.002758 0.004676 +5104 1 0.000252 1560.000000 0.000103 0.000596 0.006977 +5105 1 0.000248 1560.000000 -0.000228 -0.000800 0.006557 +5106 1 0.000226 1560.000000 0.000535 0.002866 0.005474 +5107 1 0.000243 1560.000000 -0.000059 0.000989 0.004639 +5108 1 0.000210 1560.000000 -0.000378 0.000657 0.000712 +5109 1 0.000208 1560.000000 0.000886 0.002657 0.009273 +5110 1 0.000279 1560.000000 -0.001844 -0.003256 0.005685 +5111 1 0.000213 1560.000000 -0.000777 0.002536 0.004440 +5112 1 0.000214 1560.000000 0.002391 0.002462 0.004446 +5113 1 0.000256 1560.000000 0.001718 0.003127 0.005491 +5114 1 0.000256 1560.000000 -0.002149 -0.001444 0.007968 +5115 1 0.000250 1560.000000 -0.002672 0.000235 0.005383 +5116 1 0.000284 1560.000000 0.001252 -0.002134 0.006650 +5117 1 0.000256 1560.000000 0.002643 0.000802 0.003996 +5118 1 0.000223 1560.000000 0.000183 0.001551 0.004683 +5119 1 0.000210 1560.000000 0.001987 0.003128 0.004241 +5120 1 0.000239 1560.000000 0.000446 -0.003451 0.007800 +5121 1 0.000266 1560.000000 -0.001670 -0.002577 0.003135 +5122 1 0.000267 1560.000000 0.001623 0.002252 0.001322 +5123 1 0.000222 1560.000000 -0.001740 0.001072 0.000131 +5124 1 0.000214 1560.000000 0.001113 0.000897 0.004287 +5125 1 0.000203 1560.000000 -0.000417 -0.002629 0.004142 +5126 1 0.000267 1560.000000 -0.000269 0.002617 0.005438 +5127 1 0.000246 1560.000000 -0.002895 0.002199 0.001573 +5128 1 0.000237 1560.000000 0.001604 0.002864 0.008723 +5129 1 0.000219 1560.000000 0.002375 0.001134 0.000992 +5130 1 0.000225 1560.000000 -0.000080 0.002641 0.009613 +5131 1 0.000266 1560.000000 0.001307 0.001200 0.000407 +5132 1 0.000241 1560.000000 -0.000001 0.000856 0.008718 +5133 1 0.000222 1560.000000 -0.000288 0.001416 0.008260 +5134 1 0.000282 1560.000000 -0.002689 -0.002546 0.006946 +5135 1 0.000256 1560.000000 0.000242 -0.000924 0.002664 +5136 1 0.000193 1560.000000 0.003634 -0.001101 0.003346 +5137 1 0.000229 1560.000000 -0.000750 -0.003684 0.006850 +5138 1 0.000245 1560.000000 -0.001084 0.001277 0.004175 +5139 1 0.000194 1560.000000 -0.003032 -0.001127 0.007208 +5140 1 0.000220 1560.000000 0.002072 -0.001174 0.009803 +5141 1 0.000250 1560.000000 -0.000975 0.001488 0.009638 +5142 1 0.000260 1560.000000 0.002332 0.000435 0.005846 +5143 1 0.000237 1560.000000 0.002299 -0.001841 0.008912 +5144 1 0.000283 1560.000000 0.000921 0.002721 0.003914 +5145 1 0.000211 1560.000000 -0.001471 0.001863 0.000985 +5146 1 0.000196 1560.000000 0.000355 -0.002508 0.009089 +5147 1 0.000280 1560.000000 -0.001569 0.003323 0.007226 +5148 1 0.000269 1560.000000 -0.000859 0.001375 0.000423 +5149 1 0.000195 1560.000000 0.000938 -0.001078 0.000462 +5150 1 0.000257 1560.000000 -0.001715 0.000700 0.003667 +5151 1 0.000236 1560.000000 0.000681 -0.003738 0.006972 +5152 1 0.000213 1560.000000 -0.000383 0.002470 0.003750 +5153 1 0.000210 1560.000000 -0.000012 0.001204 0.002172 +5154 1 0.000280 1560.000000 -0.000207 0.000860 0.007373 +5155 1 0.000205 1560.000000 0.000146 -0.002624 0.006296 +5156 1 0.000214 1560.000000 -0.002115 -0.001837 0.008321 +5157 1 0.000222 1560.000000 0.002711 0.001480 0.007158 +5158 1 0.000282 1560.000000 0.001759 0.003425 0.006252 +5159 1 0.000271 1560.000000 -0.001774 -0.001795 0.008315 +5160 1 0.000280 1560.000000 0.000020 0.002912 0.009422 +5161 1 0.000197 1560.000000 0.002848 0.001696 0.001460 +5162 1 0.000286 1560.000000 -0.001370 0.002351 0.009097 +5163 1 0.000261 1560.000000 0.002012 -0.001147 0.008586 +5164 1 0.000256 1560.000000 0.001338 0.000626 0.003511 +5165 1 0.000216 1560.000000 -0.003354 0.001445 0.002366 +5166 1 0.000215 1560.000000 0.001332 -0.002251 0.001752 +5167 1 0.000207 1560.000000 -0.001041 -0.002505 0.004257 +5168 1 0.000220 1560.000000 -0.000769 -0.000272 0.002053 +5169 1 0.000265 1560.000000 0.000869 -0.001513 0.005697 +5170 1 0.000192 1560.000000 0.001023 -0.001216 0.008769 +5171 1 0.000217 1560.000000 -0.002138 -0.001726 0.006926 +5172 1 0.000237 1560.000000 -0.001933 -0.002919 0.003286 +5173 1 0.000209 1560.000000 0.000075 0.002365 0.007666 +5174 1 0.000199 1560.000000 0.000873 -0.002230 0.004387 +5175 1 0.000225 1560.000000 -0.001591 -0.003480 0.005678 +5176 1 0.000269 1560.000000 0.000891 -0.001708 0.006501 +5177 1 0.000265 1560.000000 -0.001773 -0.000183 0.007836 +5178 1 0.000234 1560.000000 0.003250 -0.001465 0.006703 +5179 1 0.000283 1560.000000 -0.001511 -0.002077 0.003339 +5180 1 0.000203 1560.000000 -0.002368 0.000987 0.008799 +5181 1 0.000247 1560.000000 -0.001505 -0.000428 0.000754 +5182 1 0.000288 1560.000000 0.001822 -0.001993 0.001176 +5183 1 0.000243 1560.000000 0.002858 0.002426 0.003692 +5184 1 0.000231 1560.000000 0.001145 -0.000983 0.003172 +5185 1 0.000280 1560.000000 -0.001642 -0.000790 0.004525 +5186 1 0.000263 1560.000000 0.003741 -0.000562 0.009286 +5187 1 0.000205 1560.000000 0.003452 0.000807 0.001211 +5188 1 0.000239 1560.000000 0.002049 0.000668 0.000142 +5189 1 0.000255 1560.000000 -0.000250 0.001729 0.005344 +5190 1 0.000234 1560.000000 0.001964 0.000248 0.009344 +5191 1 0.000216 1560.000000 0.001152 -0.002830 0.008046 +5192 1 0.000227 1560.000000 0.001402 -0.000166 0.004523 +5193 1 0.000208 1560.000000 -0.000934 0.001255 0.003282 +5194 1 0.000261 1560.000000 0.001798 0.000018 0.007115 +5195 1 0.000236 1560.000000 0.000870 0.002889 0.006264 +5196 1 0.000227 1560.000000 -0.002252 -0.001879 0.009523 +5197 1 0.000197 1560.000000 -0.001465 -0.003301 0.004576 +5198 1 0.000230 1560.000000 0.001754 0.000411 0.001261 +5199 1 0.000249 1560.000000 -0.002159 0.002889 0.006309 +5200 1 0.000202 1560.000000 -0.003569 0.000491 0.009544 +5201 1 0.000225 1560.000000 -0.000560 -0.001752 0.005687 +5202 1 0.000237 1560.000000 0.002659 -0.000885 0.006885 +5203 1 0.000210 1560.000000 0.000933 0.000676 0.000345 +5204 1 0.000193 1560.000000 -0.000996 0.001071 0.001066 +5205 1 0.000224 1560.000000 -0.001504 -0.000421 0.002087 +5206 1 0.000207 1560.000000 -0.000033 -0.000664 0.004893 +5207 1 0.000269 1560.000000 0.001313 -0.002520 0.005818 +5208 1 0.000239 1560.000000 -0.002698 -0.000301 0.004785 +5209 1 0.000225 1560.000000 0.001416 -0.003271 0.007079 +5210 1 0.000267 1560.000000 0.000447 -0.003609 0.005362 +5211 1 0.000206 1560.000000 0.002441 -0.002694 0.002127 +5212 1 0.000205 1560.000000 -0.001055 0.002881 0.002676 +5213 1 0.000213 1560.000000 -0.000794 -0.003526 0.002119 +5214 1 0.000208 1560.000000 -0.000416 0.003548 0.000890 +5215 1 0.000280 1560.000000 0.001993 -0.002854 0.007954 +5216 1 0.000198 1560.000000 0.000507 -0.003119 0.002752 +5217 1 0.000210 1560.000000 -0.001800 0.002527 0.003004 +5218 1 0.000215 1560.000000 -0.000261 0.002543 0.001266 +5219 1 0.000271 1560.000000 -0.001810 -0.002156 0.006175 +5220 1 0.000234 1560.000000 0.001029 0.001767 0.002912 +5221 1 0.000193 1560.000000 0.000943 0.001256 0.000813 +5222 1 0.000235 1560.000000 0.003146 0.001315 0.003129 +5223 1 0.000223 1560.000000 -0.000986 0.000714 0.004372 +5224 1 0.000205 1560.000000 -0.001526 0.000659 0.008582 +5225 1 0.000201 1560.000000 -0.001100 -0.003451 0.002197 +5226 1 0.000207 1560.000000 -0.000206 0.000762 0.009760 +5227 1 0.000287 1560.000000 0.000922 0.002234 0.003603 +5228 1 0.000209 1560.000000 -0.000373 -0.002946 0.004199 +5229 1 0.000220 1560.000000 0.000665 -0.000424 0.009159 +5230 1 0.000219 1560.000000 0.001104 -0.000548 0.001572 +5231 1 0.000196 1560.000000 -0.001147 -0.001822 0.003349 +5232 1 0.000201 1560.000000 -0.002754 -0.000615 0.009118 +5233 1 0.000257 1560.000000 -0.002207 -0.001461 0.009810 +5234 1 0.000204 1560.000000 -0.002079 -0.001038 0.007928 +5235 1 0.000253 1560.000000 -0.002682 0.000492 0.003232 +5236 1 0.000194 1560.000000 -0.002300 0.002051 0.008110 +5237 1 0.000220 1560.000000 0.001014 0.001412 0.001043 +5238 1 0.000194 1560.000000 0.002971 -0.001488 0.001410 +5239 1 0.000193 1560.000000 0.000351 -0.001029 0.003610 +5240 1 0.000274 1560.000000 0.001828 0.002927 0.008964 +5241 1 0.000210 1560.000000 0.001683 -0.003417 0.006260 +5242 1 0.000223 1560.000000 0.000366 -0.000481 0.009451 +5243 1 0.000239 1560.000000 -0.002306 0.000052 0.002189 +5244 1 0.000201 1560.000000 0.002575 0.001873 0.007325 +5245 1 0.000203 1560.000000 0.001333 0.003276 0.001201 +5246 1 0.000273 1560.000000 -0.000651 0.003246 0.009544 +5247 1 0.000210 1560.000000 -0.001318 0.002410 0.009633 +5248 1 0.000270 1560.000000 -0.003239 0.001476 0.007378 +5249 1 0.000249 1560.000000 0.002798 0.002496 0.001423 +5250 1 0.000264 1560.000000 -0.003188 0.001121 0.008642 +5251 1 0.000221 1560.000000 0.001019 0.001523 0.002159 +5252 1 0.000225 1560.000000 0.000439 -0.001387 0.007029 +5253 1 0.000247 1560.000000 -0.001797 -0.002662 0.001604 +5254 1 0.000209 1560.000000 0.001883 -0.000283 0.007260 +5255 1 0.000196 1560.000000 -0.001193 0.000042 0.003282 +5256 1 0.000202 1560.000000 -0.002435 -0.001058 0.009372 +5257 1 0.000206 1560.000000 -0.000865 -0.000410 0.004041 +5258 1 0.000261 1560.000000 0.002896 -0.000886 0.002101 +5259 1 0.000193 1560.000000 0.000406 -0.000903 0.004417 +5260 1 0.000249 1560.000000 -0.000916 -0.002341 0.007179 +5261 1 0.000207 1560.000000 0.000859 0.001037 0.009377 +5262 1 0.000193 1560.000000 -0.000191 -0.000770 0.000223 +5263 1 0.000220 1560.000000 0.001250 -0.002268 0.005149 +5264 1 0.000218 1560.000000 -0.002607 0.000294 0.001736 +5265 1 0.000195 1560.000000 0.000965 0.001083 0.008572 +5266 1 0.000284 1560.000000 0.001753 0.000723 0.003796 +5267 1 0.000221 1560.000000 0.000290 -0.003312 0.009477 +5268 1 0.000267 1560.000000 -0.000015 0.003209 0.006178 +5269 1 0.000237 1560.000000 0.001873 0.001836 0.006666 +5270 1 0.000238 1560.000000 0.003575 0.001136 0.004416 +5271 1 0.000214 1560.000000 -0.001825 -0.000036 0.000235 +5272 1 0.000214 1560.000000 -0.000416 0.003625 0.002494 +5273 1 0.000196 1560.000000 -0.003283 0.001583 0.008181 +5274 1 0.000259 1560.000000 0.002717 -0.000048 0.007311 +5275 1 0.000249 1560.000000 0.003231 0.000576 0.004479 +5276 1 0.000270 1560.000000 0.003468 0.000494 0.006383 +5277 1 0.000245 1560.000000 0.001662 -0.000000 0.009819 +5278 1 0.000211 1560.000000 0.000547 0.001115 0.005925 +5279 1 0.000197 1560.000000 0.000085 -0.000086 0.006398 +5280 1 0.000270 1560.000000 -0.002059 -0.003247 0.002517 +5281 1 0.000247 1560.000000 0.000743 -0.001371 0.006917 +5282 1 0.000204 1560.000000 -0.000755 0.000416 0.000695 +5283 1 0.000196 1560.000000 -0.000991 -0.000920 0.008124 +5284 1 0.000195 1560.000000 -0.002936 0.000001 0.001791 +5285 1 0.000273 1560.000000 0.001286 0.000753 0.001528 +5286 1 0.000214 1560.000000 0.000749 -0.001560 0.000749 +5287 1 0.000234 1560.000000 0.002659 -0.001747 0.002299 +5288 1 0.000194 1560.000000 -0.001723 -0.000369 0.004064 +5289 1 0.000273 1560.000000 -0.000499 -0.003405 0.007583 +5290 1 0.000222 1560.000000 0.001827 0.000347 0.001472 +5291 1 0.000205 1560.000000 -0.002508 0.000049 0.006111 +5292 1 0.000215 1560.000000 0.002405 -0.002302 0.007959 +5293 1 0.000218 1560.000000 -0.001305 0.001707 0.003741 +5294 1 0.000254 1560.000000 0.003259 0.000550 0.003656 +5295 1 0.000238 1560.000000 -0.001383 0.002040 0.000767 +5296 1 0.000284 1560.000000 0.001209 -0.000039 0.003971 +5297 1 0.000286 1560.000000 0.001177 0.001292 0.003657 +5298 1 0.000194 1560.000000 -0.000281 -0.000227 0.000117 +5299 1 0.000202 1560.000000 0.000845 -0.002640 0.003588 +5300 1 0.000198 1560.000000 0.003639 0.000183 0.003378 +5301 1 0.000193 1560.000000 -0.003585 0.000242 0.001431 +5302 1 0.000264 1560.000000 -0.000671 -0.002991 0.004822 +5303 1 0.000215 1560.000000 0.001207 0.001596 0.009222 +5304 1 0.000283 1560.000000 0.000320 -0.000970 0.009136 +5305 1 0.000267 1560.000000 0.001876 0.000725 0.007069 +5306 1 0.000195 1560.000000 -0.001609 -0.003278 0.008389 +5307 1 0.000226 1560.000000 0.003534 -0.001396 0.003325 +5308 1 0.000194 1560.000000 -0.001110 0.001951 0.008423 +5309 1 0.000232 1560.000000 -0.001171 0.003208 0.001392 +5310 1 0.000256 1560.000000 0.000424 -0.003814 0.007364 +5311 1 0.000197 1560.000000 0.000624 0.003118 0.008635 +5312 1 0.000236 1560.000000 0.002694 0.001519 0.006167 +5313 1 0.000255 1560.000000 0.000820 -0.002054 0.009777 +5314 1 0.000218 1560.000000 0.000122 0.003814 0.003999 +5315 1 0.000251 1560.000000 0.002450 -0.001727 0.004889 +5316 1 0.000283 1560.000000 0.000461 -0.002266 0.001123 +5317 1 0.000208 1560.000000 0.002339 0.002298 0.001199 +5318 1 0.000232 1560.000000 0.001206 -0.003420 0.005668 +5319 1 0.000198 1560.000000 0.001421 0.001933 0.002044 +5320 1 0.000204 1560.000000 -0.001026 0.001083 0.000501 +5321 1 0.000196 1560.000000 -0.002780 0.002447 0.008222 +5322 1 0.000252 1560.000000 -0.003025 0.000925 0.009003 +5323 1 0.000243 1560.000000 0.001584 -0.002780 0.000932 +5324 1 0.000225 1560.000000 -0.002583 -0.000577 0.002562 +5325 1 0.000234 1560.000000 0.000880 -0.002555 0.003311 +5326 1 0.000275 1560.000000 0.000438 -0.000985 0.007041 +5327 1 0.000196 1560.000000 -0.001172 -0.000964 0.004116 +5328 1 0.000257 1560.000000 -0.002087 0.002858 0.005814 +5329 1 0.000282 1560.000000 -0.003505 -0.001350 0.009146 +5330 1 0.000284 1560.000000 -0.002132 -0.000337 0.009799 +5331 1 0.000206 1560.000000 -0.002122 0.000752 0.001570 +5332 1 0.000193 1560.000000 -0.000677 -0.002892 0.006722 +5333 1 0.000260 1560.000000 0.000071 0.000965 0.003075 +5334 1 0.000286 1560.000000 -0.000651 -0.001517 0.002347 +5335 1 0.000285 1560.000000 0.003193 0.001855 0.006450 +5336 1 0.000207 1560.000000 0.003021 -0.001420 0.002198 +5337 1 0.000205 1560.000000 -0.000351 -0.002501 0.005509 +5338 1 0.000267 1560.000000 0.001849 -0.002722 0.003326 +5339 1 0.000232 1560.000000 -0.000412 0.000641 0.004609 +5340 1 0.000226 1560.000000 -0.002530 -0.001056 0.005638 +5341 1 0.000266 1560.000000 0.001361 0.002040 0.005373 +5342 1 0.000260 1560.000000 0.001637 -0.001749 0.005499 +5343 1 0.000224 1560.000000 0.002857 0.000501 0.006414 +5344 1 0.000254 1560.000000 0.000138 0.000523 0.004169 +5345 1 0.000222 1560.000000 -0.000060 -0.001071 0.005066 +5346 1 0.000206 1560.000000 -0.000122 -0.003525 0.003265 +5347 1 0.000273 1560.000000 0.000881 0.003324 0.000572 +5348 1 0.000264 1560.000000 -0.001444 0.002971 0.005549 +5349 1 0.000276 1560.000000 -0.003459 -0.001657 0.001725 +5350 1 0.000193 1560.000000 0.003090 0.001164 0.001316 +5351 1 0.000255 1560.000000 -0.000261 0.001140 0.007494 +5352 1 0.000257 1560.000000 -0.001874 -0.002205 0.007266 +5353 1 0.000240 1560.000000 -0.001311 0.000666 0.009267 +5354 1 0.000201 1560.000000 0.001588 -0.000116 0.001082 +5355 1 0.000196 1560.000000 -0.000280 -0.002570 0.007191 +5356 1 0.000235 1560.000000 0.002159 0.000678 0.004212 +5357 1 0.000207 1560.000000 0.002637 -0.000150 0.006356 +5358 1 0.000193 1560.000000 -0.002341 0.000729 0.006378 +5359 1 0.000234 1560.000000 -0.002209 0.000370 0.004008 +5360 1 0.000265 1560.000000 -0.001857 0.000371 0.000658 +5361 1 0.000212 1560.000000 -0.002957 -0.000793 0.004975 +5362 1 0.000280 1560.000000 0.001713 -0.003261 0.004118 +5363 1 0.000216 1560.000000 0.000635 -0.000637 0.007134 +5364 1 0.000207 1560.000000 0.003271 -0.000866 0.005849 +5365 1 0.000196 1560.000000 -0.001543 0.002355 0.004837 +5366 1 0.000226 1560.000000 -0.001767 -0.001034 0.001360 +5367 1 0.000240 1560.000000 -0.000324 -0.000481 0.005582 +5368 1 0.000284 1560.000000 0.000625 -0.001825 0.006434 +5369 1 0.000195 1560.000000 -0.001411 -0.003492 0.001568 +5370 1 0.000214 1560.000000 0.003253 0.001217 0.000505 +5371 1 0.000241 1560.000000 0.000093 -0.003637 0.002448 +5372 1 0.000267 1560.000000 -0.000275 -0.002005 0.002473 +5373 1 0.000272 1560.000000 -0.003809 0.000219 0.004400 +5374 1 0.000199 1560.000000 -0.000873 0.002534 0.000289 +5375 1 0.000213 1560.000000 -0.000479 0.003338 0.003642 +5376 1 0.000202 1560.000000 -0.000141 -0.003366 0.005256 +5377 1 0.000245 1560.000000 0.003004 0.000727 0.000939 +5378 1 0.000263 1560.000000 0.002289 0.003101 0.002636 +5379 1 0.000202 1560.000000 0.002513 0.001273 0.000226 +5380 1 0.000207 1560.000000 0.001555 0.000049 0.001838 +5381 1 0.000238 1560.000000 0.000860 0.003102 0.001217 +5382 1 0.000214 1560.000000 0.000947 -0.001125 0.002167 +5383 1 0.000215 1560.000000 -0.002874 -0.000816 0.001789 +5384 1 0.000224 1560.000000 0.000388 0.003787 0.003817 +5385 1 0.000207 1560.000000 0.000247 0.002812 0.003789 +5386 1 0.000216 1560.000000 0.003209 -0.001436 0.001900 +5387 1 0.000197 1560.000000 0.000706 -0.000894 0.001453 +5388 1 0.000194 1560.000000 -0.000999 0.001507 0.008190 +5389 1 0.000277 1560.000000 -0.000203 0.002501 0.005694 +5390 1 0.000193 1560.000000 -0.002215 0.002291 0.009784 +5391 1 0.000252 1560.000000 0.001209 -0.002368 0.002252 +5392 1 0.000227 1560.000000 0.000827 0.001228 0.004540 +5393 1 0.000232 1560.000000 -0.002325 -0.000140 0.004441 +5394 1 0.000205 1560.000000 0.003348 -0.000465 0.000377 +5395 1 0.000258 1560.000000 -0.000803 -0.000413 0.007543 +5396 1 0.000253 1560.000000 -0.000600 0.001205 0.006910 +5397 1 0.000216 1560.000000 0.000018 0.001221 0.003704 +5398 1 0.000226 1560.000000 -0.002172 0.000488 0.008660 +5399 1 0.000246 1560.000000 0.002275 0.000403 0.008842 +5400 1 0.000199 1560.000000 0.002325 -0.002247 0.005704 +5401 1 0.000274 1560.000000 0.000981 -0.001821 0.009766 +5402 1 0.000209 1560.000000 -0.000280 -0.002857 0.005194 +5403 1 0.000240 1560.000000 -0.000324 0.000246 0.005855 +5404 1 0.000228 1560.000000 0.000217 0.002818 0.005896 +5405 1 0.000198 1560.000000 0.003364 -0.000625 0.003109 +5406 1 0.000208 1560.000000 0.000091 -0.003020 0.003969 +5407 1 0.000222 1560.000000 -0.000978 -0.000606 0.005012 +5408 1 0.000246 1560.000000 0.002376 -0.001965 0.005248 +5409 1 0.000251 1560.000000 -0.000679 -0.000590 0.001380 +5410 1 0.000201 1560.000000 0.002328 0.001060 0.009735 +5411 1 0.000209 1560.000000 -0.000465 -0.000336 0.009382 +5412 1 0.000276 1560.000000 -0.001587 0.003319 0.000719 +5413 1 0.000275 1560.000000 -0.001563 0.002514 0.004343 +5414 1 0.000228 1560.000000 0.000900 0.000404 0.009605 +5415 1 0.000215 1560.000000 0.002440 -0.000377 0.005534 +5416 1 0.000203 1560.000000 -0.003355 -0.000757 0.002735 +5417 1 0.000258 1560.000000 -0.002742 -0.000447 0.006884 +5418 1 0.000205 1560.000000 -0.002069 0.001623 0.005020 +5419 1 0.000201 1560.000000 -0.002436 -0.001137 0.009617 +5420 1 0.000201 1560.000000 -0.001415 -0.001958 0.000860 +5421 1 0.000218 1560.000000 0.003447 0.000362 0.008566 +5422 1 0.000225 1560.000000 -0.000723 -0.001615 0.005986 +5423 1 0.000257 1560.000000 -0.000083 -0.001626 0.005733 +5424 1 0.000216 1560.000000 0.002010 0.000187 0.005917 +5425 1 0.000203 1560.000000 -0.000445 0.000373 0.003564 +5426 1 0.000263 1560.000000 -0.002195 0.002154 0.001792 +5427 1 0.000266 1560.000000 -0.001712 0.001341 0.003038 +5428 1 0.000198 1560.000000 -0.000309 0.003660 0.009359 +5429 1 0.000258 1560.000000 -0.003357 -0.000355 0.008236 +5430 1 0.000197 1560.000000 0.000564 -0.000691 0.008013 +5431 1 0.000209 1560.000000 0.001156 -0.000270 0.007168 +5432 1 0.000246 1560.000000 -0.003161 0.001563 0.001554 +5433 1 0.000250 1560.000000 -0.001318 -0.003528 0.005369 +5434 1 0.000219 1560.000000 0.001296 0.000473 0.002889 +5435 1 0.000212 1560.000000 0.002258 0.001692 0.008711 +5436 1 0.000247 1560.000000 -0.001102 -0.002383 0.007004 +5437 1 0.000231 1560.000000 -0.001663 -0.002965 0.009622 +5438 1 0.000228 1560.000000 0.002393 -0.000056 0.006390 +5439 1 0.000221 1560.000000 0.000009 -0.001679 0.005225 +5440 1 0.000212 1560.000000 -0.003152 0.000378 0.000761 +5441 1 0.000216 1560.000000 0.003420 0.001214 0.005971 +5442 1 0.000276 1560.000000 0.002121 0.003134 0.001860 +5443 1 0.000227 1560.000000 -0.002112 0.000798 0.005816 +5444 1 0.000217 1560.000000 -0.001815 0.001637 0.000924 +5445 1 0.000263 1560.000000 -0.001289 -0.002762 0.002232 +5446 1 0.000216 1560.000000 0.000994 -0.002166 0.007827 +5447 1 0.000272 1560.000000 -0.001229 -0.001655 0.002646 +5448 1 0.000258 1560.000000 -0.001559 -0.001989 0.007509 +5449 1 0.000236 1560.000000 0.003199 -0.001726 0.006206 +5450 1 0.000270 1560.000000 -0.000064 0.003302 0.005187 +5451 1 0.000218 1560.000000 -0.000975 0.003034 0.000944 +5452 1 0.000208 1560.000000 -0.000475 0.002068 0.009682 +5453 1 0.000277 1560.000000 0.000024 0.002427 0.004551 +5454 1 0.000214 1560.000000 -0.002353 -0.002940 0.008656 +5455 1 0.000229 1560.000000 0.002018 0.002850 0.005542 +5456 1 0.000244 1560.000000 0.001624 0.001679 0.008456 +5457 1 0.000220 1560.000000 0.001327 -0.001281 0.006974 +5458 1 0.000243 1560.000000 0.001624 0.000165 0.003328 +5459 1 0.000266 1560.000000 -0.001446 0.000132 0.009077 +5460 1 0.000234 1560.000000 0.001797 0.001056 0.000760 +5461 1 0.000219 1560.000000 0.001491 0.001718 0.002285 +5462 1 0.000247 1560.000000 0.003421 -0.000033 0.008150 +5463 1 0.000223 1560.000000 0.000990 -0.000230 0.007753 +5464 1 0.000195 1560.000000 -0.002361 -0.000327 0.003381 +5465 1 0.000211 1560.000000 -0.002015 -0.000363 0.006676 +5466 1 0.000199 1560.000000 0.001055 0.001730 0.008831 +5467 1 0.000239 1560.000000 0.002345 0.000389 0.007217 +5468 1 0.000214 1560.000000 -0.002060 -0.000350 0.002743 +5469 1 0.000280 1560.000000 -0.001204 -0.000826 0.000595 +5470 1 0.000234 1560.000000 0.000406 -0.000001 0.000429 +5471 1 0.000261 1560.000000 -0.000986 0.003709 0.009391 +5472 1 0.000204 1560.000000 0.001065 -0.000218 0.008602 +5473 1 0.000195 1560.000000 -0.001488 -0.002097 0.006217 +5474 1 0.000262 1560.000000 -0.002326 -0.000367 0.009234 +5475 1 0.000230 1560.000000 0.002794 0.002304 0.006433 +5476 1 0.000256 1560.000000 0.001259 0.001760 0.007380 +5477 1 0.000210 1560.000000 -0.002407 0.000518 0.008998 +5478 1 0.000263 1560.000000 -0.000737 0.000295 0.001299 +5479 1 0.000256 1560.000000 0.000087 -0.000859 0.002391 +5480 1 0.000263 1560.000000 0.001081 0.002331 0.001915 +5481 1 0.000219 1560.000000 0.001620 -0.002514 0.005943 +5482 1 0.000194 1560.000000 -0.001206 -0.001575 0.001705 +5483 1 0.000207 1560.000000 0.001124 -0.000605 0.008350 +5484 1 0.000200 1560.000000 0.001082 0.000129 0.000508 +5485 1 0.000225 1560.000000 -0.000013 -0.001598 0.007142 +5486 1 0.000218 1560.000000 -0.002917 -0.000315 0.000195 +5487 1 0.000223 1560.000000 -0.000680 0.000262 0.009555 +5488 1 0.000209 1560.000000 0.000237 -0.001608 0.004654 +5489 1 0.000210 1560.000000 -0.001893 -0.002577 0.009815 +5490 1 0.000205 1560.000000 0.000969 -0.002912 0.006194 +5491 1 0.000275 1560.000000 0.000298 -0.000089 0.000652 +5492 1 0.000218 1560.000000 0.001542 0.001172 0.006041 +5493 1 0.000228 1560.000000 0.001331 -0.001209 0.005053 +5494 1 0.000240 1560.000000 0.001380 -0.000189 0.003775 +5495 1 0.000286 1560.000000 0.001791 0.001300 0.004841 +5496 1 0.000210 1560.000000 0.000492 0.003706 0.003387 +5497 1 0.000219 1560.000000 0.003404 0.001786 0.000652 +5498 1 0.000215 1560.000000 0.003784 -0.000701 0.007566 +5499 1 0.000195 1560.000000 0.002182 0.001574 0.006534 +5500 1 0.000282 1560.000000 0.003636 0.000778 0.006067 +5501 1 0.000259 1560.000000 -0.002671 -0.002056 0.004588 +5502 1 0.000205 1560.000000 -0.001084 0.002111 0.001122 +5503 1 0.000270 1560.000000 0.001755 -0.002104 0.007940 +5504 1 0.000256 1560.000000 -0.001754 0.003312 0.009527 +5505 1 0.000246 1560.000000 -0.000806 -0.001366 0.009108 +5506 1 0.000200 1560.000000 -0.003332 -0.001641 0.002485 +5507 1 0.000264 1560.000000 0.003072 0.000759 0.003323 +5508 1 0.000217 1560.000000 -0.000836 -0.001816 0.004634 +5509 1 0.000267 1560.000000 -0.000601 0.003701 0.003605 +5510 1 0.000209 1560.000000 -0.002865 -0.000841 0.009370 +5511 1 0.000246 1560.000000 0.001697 -0.002050 0.009073 +5512 1 0.000268 1560.000000 -0.000710 0.002733 0.007980 +5513 1 0.000211 1560.000000 -0.001716 -0.001246 0.006401 +5514 1 0.000213 1560.000000 -0.000932 -0.001310 0.002059 +5515 1 0.000234 1560.000000 0.001095 -0.003600 0.003932 +5516 1 0.000195 1560.000000 0.002121 0.000654 0.005698 +5517 1 0.000224 1560.000000 0.000400 -0.000269 0.002296 +5518 1 0.000241 1560.000000 -0.003361 0.000349 0.008885 +5519 1 0.000277 1560.000000 0.002447 0.002896 0.001309 +5520 1 0.000203 1560.000000 -0.002655 -0.000484 0.002005 +5521 1 0.000197 1560.000000 -0.000882 0.000775 0.004864 +5522 1 0.000223 1560.000000 -0.002115 0.000959 0.003176 +5523 1 0.000211 1560.000000 0.000392 0.002708 0.007117 +5524 1 0.000258 1560.000000 0.000736 -0.002547 0.002566 +5525 1 0.000250 1560.000000 0.003493 -0.001210 0.005228 +5526 1 0.000218 1560.000000 0.000188 -0.000087 0.008886 +5527 1 0.000210 1560.000000 0.001435 0.002433 0.002972 +5528 1 0.000253 1560.000000 0.002229 -0.000628 0.005222 +5529 1 0.000202 1560.000000 0.000507 0.001795 0.002524 +5530 1 0.000254 1560.000000 0.003101 0.002273 0.009463 +5531 1 0.000196 1560.000000 -0.000647 0.000847 0.000810 +5532 1 0.000205 1560.000000 0.002157 -0.000832 0.006170 +5533 1 0.000207 1560.000000 0.000834 -0.000418 0.003151 +5534 1 0.000193 1560.000000 0.003167 0.000239 0.001439 +5535 1 0.000192 1560.000000 0.003182 -0.000850 0.001875 +5536 1 0.000223 1560.000000 -0.002098 -0.001657 0.002894 +5537 1 0.000224 1560.000000 -0.003095 0.000750 0.004875 +5538 1 0.000249 1560.000000 0.002438 -0.000106 0.005871 +5539 1 0.000223 1560.000000 0.001289 -0.002389 0.000175 +5540 1 0.000254 1560.000000 -0.003725 0.000340 0.004849 +5541 1 0.000235 1560.000000 0.002424 -0.001268 0.007727 +5542 1 0.000210 1560.000000 0.001862 -0.000292 0.005373 +5543 1 0.000243 1560.000000 0.002354 0.002527 0.002735 +5544 1 0.000215 1560.000000 0.000777 -0.001925 0.007944 +5545 1 0.000247 1560.000000 0.002078 -0.002180 0.009727 +5546 1 0.000248 1560.000000 -0.002565 -0.000262 0.002399 +5547 1 0.000201 1560.000000 -0.000234 0.001074 0.002826 +5548 1 0.000235 1560.000000 -0.001626 -0.002011 0.008353 +5549 1 0.000242 1560.000000 0.001401 0.002698 0.004930 +5550 1 0.000207 1560.000000 -0.000331 -0.002634 0.009782 +5551 1 0.000202 1560.000000 0.001292 -0.000990 0.005196 +5552 1 0.000272 1560.000000 -0.001177 0.000371 0.005971 +5553 1 0.000225 1560.000000 0.002124 -0.001627 0.009571 +5554 1 0.000215 1560.000000 -0.001248 0.001113 0.002649 +5555 1 0.000199 1560.000000 0.003530 -0.001255 0.004531 +5556 1 0.000243 1560.000000 0.003249 0.000569 0.001331 +5557 1 0.000255 1560.000000 -0.001296 0.002788 0.006918 +5558 1 0.000222 1560.000000 -0.001240 -0.000184 0.002900 +5559 1 0.000205 1560.000000 0.003205 0.000257 0.003525 +5560 1 0.000279 1560.000000 -0.001676 -0.000873 0.000516 +5561 1 0.000284 1560.000000 -0.000740 -0.000922 0.000694 +5562 1 0.000248 1560.000000 0.000125 -0.002661 0.003141 +5563 1 0.000197 1560.000000 0.000577 0.001343 0.004117 +5564 1 0.000262 1560.000000 0.000109 0.003418 0.007542 +5565 1 0.000227 1560.000000 -0.003546 0.001087 0.008193 +5566 1 0.000224 1560.000000 0.001375 0.001768 0.005115 +5567 1 0.000220 1560.000000 0.001305 0.000373 0.008982 +5568 1 0.000244 1560.000000 0.001458 0.002835 0.001401 +5569 1 0.000209 1560.000000 -0.000446 -0.000139 0.004612 +5570 1 0.000212 1560.000000 0.001964 0.002164 0.000973 +5571 1 0.000209 1560.000000 -0.000812 -0.000207 0.008660 +5572 1 0.000238 1560.000000 -0.000823 -0.003239 0.004753 +5573 1 0.000199 1560.000000 -0.000116 0.001218 0.003328 +5574 1 0.000255 1560.000000 0.000488 0.000215 0.004123 +5575 1 0.000214 1560.000000 0.000286 0.001098 0.003730 +5576 1 0.000269 1560.000000 0.003284 0.000301 0.006214 +5577 1 0.000197 1560.000000 -0.000798 -0.003286 0.004520 +5578 1 0.000200 1560.000000 0.002967 -0.000413 0.007427 +5579 1 0.000237 1560.000000 0.002557 -0.001946 0.005703 +5580 1 0.000283 1560.000000 0.001484 -0.001499 0.005786 +5581 1 0.000262 1560.000000 0.002928 0.000766 0.008491 +5582 1 0.000227 1560.000000 0.001421 0.001719 0.008307 +5583 1 0.000224 1560.000000 -0.002467 -0.000604 0.004054 +5584 1 0.000265 1560.000000 0.002473 -0.002908 0.004586 +5585 1 0.000285 1560.000000 0.002316 0.001077 0.004493 +5586 1 0.000208 1560.000000 0.001564 0.002955 0.006033 +5587 1 0.000229 1560.000000 0.000990 -0.002761 0.000715 +5588 1 0.000242 1560.000000 -0.000526 -0.003313 0.002670 +5589 1 0.000251 1560.000000 -0.001447 0.000319 0.003159 +5590 1 0.000286 1560.000000 -0.001137 0.001315 0.006819 +5591 1 0.000223 1560.000000 -0.001977 0.001646 0.001712 +5592 1 0.000250 1560.000000 0.000589 -0.000119 0.003905 +5593 1 0.000268 1560.000000 -0.002123 -0.002799 0.008843 +5594 1 0.000227 1560.000000 0.000981 -0.000778 0.002187 +5595 1 0.000229 1560.000000 -0.000527 -0.002690 0.008449 +5596 1 0.000196 1560.000000 -0.002113 0.000472 0.005723 +5597 1 0.000248 1560.000000 0.002197 0.001149 0.001300 +5598 1 0.000225 1560.000000 -0.003632 -0.000526 0.007412 +5599 1 0.000239 1560.000000 -0.001983 0.002021 0.008415 +5600 1 0.000193 1560.000000 -0.001334 -0.002794 0.007466 +5601 1 0.000275 1560.000000 -0.001338 0.002079 0.000153 +5602 1 0.000193 1560.000000 -0.000430 0.000123 0.008584 +5603 1 0.000245 1560.000000 0.000298 0.001998 0.001456 +5604 1 0.000235 1560.000000 -0.003044 -0.000614 0.005945 +5605 1 0.000282 1560.000000 0.003076 -0.000625 0.001645 +5606 1 0.000211 1560.000000 0.002183 -0.000747 0.003057 +5607 1 0.000226 1560.000000 -0.000583 -0.001635 0.002567 +5608 1 0.000233 1560.000000 0.000289 0.001192 0.004970 +5609 1 0.000276 1560.000000 -0.001070 0.000513 0.007510 +5610 1 0.000239 1560.000000 0.001280 -0.000440 0.000598 +5611 1 0.000253 1560.000000 -0.001372 0.003427 0.002487 +5612 1 0.000212 1560.000000 -0.002946 -0.001548 0.006434 +5613 1 0.000247 1560.000000 -0.001176 0.003123 0.009080 +5614 1 0.000211 1560.000000 -0.001362 0.001223 0.008063 +5615 1 0.000194 1560.000000 -0.000582 -0.001383 0.001476 +5616 1 0.000259 1560.000000 -0.003410 -0.000338 0.008497 +5617 1 0.000257 1560.000000 -0.001305 0.000440 0.002094 +5618 1 0.000287 1560.000000 -0.001071 0.002240 0.003886 +5619 1 0.000263 1560.000000 -0.000425 -0.003082 0.002589 +5620 1 0.000228 1560.000000 -0.000881 0.001815 0.004813 +5621 1 0.000207 1560.000000 -0.001203 0.002319 0.004119 +5622 1 0.000205 1560.000000 0.000163 -0.002130 0.002478 +5623 1 0.000229 1560.000000 0.000413 0.000366 0.005124 +5624 1 0.000244 1560.000000 -0.000761 -0.002699 0.002734 +5625 1 0.000255 1560.000000 0.002939 -0.002485 0.006870 +5626 1 0.000250 1560.000000 0.000359 -0.000252 0.007737 +5627 1 0.000218 1560.000000 0.003141 -0.001875 0.002466 +5628 1 0.000210 1560.000000 0.000805 -0.000432 0.004187 +5629 1 0.000223 1560.000000 -0.000105 -0.001357 0.001272 +5630 1 0.000242 1560.000000 0.001425 0.000313 0.008227 +5631 1 0.000261 1560.000000 -0.000440 -0.001473 0.005843 +5632 1 0.000193 1560.000000 0.001638 0.000324 0.002187 +5633 1 0.000262 1560.000000 -0.002498 0.000503 0.004672 +5634 1 0.000226 1560.000000 -0.000900 0.001024 0.006395 +5635 1 0.000196 1560.000000 0.000940 0.000562 0.003645 +5636 1 0.000195 1560.000000 -0.001317 0.000057 0.001046 +5637 1 0.000226 1560.000000 0.000628 0.000200 0.005787 +5638 1 0.000195 1560.000000 -0.001808 0.000183 0.001081 +5639 1 0.000284 1560.000000 0.000553 0.001764 0.005066 +5640 1 0.000262 1560.000000 -0.001501 0.000703 0.005541 +5641 1 0.000213 1560.000000 -0.001968 -0.000389 0.008958 +5642 1 0.000285 1560.000000 0.001052 -0.000268 0.003341 +5643 1 0.000224 1560.000000 0.000955 -0.001248 0.001617 +5644 1 0.000195 1560.000000 -0.002679 0.001610 0.001100 +5645 1 0.000276 1560.000000 -0.001777 -0.000283 0.000329 +5646 1 0.000285 1560.000000 0.001638 0.002255 0.007846 +5647 1 0.000224 1560.000000 -0.002545 0.000051 0.001364 +5648 1 0.000192 1560.000000 -0.003000 0.001728 0.003796 +5649 1 0.000284 1560.000000 -0.001015 -0.003375 0.005572 +5650 1 0.000262 1560.000000 0.000749 -0.002752 0.001476 +5651 1 0.000267 1560.000000 -0.000786 -0.002390 0.007832 +5652 1 0.000193 1560.000000 0.001939 0.001636 0.008330 +5653 1 0.000211 1560.000000 0.002003 -0.002991 0.008255 +5654 1 0.000251 1560.000000 0.000183 -0.001935 0.001802 +5655 1 0.000248 1560.000000 -0.001965 0.000318 0.008152 +5656 1 0.000205 1560.000000 -0.000207 -0.001982 0.001807 +5657 1 0.000210 1560.000000 0.001802 0.001062 0.001973 +5658 1 0.000195 1560.000000 -0.000153 0.000182 0.002629 +5659 1 0.000281 1560.000000 0.002520 0.001986 0.008341 +5660 1 0.000274 1560.000000 -0.001329 0.000643 0.006206 +5661 1 0.000224 1560.000000 0.002445 -0.002176 0.002996 +5662 1 0.000266 1560.000000 0.002095 -0.001550 0.008582 +5663 1 0.000204 1560.000000 0.003274 -0.001657 0.002454 +5664 1 0.000273 1560.000000 -0.000532 0.003611 0.007416 +5665 1 0.000213 1560.000000 -0.001127 0.001785 0.007048 +5666 1 0.000230 1560.000000 -0.002114 0.000597 0.006379 +5667 1 0.000216 1560.000000 -0.002157 0.001178 0.008375 +5668 1 0.000209 1560.000000 0.002739 -0.002352 0.002888 +5669 1 0.000260 1560.000000 -0.002523 0.001152 0.002990 +5670 1 0.000229 1560.000000 0.003085 0.000431 0.005029 +5671 1 0.000209 1560.000000 0.001414 -0.001455 0.004706 +5672 1 0.000206 1560.000000 0.000441 0.000482 0.007214 +5673 1 0.000197 1560.000000 -0.002185 -0.000831 0.002784 +5674 1 0.000192 1560.000000 0.000132 -0.003572 0.009441 +5675 1 0.000249 1560.000000 -0.000550 -0.001521 0.003915 +5676 1 0.000264 1560.000000 0.001744 0.001341 0.006463 +5677 1 0.000253 1560.000000 0.001227 0.000390 0.001563 +5678 1 0.000241 1560.000000 0.001082 -0.001689 0.008638 +5679 1 0.000266 1560.000000 -0.001282 -0.000178 0.007443 +5680 1 0.000201 1560.000000 -0.002336 0.002646 0.005661 +5681 1 0.000278 1560.000000 0.001545 0.001911 0.001273 +5682 1 0.000199 1560.000000 0.001228 0.001196 0.007675 +5683 1 0.000271 1560.000000 -0.000499 -0.000518 0.007955 +5684 1 0.000241 1560.000000 0.003333 0.001459 0.009630 +5685 1 0.000235 1560.000000 0.000251 0.003484 0.006781 +5686 1 0.000218 1560.000000 -0.000352 0.001219 0.009403 +5687 1 0.000279 1560.000000 0.003800 0.000376 0.003581 +5688 1 0.000198 1560.000000 -0.001395 -0.003285 0.003057 +5689 1 0.000249 1560.000000 0.002173 -0.002240 0.000771 +5690 1 0.000216 1560.000000 0.001006 -0.001313 0.006825 +5691 1 0.000238 1560.000000 -0.002039 0.001848 0.006968 +5692 1 0.000249 1560.000000 -0.001615 0.002280 0.007895 +5693 1 0.000247 1560.000000 0.002512 -0.001116 0.002338 +5694 1 0.000235 1560.000000 0.003257 0.000027 0.001518 +5695 1 0.000227 1560.000000 0.000541 -0.001221 0.004619 +5696 1 0.000287 1560.000000 0.002537 -0.000363 0.009194 +5697 1 0.000216 1560.000000 -0.002836 -0.002494 0.005203 +5698 1 0.000288 1560.000000 0.002672 -0.001442 0.000419 +5699 1 0.000203 1560.000000 0.001815 -0.001001 0.001674 +5700 1 0.000258 1560.000000 0.000759 0.003442 0.007259 +5701 1 0.000202 1560.000000 0.002528 -0.002896 0.004830 +5702 1 0.000207 1560.000000 -0.001288 -0.000918 0.004682 +5703 1 0.000213 1560.000000 0.000205 -0.003811 0.001734 +5704 1 0.000221 1560.000000 0.000484 0.000694 0.007248 +5705 1 0.000269 1560.000000 0.001351 -0.002187 0.007645 +5706 1 0.000254 1560.000000 0.000961 0.003511 0.005937 +5707 1 0.000197 1560.000000 -0.001507 0.002761 0.005056 +5708 1 0.000222 1560.000000 -0.002226 0.003046 0.003510 +5709 1 0.000210 1560.000000 -0.000621 -0.000008 0.003647 +5710 1 0.000216 1560.000000 -0.000557 -0.000061 0.009492 +5711 1 0.000210 1560.000000 0.001224 0.002868 0.001088 +5712 1 0.000230 1560.000000 0.000805 0.000577 0.001914 +5713 1 0.000225 1560.000000 -0.001343 0.001358 0.002539 +5714 1 0.000285 1560.000000 0.000260 0.003528 0.005940 +5715 1 0.000283 1560.000000 -0.001404 -0.003304 0.008578 +5716 1 0.000227 1560.000000 0.000051 -0.003335 0.006142 +5717 1 0.000221 1560.000000 -0.002401 0.001585 0.008110 +5718 1 0.000255 1560.000000 0.001570 0.002447 0.007592 +5719 1 0.000208 1560.000000 0.001657 -0.001703 0.003494 +5720 1 0.000247 1560.000000 0.000873 0.000000 0.001351 +5721 1 0.000255 1560.000000 -0.001555 0.002973 0.000829 +5722 1 0.000237 1560.000000 -0.001351 -0.002461 0.006746 +5723 1 0.000266 1560.000000 -0.002618 0.001896 0.002895 +5724 1 0.000231 1560.000000 -0.002803 -0.001306 0.006948 +5725 1 0.000230 1560.000000 0.000768 0.003630 0.008287 +5726 1 0.000200 1560.000000 0.000866 -0.002959 0.008745 +5727 1 0.000261 1560.000000 0.000616 0.003380 0.009606 +5728 1 0.000231 1560.000000 0.001767 -0.001011 0.001337 +5729 1 0.000246 1560.000000 -0.002579 -0.001387 0.002141 +5730 1 0.000235 1560.000000 0.002771 0.000811 0.008216 +5731 1 0.000220 1560.000000 -0.000566 0.001713 0.002246 +5732 1 0.000216 1560.000000 0.002964 -0.000800 0.005598 +5733 1 0.000198 1560.000000 -0.001977 0.001162 0.003479 +5734 1 0.000279 1560.000000 0.000838 0.002572 0.005958 +5735 1 0.000280 1560.000000 0.000256 0.003710 0.008714 +5736 1 0.000265 1560.000000 -0.000833 0.003279 0.003322 +5737 1 0.000284 1560.000000 0.000700 0.003125 0.008213 +5738 1 0.000205 1560.000000 0.001286 0.001387 0.005838 +5739 1 0.000193 1560.000000 0.001653 -0.000780 0.000891 +5740 1 0.000260 1560.000000 -0.002800 -0.000489 0.004095 +5741 1 0.000217 1560.000000 -0.003433 -0.001091 0.000505 +5742 1 0.000253 1560.000000 0.000146 0.000926 0.005379 +5743 1 0.000210 1560.000000 -0.001818 0.002096 0.005591 +5744 1 0.000279 1560.000000 -0.000236 0.002268 0.007628 +5745 1 0.000209 1560.000000 -0.000927 -0.001485 0.000348 +5746 1 0.000260 1560.000000 -0.001550 -0.002656 0.004747 +5747 1 0.000254 1560.000000 -0.001370 -0.000853 0.007679 +5748 1 0.000233 1560.000000 -0.001338 0.001642 0.003517 +5749 1 0.000254 1560.000000 -0.000796 0.001186 0.002367 +5750 1 0.000262 1560.000000 -0.003280 -0.001737 0.008266 +5751 1 0.000225 1560.000000 -0.000682 -0.001164 0.006970 +5752 1 0.000196 1560.000000 0.001476 0.001058 0.003427 +5753 1 0.000272 1560.000000 -0.000082 0.001389 0.004958 +5754 1 0.000222 1560.000000 -0.001851 0.000321 0.005625 +5755 1 0.000240 1560.000000 -0.000260 -0.003382 0.006077 +5756 1 0.000279 1560.000000 0.003475 0.001594 0.000794 +5757 1 0.000221 1560.000000 -0.002991 0.001553 0.002719 +5758 1 0.000227 1560.000000 -0.001854 -0.000368 0.007504 +5759 1 0.000200 1560.000000 -0.001777 -0.003034 0.001171 +5760 1 0.000281 1560.000000 0.001302 0.003525 0.000653 +5761 1 0.000216 1560.000000 0.001199 -0.001359 0.007156 +5762 1 0.000262 1560.000000 0.002790 -0.001286 0.007235 +5763 1 0.000262 1560.000000 -0.000710 0.000996 0.006125 +5764 1 0.000238 1560.000000 0.000376 0.000457 0.002408 +5765 1 0.000263 1560.000000 0.000781 0.000782 0.008075 +5766 1 0.000258 1560.000000 0.002025 0.002554 0.000891 +5767 1 0.000212 1560.000000 0.003715 0.000650 0.005413 +5768 1 0.000202 1560.000000 0.002271 -0.003088 0.008169 +5769 1 0.000218 1560.000000 -0.002022 -0.003172 0.009369 +5770 1 0.000200 1560.000000 -0.001531 0.001239 0.008217 +5771 1 0.000250 1560.000000 0.001387 0.000139 0.004185 +5772 1 0.000197 1560.000000 -0.002930 -0.001586 0.000417 +5773 1 0.000241 1560.000000 0.001874 -0.000189 0.001825 +5774 1 0.000210 1560.000000 0.000137 0.000499 0.008537 +5775 1 0.000250 1560.000000 0.000219 -0.000575 0.006733 +5776 1 0.000272 1560.000000 -0.000964 0.002557 0.004924 +5777 1 0.000230 1560.000000 0.002229 0.001596 0.005373 +5778 1 0.000203 1560.000000 0.002047 0.001854 0.007942 +5779 1 0.000222 1560.000000 -0.001564 0.001481 0.006378 +5780 1 0.000195 1560.000000 0.002564 -0.002536 0.005374 +5781 1 0.000223 1560.000000 0.000454 0.000962 0.004044 +5782 1 0.000288 1560.000000 -0.002744 -0.000748 0.000551 +5783 1 0.000219 1560.000000 0.001184 -0.002435 0.009362 +5784 1 0.000232 1560.000000 0.002464 -0.002068 0.005945 +5785 1 0.000226 1560.000000 0.000820 0.000172 0.006986 +5786 1 0.000214 1560.000000 -0.000450 0.003286 0.005549 +5787 1 0.000202 1560.000000 -0.000217 0.000448 0.002246 +5788 1 0.000206 1560.000000 0.001845 0.000267 0.000819 +5789 1 0.000198 1560.000000 -0.002634 -0.001209 0.005405 +5790 1 0.000203 1560.000000 0.000761 0.001957 0.003606 +5791 1 0.000213 1560.000000 -0.002186 0.002731 0.002885 +5792 1 0.000288 1560.000000 -0.000583 -0.002630 0.004733 +5793 1 0.000214 1560.000000 0.002492 -0.002050 0.008653 +5794 1 0.000194 1560.000000 0.002843 -0.001071 0.007621 +5795 1 0.000278 1560.000000 -0.002984 -0.000393 0.007094 +5796 1 0.000223 1560.000000 0.002554 -0.001430 0.003289 +5797 1 0.000233 1560.000000 -0.002836 -0.001248 0.000772 +5798 1 0.000254 1560.000000 0.002510 0.002805 0.006405 +5799 1 0.000193 1560.000000 0.002895 -0.001234 0.001918 +5800 1 0.000253 1560.000000 -0.001635 0.000555 0.009497 +5801 1 0.000208 1560.000000 0.003116 -0.000661 0.002363 +5802 1 0.000221 1560.000000 -0.000864 0.002187 0.008207 +5803 1 0.000279 1560.000000 -0.000637 -0.001724 0.007934 +5804 1 0.000209 1560.000000 0.000685 0.001929 0.000128 +5805 1 0.000194 1560.000000 -0.000261 0.000188 0.004967 +5806 1 0.000196 1560.000000 0.002402 -0.001061 0.009078 +5807 1 0.000272 1560.000000 -0.003129 -0.000322 0.005717 +5808 1 0.000250 1560.000000 0.002584 -0.002204 0.006856 +5809 1 0.000205 1560.000000 -0.002937 0.000288 0.009274 +5810 1 0.000251 1560.000000 -0.002731 -0.000839 0.005509 +5811 1 0.000283 1560.000000 -0.000763 0.001074 0.008827 +5812 1 0.000229 1560.000000 -0.000695 -0.000259 0.005293 +5813 1 0.000239 1560.000000 -0.002228 -0.001128 0.000434 +5814 1 0.000200 1560.000000 0.002124 0.001469 0.003739 +5815 1 0.000245 1560.000000 0.002526 0.000261 0.007750 +5816 1 0.000205 1560.000000 -0.000134 -0.002236 0.000970 +5817 1 0.000218 1560.000000 0.000197 0.000799 0.000480 +5818 1 0.000194 1560.000000 0.000075 -0.001345 0.007997 +5819 1 0.000231 1560.000000 0.002750 -0.000990 0.001229 +5820 1 0.000220 1560.000000 -0.001774 0.002392 0.006635 +5821 1 0.000268 1560.000000 -0.002929 0.002293 0.003552 +5822 1 0.000257 1560.000000 -0.001235 0.000786 0.008504 +5823 1 0.000205 1560.000000 0.002856 0.001771 0.001990 +5824 1 0.000235 1560.000000 0.003472 -0.000585 0.002280 +5825 1 0.000241 1560.000000 -0.000308 -0.002211 0.004655 +5826 1 0.000217 1560.000000 -0.001686 0.000506 0.001898 +5827 1 0.000235 1560.000000 0.003213 -0.000368 0.006730 +5828 1 0.000222 1560.000000 -0.003294 0.001500 0.008462 +5829 1 0.000280 1560.000000 -0.000864 0.003606 0.001416 +5830 1 0.000218 1560.000000 0.000896 -0.003332 0.000262 +5831 1 0.000220 1560.000000 -0.003095 0.000410 0.006669 +5832 1 0.000239 1560.000000 -0.002061 -0.001331 0.002392 +5833 1 0.000226 1560.000000 0.000119 0.000223 0.002565 +5834 1 0.000213 1560.000000 0.000024 0.002322 0.006773 +5835 1 0.000202 1560.000000 0.001482 -0.002482 0.007821 +5836 1 0.000268 1560.000000 -0.001910 -0.003310 0.007633 +5837 1 0.000200 1560.000000 0.000937 -0.002467 0.009422 +5838 1 0.000263 1560.000000 0.001566 -0.001071 0.003492 +5839 1 0.000213 1560.000000 0.003242 0.000034 0.001279 +5840 1 0.000203 1560.000000 0.001839 0.000493 0.003568 +5841 1 0.000265 1560.000000 0.003153 -0.000861 0.001257 +5842 1 0.000229 1560.000000 -0.001054 0.001481 0.009091 +5843 1 0.000263 1560.000000 -0.002724 0.000030 0.001087 +5844 1 0.000234 1560.000000 0.000228 -0.001442 0.001030 +5845 1 0.000205 1560.000000 0.002855 0.002056 0.007085 +5846 1 0.000226 1560.000000 -0.000106 -0.002027 0.007769 +5847 1 0.000201 1560.000000 -0.000257 0.001965 0.009188 +5848 1 0.000232 1560.000000 0.000500 0.002252 0.008522 +5849 1 0.000272 1560.000000 0.002826 -0.001127 0.005228 +5850 1 0.000201 1560.000000 0.001979 0.002703 0.004807 +5851 1 0.000203 1560.000000 0.000621 0.000508 0.000371 +5852 1 0.000238 1560.000000 0.001605 -0.000843 0.000124 +5853 1 0.000208 1560.000000 0.001383 0.002682 0.005445 +5854 1 0.000223 1560.000000 0.001115 -0.003021 0.001757 +5855 1 0.000284 1560.000000 -0.002773 0.000149 0.007318 +5856 1 0.000199 1560.000000 0.001890 -0.000078 0.003658 +5857 1 0.000209 1560.000000 0.001197 0.001615 0.000156 +5858 1 0.000203 1560.000000 0.001849 -0.001428 0.009710 +5859 1 0.000204 1560.000000 0.002555 -0.001961 0.005469 +5860 1 0.000206 1560.000000 -0.003072 0.002002 0.007418 +5861 1 0.000208 1560.000000 0.001107 0.000176 0.001148 +5862 1 0.000213 1560.000000 0.003033 -0.000577 0.003969 +5863 1 0.000225 1560.000000 -0.001173 -0.000038 0.007037 +5864 1 0.000258 1560.000000 -0.001234 0.002384 0.002327 +5865 1 0.000266 1560.000000 0.001305 -0.001181 0.000495 +5866 1 0.000194 1560.000000 -0.000994 0.003585 0.002686 +5867 1 0.000238 1560.000000 -0.001076 -0.000199 0.006580 +5868 1 0.000193 1560.000000 0.001311 0.000802 0.005019 +5869 1 0.000221 1560.000000 -0.002099 0.002794 0.008675 +5870 1 0.000212 1560.000000 0.002557 0.000525 0.006983 +5871 1 0.000275 1560.000000 0.002583 -0.001926 0.009623 +5872 1 0.000204 1560.000000 0.001022 -0.003089 0.003324 +5873 1 0.000210 1560.000000 0.000103 -0.002890 0.006019 +5874 1 0.000200 1560.000000 0.001872 0.002892 0.000728 +5875 1 0.000274 1560.000000 0.000111 -0.001219 0.009381 +5876 1 0.000275 1560.000000 -0.001043 -0.001911 0.004078 +5877 1 0.000243 1560.000000 0.000349 -0.002219 0.006327 +5878 1 0.000205 1560.000000 0.002895 -0.001249 0.004404 +5879 1 0.000206 1560.000000 -0.002511 -0.002797 0.009718 +5880 1 0.000225 1560.000000 -0.003502 0.000484 0.003874 +5881 1 0.000219 1560.000000 0.002119 -0.000840 0.003251 +5882 1 0.000257 1560.000000 -0.000234 0.001396 0.002710 +5883 1 0.000213 1560.000000 0.000669 -0.000569 0.008430 +5884 1 0.000246 1560.000000 0.001137 0.003484 0.003878 +5885 1 0.000221 1560.000000 -0.002204 0.000874 0.009473 +5886 1 0.000237 1560.000000 0.002427 0.000732 0.002230 +5887 1 0.000261 1560.000000 -0.001490 -0.002303 0.004721 +5888 1 0.000222 1560.000000 -0.001268 -0.001494 0.009126 +5889 1 0.000242 1560.000000 -0.003201 -0.000949 0.009680 +5890 1 0.000251 1560.000000 -0.000487 -0.002566 0.002632 +5891 1 0.000275 1560.000000 0.001802 -0.002229 0.006643 +5892 1 0.000204 1560.000000 0.000948 0.002987 0.002844 +5893 1 0.000233 1560.000000 -0.000610 0.000411 0.007315 +5894 1 0.000218 1560.000000 -0.002695 0.001555 0.009363 +5895 1 0.000242 1560.000000 -0.000163 -0.003016 0.000786 +5896 1 0.000222 1560.000000 0.000200 -0.002533 0.009627 +5897 1 0.000286 1560.000000 -0.001145 -0.001027 0.009455 +5898 1 0.000243 1560.000000 -0.000466 0.003340 0.005820 +5899 1 0.000192 1560.000000 0.001184 -0.000811 0.001767 +5900 1 0.000269 1560.000000 -0.003715 -0.000943 0.000331 +5901 1 0.000205 1560.000000 -0.002764 0.001454 0.007986 +5902 1 0.000202 1560.000000 0.002563 0.000006 0.004795 +5903 1 0.000196 1560.000000 -0.000835 -0.002094 0.005392 +5904 1 0.000227 1560.000000 -0.000871 0.003373 0.005824 +5905 1 0.000203 1560.000000 -0.001119 -0.002487 0.007608 +5906 1 0.000198 1560.000000 0.000631 -0.000616 0.000920 +5907 1 0.000213 1560.000000 -0.003450 -0.001244 0.005621 +5908 1 0.000233 1560.000000 -0.000612 -0.003719 0.002596 +5909 1 0.000260 1560.000000 0.003045 -0.001113 0.006990 +5910 1 0.000228 1560.000000 -0.000570 0.001574 0.001485 +5911 1 0.000208 1560.000000 -0.001083 -0.002089 0.006054 +5912 1 0.000235 1560.000000 0.003324 -0.001046 0.008309 +5913 1 0.000202 1560.000000 -0.002025 -0.001612 0.002652 +5914 1 0.000283 1560.000000 -0.000035 -0.003697 0.007170 +5915 1 0.000263 1560.000000 -0.003353 -0.001867 0.006300 +5916 1 0.000278 1560.000000 -0.001878 -0.000890 0.007017 +5917 1 0.000192 1560.000000 0.001589 0.001916 0.004142 +5918 1 0.000225 1560.000000 -0.001265 0.001819 0.005518 +5919 1 0.000230 1560.000000 0.002190 0.001175 0.002064 +5920 1 0.000267 1560.000000 -0.001381 -0.000941 0.008226 +5921 1 0.000274 1560.000000 -0.000252 -0.001470 0.004965 +5922 1 0.000252 1560.000000 -0.002671 -0.002552 0.008887 +5923 1 0.000226 1560.000000 -0.002225 0.000118 0.003923 +5924 1 0.000268 1560.000000 0.001808 -0.002618 0.004249 +5925 1 0.000257 1560.000000 0.000934 -0.002173 0.000475 +5926 1 0.000204 1560.000000 0.002644 0.001030 0.002665 +5927 1 0.000224 1560.000000 0.002439 0.002340 0.006631 +5928 1 0.000221 1560.000000 -0.001674 -0.002200 0.007925 +5929 1 0.000228 1560.000000 0.002061 -0.000258 0.008027 +5930 1 0.000229 1560.000000 -0.000120 -0.002093 0.000672 +5931 1 0.000206 1560.000000 -0.002911 -0.000010 0.008594 +5932 1 0.000254 1560.000000 -0.001603 -0.001147 0.001500 +5933 1 0.000264 1560.000000 0.000771 -0.003649 0.002711 +5934 1 0.000283 1560.000000 0.003181 0.001248 0.005348 +5935 1 0.000275 1560.000000 -0.000025 0.003299 0.001540 +5936 1 0.000245 1560.000000 -0.003212 -0.001234 0.002810 +5937 1 0.000208 1560.000000 -0.003061 0.000962 0.003887 +5938 1 0.000214 1560.000000 0.001593 -0.002844 0.000431 +5939 1 0.000196 1560.000000 0.002079 0.001638 0.006936 +5940 1 0.000268 1560.000000 0.003382 0.000255 0.005251 +5941 1 0.000202 1560.000000 -0.001515 -0.001510 0.004392 +5942 1 0.000240 1560.000000 0.000237 -0.003624 0.000718 +5943 1 0.000211 1560.000000 -0.002346 0.001911 0.002194 +5944 1 0.000247 1560.000000 -0.001497 -0.003121 0.006313 +5945 1 0.000250 1560.000000 -0.000793 0.001111 0.009711 +5946 1 0.000234 1560.000000 0.001318 0.002984 0.002674 +5947 1 0.000255 1560.000000 -0.000940 0.001863 0.009596 +5948 1 0.000270 1560.000000 -0.001420 0.002087 0.008003 +5949 1 0.000225 1560.000000 -0.002994 -0.001956 0.003022 +5950 1 0.000233 1560.000000 0.001023 -0.001233 0.005699 +5951 1 0.000207 1560.000000 -0.001984 -0.000341 0.001266 +5952 1 0.000194 1560.000000 0.002584 -0.001057 0.005790 +5953 1 0.000280 1560.000000 0.000008 0.001003 0.007691 +5954 1 0.000220 1560.000000 -0.000279 -0.001361 0.000539 +5955 1 0.000200 1560.000000 0.002653 -0.000492 0.000612 +5956 1 0.000220 1560.000000 -0.000606 0.000546 0.002407 +5957 1 0.000253 1560.000000 0.002350 -0.002417 0.007122 +5958 1 0.000237 1560.000000 -0.003786 0.000300 0.003569 +5959 1 0.000218 1560.000000 0.001829 0.002379 0.000647 +5960 1 0.000231 1560.000000 0.002569 0.002762 0.001990 +5961 1 0.000243 1560.000000 0.001944 0.000237 0.008842 +5962 1 0.000198 1560.000000 0.003198 0.001471 0.008692 +5963 1 0.000240 1560.000000 0.001942 0.000457 0.002767 +5964 1 0.000195 1560.000000 0.002732 -0.001886 0.001339 +5965 1 0.000227 1560.000000 -0.002078 0.003096 0.006960 +5966 1 0.000285 1560.000000 -0.002362 -0.000354 0.007370 +5967 1 0.000222 1560.000000 -0.000338 -0.000357 0.005102 +5968 1 0.000211 1560.000000 -0.001430 -0.001864 0.008852 +5969 1 0.000211 1560.000000 0.001385 -0.003434 0.003474 +5970 1 0.000231 1560.000000 0.001020 0.002120 0.001768 +5971 1 0.000249 1560.000000 0.001518 0.001999 0.000706 +5972 1 0.000274 1560.000000 0.001721 -0.000883 0.006508 +5973 1 0.000233 1560.000000 -0.001703 0.001054 0.007157 +5974 1 0.000246 1560.000000 -0.003332 -0.000260 0.009360 +5975 1 0.000193 1560.000000 -0.003444 0.000459 0.005232 +5976 1 0.000258 1560.000000 0.000170 0.002917 0.008573 +5977 1 0.000208 1560.000000 0.000334 -0.003470 0.002132 +5978 1 0.000268 1560.000000 0.002289 0.000216 0.005438 +5979 1 0.000215 1560.000000 -0.000167 0.002999 0.003099 +5980 1 0.000202 1560.000000 0.000756 0.000861 0.004756 +5981 1 0.000256 1560.000000 0.001109 -0.001419 0.002379 +5982 1 0.000213 1560.000000 -0.000896 0.002101 0.005573 +5983 1 0.000215 1560.000000 -0.000567 -0.002754 0.009664 +5984 1 0.000197 1560.000000 -0.000578 0.000811 0.000582 +5985 1 0.000288 1560.000000 0.003116 0.001642 0.006759 +5986 1 0.000214 1560.000000 -0.000656 -0.002816 0.003897 +5987 1 0.000192 1560.000000 -0.002774 -0.000486 0.005732 +5988 1 0.000205 1560.000000 -0.001171 -0.000756 0.002522 +5989 1 0.000244 1560.000000 0.002812 0.002245 0.008083 +5990 1 0.000210 1560.000000 -0.001918 -0.000312 0.005746 +5991 1 0.000217 1560.000000 -0.001494 -0.002630 0.001502 +5992 1 0.000220 1560.000000 -0.002919 0.001020 0.006650 +5993 1 0.000284 1560.000000 0.001797 0.003031 0.006000 +5994 1 0.000219 1560.000000 0.002505 0.002203 0.007961 +5995 1 0.000202 1560.000000 -0.000759 0.000806 0.005647 +5996 1 0.000276 1560.000000 -0.003064 -0.000041 0.000279 +5997 1 0.000216 1560.000000 -0.000955 0.000886 0.003881 +5998 1 0.000248 1560.000000 -0.000786 0.001379 0.008621 +5999 1 0.000208 1560.000000 -0.000593 -0.003782 0.005892 +6000 1 0.000205 1560.000000 -0.001979 0.002100 0.001879 +6001 1 0.000195 1560.000000 -0.001177 -0.003526 0.008415 +6002 1 0.000194 1560.000000 -0.000115 0.002210 0.008303 +6003 1 0.000233 1560.000000 0.001847 -0.001442 0.004050 +6004 1 0.000205 1560.000000 0.003019 -0.001810 0.006099 +6005 1 0.000229 1560.000000 -0.003573 0.001193 0.005692 +6006 1 0.000281 1560.000000 0.000297 0.002060 0.008266 +6007 1 0.000232 1560.000000 0.000721 -0.003566 0.009143 +6008 1 0.000219 1560.000000 -0.003316 -0.000147 0.005063 +6009 1 0.000208 1560.000000 0.000611 -0.003267 0.003187 +6010 1 0.000250 1560.000000 -0.002517 -0.000307 0.008463 +6011 1 0.000261 1560.000000 -0.003244 -0.000287 0.008800 +6012 1 0.000211 1560.000000 -0.001370 -0.001010 0.009717 +6013 1 0.000232 1560.000000 0.000847 -0.003568 0.005679 +6014 1 0.000232 1560.000000 -0.000397 0.002110 0.004327 +6015 1 0.000200 1560.000000 -0.001945 -0.001901 0.000995 +6016 1 0.000194 1560.000000 0.001072 0.000365 0.000364 +6017 1 0.000265 1560.000000 0.000361 -0.002884 0.000181 +6018 1 0.000276 1560.000000 0.002612 -0.002496 0.003497 +6019 1 0.000212 1560.000000 -0.002281 0.003043 0.002272 +6020 1 0.000250 1560.000000 0.000655 0.000576 0.004473 +6021 1 0.000272 1560.000000 -0.001791 0.002179 0.008327 +6022 1 0.000286 1560.000000 0.000779 0.003729 0.008897 +6023 1 0.000209 1560.000000 -0.000115 -0.001856 0.003384 +6024 1 0.000242 1560.000000 -0.000120 0.001495 0.001027 +6025 1 0.000219 1560.000000 0.002433 -0.001769 0.002564 +6026 1 0.000257 1560.000000 -0.000248 0.002008 0.005461 +6027 1 0.000230 1560.000000 0.002316 -0.002259 0.008196 +6028 1 0.000199 1560.000000 -0.000846 0.003179 0.007275 +6029 1 0.000204 1560.000000 -0.003229 -0.000757 0.000647 +6030 1 0.000198 1560.000000 0.002277 -0.000646 0.006219 +6031 1 0.000211 1560.000000 -0.001651 0.000493 0.002882 +6032 1 0.000224 1560.000000 -0.001126 0.001122 0.006625 +6033 1 0.000267 1560.000000 0.000568 0.002535 0.003572 +6034 1 0.000239 1560.000000 -0.002146 -0.001661 0.009546 +6035 1 0.000223 1560.000000 0.001237 0.002024 0.001151 +6036 1 0.000218 1560.000000 0.000294 0.002876 0.000538 +6037 1 0.000241 1560.000000 -0.002098 -0.002237 0.007047 +6038 1 0.000205 1560.000000 -0.000423 -0.003112 0.007410 +6039 1 0.000212 1560.000000 0.001830 -0.000697 0.002976 +6040 1 0.000275 1560.000000 -0.000211 -0.003125 0.007022 +6041 1 0.000226 1560.000000 -0.003404 0.000536 0.008124 +6042 1 0.000287 1560.000000 0.002278 -0.003050 0.006845 +6043 1 0.000218 1560.000000 0.003251 -0.001776 0.002689 +6044 1 0.000268 1560.000000 0.003774 0.000419 0.004764 +6045 1 0.000221 1560.000000 0.002260 0.001705 0.006742 +6046 1 0.000200 1560.000000 -0.001022 -0.001682 0.001251 +6047 1 0.000222 1560.000000 0.000584 -0.003128 0.009241 +6048 1 0.000228 1560.000000 -0.000883 -0.000772 0.003650 +6049 1 0.000197 1560.000000 0.003039 -0.001234 0.001664 +6050 1 0.000205 1560.000000 0.001007 0.000349 0.005328 +6051 1 0.000251 1560.000000 -0.001800 0.002203 0.004490 +6052 1 0.000245 1560.000000 0.002109 0.000223 0.003897 +6053 1 0.000236 1560.000000 0.000880 0.003021 0.000421 +6054 1 0.000247 1560.000000 0.001723 0.003249 0.005139 +6055 1 0.000227 1560.000000 -0.002021 0.000496 0.000373 +6056 1 0.000197 1560.000000 0.001629 -0.000334 0.007224 +6057 1 0.000194 1560.000000 0.003570 -0.001362 0.000152 +6058 1 0.000217 1560.000000 0.000851 0.003038 0.009689 +6059 1 0.000208 1560.000000 0.003089 0.002096 0.004367 +6060 1 0.000213 1560.000000 -0.000719 0.000308 0.005984 +6061 1 0.000213 1560.000000 0.002006 -0.002193 0.006994 +6062 1 0.000267 1560.000000 -0.000479 0.000347 0.001025 +6063 1 0.000223 1560.000000 -0.000165 -0.001159 0.006802 +6064 1 0.000195 1560.000000 -0.001770 -0.000100 0.008363 +6065 1 0.000221 1560.000000 -0.002222 -0.000485 0.006220 +6066 1 0.000236 1560.000000 0.000600 -0.002864 0.000349 +6067 1 0.000241 1560.000000 0.001616 0.002377 0.000734 +6068 1 0.000235 1560.000000 -0.001850 -0.002751 0.005764 +6069 1 0.000222 1560.000000 -0.002996 0.000480 0.007175 +6070 1 0.000214 1560.000000 0.001062 -0.001619 0.009337 +6071 1 0.000247 1560.000000 0.001127 0.000242 0.007373 +6072 1 0.000220 1560.000000 0.002200 -0.000456 0.007741 +6073 1 0.000239 1560.000000 -0.001012 0.002921 0.007205 +6074 1 0.000274 1560.000000 -0.003209 0.001439 0.002929 +6075 1 0.000229 1560.000000 -0.001581 -0.000745 0.006345 +6076 1 0.000213 1560.000000 0.001089 0.001501 0.003088 +6077 1 0.000249 1560.000000 0.002508 0.002882 0.006119 +6078 1 0.000279 1560.000000 0.001960 0.000023 0.009087 +6079 1 0.000229 1560.000000 -0.002393 0.002810 0.003045 +6080 1 0.000229 1560.000000 -0.002474 0.000512 0.006471 +6081 1 0.000203 1560.000000 0.002350 -0.000432 0.004410 +6082 1 0.000197 1560.000000 -0.000687 -0.003070 0.005101 +6083 1 0.000208 1560.000000 0.000356 0.000742 0.007889 +6084 1 0.000197 1560.000000 0.001805 0.002242 0.008059 +6085 1 0.000218 1560.000000 -0.001024 0.000457 0.003478 +6086 1 0.000242 1560.000000 -0.002742 -0.000716 0.008516 +6087 1 0.000229 1560.000000 0.001974 -0.002936 0.002227 +6088 1 0.000218 1560.000000 -0.002471 0.000648 0.005915 +6089 1 0.000217 1560.000000 -0.001375 -0.000486 0.005252 +6090 1 0.000195 1560.000000 0.002038 -0.000063 0.005840 +6091 1 0.000213 1560.000000 -0.002800 -0.000997 0.000367 +6092 1 0.000207 1560.000000 0.000221 -0.002540 0.008271 +6093 1 0.000230 1560.000000 0.002845 -0.000258 0.006844 +6094 1 0.000236 1560.000000 -0.003430 0.001036 0.002540 +6095 1 0.000210 1560.000000 0.002931 -0.001527 0.007601 +6096 1 0.000242 1560.000000 -0.003021 -0.000553 0.008701 +6097 1 0.000253 1560.000000 -0.002437 0.002016 0.006236 +6098 1 0.000275 1560.000000 -0.001431 0.002739 0.003267 +6099 1 0.000233 1560.000000 -0.002660 0.002010 0.002262 +6100 1 0.000207 1560.000000 -0.001774 -0.002138 0.002220 +6101 1 0.000245 1560.000000 0.003412 0.001516 0.002575 +6102 1 0.000258 1560.000000 -0.003367 0.001403 0.001788 +6103 1 0.000260 1560.000000 -0.001297 0.000637 0.008153 +6104 1 0.000248 1560.000000 0.000241 0.001008 0.002440 +6105 1 0.000200 1560.000000 0.000075 -0.000541 0.000472 +6106 1 0.000194 1560.000000 -0.001650 -0.002924 0.002604 +6107 1 0.000218 1560.000000 0.000709 0.000945 0.002286 +6108 1 0.000200 1560.000000 -0.002043 -0.001907 0.008720 +6109 1 0.000193 1560.000000 -0.001424 -0.001032 0.004051 +6110 1 0.000217 1560.000000 -0.001346 -0.002179 0.001951 +6111 1 0.000263 1560.000000 0.001815 0.003219 0.001626 +6112 1 0.000241 1560.000000 -0.001396 0.001863 0.002871 +6113 1 0.000246 1560.000000 -0.002963 0.000348 0.003810 +6114 1 0.000201 1560.000000 0.001049 0.002323 0.008945 +6115 1 0.000231 1560.000000 -0.001593 0.001130 0.001569 +6116 1 0.000251 1560.000000 -0.000943 0.002219 0.006899 +6117 1 0.000197 1560.000000 0.002894 -0.000390 0.005322 +6118 1 0.000212 1560.000000 -0.001090 0.002794 0.006683 +6119 1 0.000227 1560.000000 -0.001185 -0.002619 0.006090 +6120 1 0.000207 1560.000000 -0.002764 -0.001123 0.007122 +6121 1 0.000257 1560.000000 0.001890 -0.000819 0.009594 +6122 1 0.000233 1560.000000 0.001439 -0.001325 0.004256 +6123 1 0.000241 1560.000000 -0.002980 0.001149 0.004342 +6124 1 0.000236 1560.000000 -0.002113 0.000551 0.009710 +6125 1 0.000270 1560.000000 0.000126 0.001411 0.009399 +6126 1 0.000252 1560.000000 0.000790 0.000173 0.002286 +6127 1 0.000216 1560.000000 0.002599 0.000486 0.009061 +6128 1 0.000232 1560.000000 0.000117 -0.001638 0.005916 +6129 1 0.000241 1560.000000 0.003451 -0.000952 0.004593 +6130 1 0.000231 1560.000000 0.001772 0.001244 0.000909 +6131 1 0.000199 1560.000000 0.001565 -0.003166 0.006590 +6132 1 0.000231 1560.000000 -0.000991 0.003082 0.007682 +6133 1 0.000213 1560.000000 -0.001153 -0.000813 0.005161 +6134 1 0.000233 1560.000000 -0.003144 0.001853 0.002797 +6135 1 0.000213 1560.000000 0.000986 0.002925 0.008736 +6136 1 0.000196 1560.000000 -0.002684 -0.001681 0.009160 +6137 1 0.000285 1560.000000 0.001289 0.001688 0.006454 +6138 1 0.000257 1560.000000 0.000473 0.001025 0.001527 +6139 1 0.000234 1560.000000 0.001551 -0.000339 0.000524 +6140 1 0.000199 1560.000000 0.001105 -0.002007 0.005670 +6141 1 0.000228 1560.000000 -0.001411 -0.003092 0.009621 +6142 1 0.000236 1560.000000 0.001353 0.000250 0.001005 +6143 1 0.000264 1560.000000 -0.002118 -0.000998 0.003154 +6144 1 0.000248 1560.000000 -0.001140 -0.002217 0.009290 +6145 1 0.000234 1560.000000 0.000442 0.002608 0.002507 +6146 1 0.000208 1560.000000 -0.001976 -0.002665 0.009578 +6147 1 0.000228 1560.000000 -0.003469 -0.000621 0.002383 +6148 1 0.000197 1560.000000 0.001213 -0.002935 0.000942 +6149 1 0.000206 1560.000000 -0.001242 -0.001099 0.002424 +6150 1 0.000249 1560.000000 0.000538 0.003143 0.001651 +6151 1 0.000212 1560.000000 0.000948 -0.000480 0.006269 +6152 1 0.000243 1560.000000 0.002865 0.002122 0.007839 +6153 1 0.000264 1560.000000 0.002928 -0.000173 0.005734 +6154 1 0.000229 1560.000000 0.002611 -0.000201 0.008907 +6155 1 0.000210 1560.000000 0.002033 -0.001582 0.001949 +6156 1 0.000209 1560.000000 0.003438 -0.001098 0.008596 +6157 1 0.000219 1560.000000 0.002177 0.000017 0.008949 +6158 1 0.000201 1560.000000 -0.000062 0.003229 0.000366 +6159 1 0.000225 1560.000000 0.000450 -0.000002 0.005227 +6160 1 0.000229 1560.000000 -0.002416 0.000235 0.002003 +6161 1 0.000196 1560.000000 0.003147 -0.001213 0.001413 +6162 1 0.000244 1560.000000 -0.000328 -0.000657 0.006332 +6163 1 0.000263 1560.000000 -0.000246 -0.000672 0.001701 +6164 1 0.000261 1560.000000 -0.002368 0.000946 0.007822 +6165 1 0.000264 1560.000000 -0.001701 -0.003265 0.004338 +6166 1 0.000215 1560.000000 0.000603 0.000065 0.009756 +6167 1 0.000192 1560.000000 0.002792 -0.001835 0.008886 +6168 1 0.000220 1560.000000 0.001629 -0.001118 0.006261 +6169 1 0.000230 1560.000000 0.003726 0.000763 0.009398 +6170 1 0.000209 1560.000000 -0.000218 0.002397 0.000924 +6171 1 0.000242 1560.000000 0.002986 0.000663 0.008918 +6172 1 0.000288 1560.000000 -0.001783 0.002056 0.000283 +6173 1 0.000220 1560.000000 0.002238 -0.002840 0.004883 +6174 1 0.000221 1560.000000 -0.001015 -0.003653 0.007569 +6175 1 0.000219 1560.000000 0.001606 -0.001610 0.002705 +6176 1 0.000246 1560.000000 -0.000803 -0.003058 0.000129 +6177 1 0.000205 1560.000000 0.001775 -0.002590 0.006996 +6178 1 0.000211 1560.000000 -0.000264 0.000158 0.000621 +6179 1 0.000195 1560.000000 -0.001263 -0.000531 0.005824 +6180 1 0.000208 1560.000000 0.000169 0.000675 0.003920 +6181 1 0.000279 1560.000000 0.001184 0.001357 0.005391 +6182 1 0.000265 1560.000000 0.001017 -0.001460 0.009794 +6183 1 0.000267 1560.000000 0.002356 -0.000458 0.006094 +6184 1 0.000215 1560.000000 -0.000954 0.000046 0.009736 +6185 1 0.000200 1560.000000 0.002600 -0.001452 0.000730 +6186 1 0.000199 1560.000000 -0.001981 0.002466 0.009301 +6187 1 0.000277 1560.000000 -0.001167 0.003607 0.002963 +6188 1 0.000198 1560.000000 -0.000667 -0.001964 0.000728 +6189 1 0.000232 1560.000000 0.001399 -0.000600 0.009021 +6190 1 0.000257 1560.000000 -0.003045 0.000178 0.007361 +6191 1 0.000260 1560.000000 -0.003627 0.000039 0.005909 +6192 1 0.000200 1560.000000 0.000608 0.002545 0.005018 +6193 1 0.000219 1560.000000 -0.001833 -0.002477 0.006077 +6194 1 0.000224 1560.000000 -0.002872 0.000222 0.001974 +6195 1 0.000242 1560.000000 -0.001026 -0.000448 0.009185 +6196 1 0.000225 1560.000000 0.002497 0.001987 0.008672 +6197 1 0.000230 1560.000000 -0.000585 0.000784 0.000259 +6198 1 0.000216 1560.000000 0.000227 0.000668 0.005550 +6199 1 0.000225 1560.000000 -0.001509 -0.001241 0.008684 +6200 1 0.000229 1560.000000 0.001625 -0.003118 0.009625 +6201 1 0.000196 1560.000000 0.002527 0.000047 0.001855 +6202 1 0.000237 1560.000000 -0.002975 -0.001620 0.006046 +6203 1 0.000239 1560.000000 0.000767 0.001477 0.009650 +6204 1 0.000207 1560.000000 -0.001785 -0.001583 0.007927 +6205 1 0.000277 1560.000000 0.002300 -0.001520 0.005956 +6206 1 0.000213 1560.000000 -0.003169 0.000018 0.003871 +6207 1 0.000227 1560.000000 0.000258 -0.000762 0.004744 +6208 1 0.000203 1560.000000 -0.000636 -0.002145 0.008334 +6209 1 0.000219 1560.000000 -0.003581 0.001198 0.002974 +6210 1 0.000201 1560.000000 -0.002401 -0.000762 0.002471 +6211 1 0.000266 1560.000000 -0.000293 -0.001291 0.007462 +6212 1 0.000208 1560.000000 -0.003791 -0.000189 0.007845 +6213 1 0.000217 1560.000000 -0.000311 -0.003291 0.001657 +6214 1 0.000205 1560.000000 -0.002608 0.000661 0.008393 +6215 1 0.000222 1560.000000 0.001065 0.002916 0.007960 +6216 1 0.000230 1560.000000 -0.003331 0.001148 0.005001 +6217 1 0.000219 1560.000000 -0.003059 0.000356 0.003448 +6218 1 0.000238 1560.000000 0.000735 -0.001079 0.007637 +6219 1 0.000219 1560.000000 -0.001580 -0.002263 0.006691 +6220 1 0.000201 1560.000000 0.000108 -0.002518 0.008840 +6221 1 0.000211 1560.000000 0.000006 -0.000475 0.007038 +6222 1 0.000213 1560.000000 0.003103 0.001150 0.003376 +6223 1 0.000227 1560.000000 -0.000143 -0.002004 0.002970 +6224 1 0.000202 1560.000000 -0.003328 -0.000085 0.008429 +6225 1 0.000230 1560.000000 0.001922 -0.000748 0.009053 +6226 1 0.000219 1560.000000 -0.001306 -0.003350 0.000456 +6227 1 0.000219 1560.000000 -0.000635 -0.000738 0.009365 +6228 1 0.000265 1560.000000 -0.002260 -0.001061 0.002926 +6229 1 0.000263 1560.000000 -0.002600 -0.000627 0.001241 +6230 1 0.000200 1560.000000 -0.001307 -0.000185 0.008006 +6231 1 0.000266 1560.000000 0.000036 -0.003207 0.009806 +6232 1 0.000219 1560.000000 -0.002130 -0.002527 0.005643 +6233 1 0.000215 1560.000000 0.000023 0.000324 0.005463 +6234 1 0.000206 1560.000000 0.002684 -0.001022 0.004778 +6235 1 0.000245 1560.000000 0.001748 -0.003360 0.006771 +6236 1 0.000209 1560.000000 0.001873 -0.001113 0.005957 +6237 1 0.000272 1560.000000 0.000822 -0.003349 0.003316 +6238 1 0.000202 1560.000000 -0.002685 -0.002097 0.003103 +6239 1 0.000195 1560.000000 -0.000030 -0.001716 0.003818 +6240 1 0.000193 1560.000000 -0.003431 0.000067 0.001089 +6241 1 0.000233 1560.000000 0.000792 0.001780 0.009779 +6242 1 0.000238 1560.000000 0.001965 0.000769 0.006151 +6243 1 0.000243 1560.000000 -0.000146 0.003056 0.004242 +6244 1 0.000193 1560.000000 0.003051 0.001611 0.000125 +6245 1 0.000270 1560.000000 0.001470 -0.001077 0.000202 +6246 1 0.000237 1560.000000 -0.000500 0.003755 0.007999 +6247 1 0.000250 1560.000000 -0.002865 0.001542 0.007129 +6248 1 0.000251 1560.000000 -0.000573 0.001969 0.004897 +6249 1 0.000261 1560.000000 -0.003560 0.001428 0.000590 +6250 1 0.000200 1560.000000 -0.001211 -0.003168 0.007564 +6251 1 0.000254 1560.000000 -0.002766 -0.000203 0.007634 +6252 1 0.000203 1560.000000 0.002563 0.001965 0.003145 +6253 1 0.000196 1560.000000 -0.001116 0.001627 0.005512 +6254 1 0.000244 1560.000000 -0.000849 0.001250 0.004004 +6255 1 0.000226 1560.000000 -0.002273 -0.002238 0.002299 +6256 1 0.000276 1560.000000 -0.001947 0.003207 0.006681 +6257 1 0.000242 1560.000000 -0.002427 0.000826 0.000505 +6258 1 0.000252 1560.000000 -0.003544 -0.001428 0.008379 +6259 1 0.000225 1560.000000 0.002926 0.000354 0.001773 +6260 1 0.000230 1560.000000 -0.001275 -0.001445 0.004795 +6261 1 0.000239 1560.000000 0.001551 0.001910 0.006859 +6262 1 0.000244 1560.000000 0.002913 -0.000679 0.001442 +6263 1 0.000256 1560.000000 -0.000442 -0.002077 0.006884 +6264 1 0.000199 1560.000000 0.001081 -0.002011 0.000172 +6265 1 0.000208 1560.000000 -0.003111 -0.001736 0.009248 +6266 1 0.000198 1560.000000 0.000839 0.002773 0.002114 +6267 1 0.000268 1560.000000 0.002151 0.001340 0.000542 +6268 1 0.000196 1560.000000 -0.001167 -0.000581 0.004859 +6269 1 0.000229 1560.000000 -0.001388 0.002238 0.003820 +6270 1 0.000224 1560.000000 0.000724 -0.001463 0.004573 +6271 1 0.000268 1560.000000 -0.000130 -0.003045 0.005115 +6272 1 0.000204 1560.000000 -0.001437 -0.000791 0.008746 +6273 1 0.000200 1560.000000 0.003647 -0.000963 0.004172 +6274 1 0.000276 1560.000000 0.002613 -0.002705 0.007283 +6275 1 0.000280 1560.000000 -0.002363 0.001592 0.006259 +6276 1 0.000242 1560.000000 -0.000810 0.001950 0.001684 +6277 1 0.000217 1560.000000 0.003520 0.000354 0.003272 +6278 1 0.000238 1560.000000 -0.002494 -0.000614 0.007321 +6279 1 0.000263 1560.000000 0.003473 -0.001130 0.009471 +6280 1 0.000196 1560.000000 -0.000295 0.001557 0.007469 +6281 1 0.000232 1560.000000 0.000493 -0.003396 0.001992 +6282 1 0.000221 1560.000000 0.001423 0.001880 0.006116 +6283 1 0.000208 1560.000000 0.002826 -0.002465 0.009416 +6284 1 0.000230 1560.000000 -0.002541 0.000214 0.007735 +6285 1 0.000214 1560.000000 -0.001499 -0.003473 0.000518 +6286 1 0.000259 1560.000000 -0.000829 -0.001734 0.008982 +6287 1 0.000214 1560.000000 0.000619 -0.001848 0.009124 +6288 1 0.000284 1560.000000 -0.002963 -0.002101 0.005981 +6289 1 0.000204 1560.000000 -0.001164 0.000418 0.009505 +6290 1 0.000264 1560.000000 0.000598 -0.001879 0.005022 +6291 1 0.000209 1560.000000 0.003004 0.000120 0.000473 +6292 1 0.000199 1560.000000 0.001316 0.001141 0.006103 +6293 1 0.000254 1560.000000 -0.003523 0.000006 0.000132 +6294 1 0.000197 1560.000000 0.003694 -0.001071 0.007563 +6295 1 0.000274 1560.000000 -0.000492 0.001529 0.004011 +6296 1 0.000238 1560.000000 0.000501 -0.001056 0.001510 +6297 1 0.000212 1560.000000 -0.001040 -0.002203 0.006870 +6298 1 0.000216 1560.000000 -0.001582 0.001229 0.000631 +6299 1 0.000243 1560.000000 0.001150 -0.001732 0.003155 +6300 1 0.000206 1560.000000 -0.002641 -0.000734 0.005083 +6301 1 0.000224 1560.000000 -0.000045 -0.000552 0.005274 +6302 1 0.000220 1560.000000 -0.003355 -0.000876 0.007363 +6303 1 0.000203 1560.000000 -0.000026 0.001184 0.001857 +6304 1 0.000254 1560.000000 -0.002093 0.000806 0.008673 +6305 1 0.000276 1560.000000 0.000874 0.000729 0.009691 +6306 1 0.000288 1560.000000 0.003278 0.001530 0.006090 +6307 1 0.000254 1560.000000 0.001158 0.001835 0.008513 +6308 1 0.000207 1560.000000 -0.001968 -0.003264 0.002177 +6309 1 0.000207 1560.000000 -0.000173 -0.000384 0.006969 +6310 1 0.000209 1560.000000 -0.000289 0.002989 0.002874 +6311 1 0.000218 1560.000000 0.001209 0.000057 0.007602 +6312 1 0.000202 1560.000000 0.000140 0.001279 0.006237 +6313 1 0.000245 1560.000000 0.001658 -0.002059 0.000176 +6314 1 0.000196 1560.000000 -0.001526 -0.000778 0.000793 +6315 1 0.000227 1560.000000 -0.003341 -0.001728 0.001416 +6316 1 0.000241 1560.000000 0.003434 -0.001730 0.002221 +6317 1 0.000275 1560.000000 -0.001936 -0.001760 0.004994 +6318 1 0.000278 1560.000000 -0.000831 0.001413 0.005601 +6319 1 0.000222 1560.000000 -0.001192 -0.000029 0.008558 +6320 1 0.000194 1560.000000 0.002020 0.002526 0.005592 +6321 1 0.000234 1560.000000 -0.000880 0.002758 0.009512 +6322 1 0.000193 1560.000000 -0.001904 -0.000184 0.001854 +6323 1 0.000210 1560.000000 0.002271 0.001100 0.000802 +6324 1 0.000219 1560.000000 0.000802 0.002035 0.007274 +6325 1 0.000283 1560.000000 -0.003089 0.001408 0.003484 +6326 1 0.000201 1560.000000 0.002543 0.000372 0.000344 +6327 1 0.000266 1560.000000 0.000106 -0.002427 0.002462 +6328 1 0.000192 1560.000000 -0.002756 0.000506 0.007332 +6329 1 0.000207 1560.000000 0.001623 0.001068 0.007745 +6330 1 0.000246 1560.000000 0.001916 -0.001092 0.009166 +6331 1 0.000208 1560.000000 -0.000918 -0.002806 0.009047 +6332 1 0.000234 1560.000000 0.003070 0.001884 0.007071 +6333 1 0.000256 1560.000000 -0.002762 0.001352 0.009771 +6334 1 0.000238 1560.000000 -0.000977 0.003452 0.006603 +6335 1 0.000196 1560.000000 -0.001721 -0.001416 0.009126 +6336 1 0.000285 1560.000000 -0.002790 0.001843 0.008827 +6337 1 0.000277 1560.000000 -0.002913 -0.000565 0.002784 +6338 1 0.000220 1560.000000 -0.002142 -0.001481 0.003558 +6339 1 0.000262 1560.000000 -0.001487 -0.003347 0.007419 +6340 1 0.000204 1560.000000 0.001144 -0.003636 0.006547 +6341 1 0.000210 1560.000000 -0.000707 0.001401 0.004502 +6342 1 0.000230 1560.000000 -0.001542 -0.002480 0.002009 +6343 1 0.000243 1560.000000 0.002715 0.000604 0.002188 +6344 1 0.000265 1560.000000 0.003195 -0.000957 0.000460 +6345 1 0.000263 1560.000000 0.000966 0.000505 0.000141 +6346 1 0.000209 1560.000000 0.001535 0.001274 0.008920 +6347 1 0.000279 1560.000000 0.003111 -0.001171 0.007293 +6348 1 0.000204 1560.000000 -0.002460 0.002724 0.001985 +6349 1 0.000247 1560.000000 0.000198 -0.002229 0.007824 +6350 1 0.000245 1560.000000 0.000328 -0.000349 0.007104 +6351 1 0.000203 1560.000000 0.000755 -0.000561 0.005558 +6352 1 0.000246 1560.000000 -0.003425 0.000422 0.001508 +6353 1 0.000241 1560.000000 0.000578 0.001001 0.002730 +6354 1 0.000248 1560.000000 -0.000503 0.001248 0.008737 +6355 1 0.000226 1560.000000 0.001678 -0.001442 0.001273 +6356 1 0.000244 1560.000000 -0.002736 0.001330 0.004071 +6357 1 0.000223 1560.000000 0.002438 0.001511 0.000870 +6358 1 0.000233 1560.000000 0.001622 -0.001751 0.009385 +6359 1 0.000263 1560.000000 -0.002910 -0.001705 0.007000 +6360 1 0.000195 1560.000000 0.002193 -0.002763 0.005250 +6361 1 0.000217 1560.000000 -0.001307 0.001299 0.001098 +6362 1 0.000246 1560.000000 -0.000667 0.002599 0.000612 +6363 1 0.000287 1560.000000 -0.002309 0.001822 0.002771 +6364 1 0.000215 1560.000000 0.000998 -0.002951 0.007794 +6365 1 0.000254 1560.000000 -0.002643 0.001894 0.005981 +6366 1 0.000194 1560.000000 -0.001722 -0.000753 0.009627 +6367 1 0.000193 1560.000000 0.000335 -0.001052 0.004813 +6368 1 0.000241 1560.000000 -0.001860 -0.001880 0.004498 +6369 1 0.000244 1560.000000 -0.003264 -0.000850 0.002288 +6370 1 0.000199 1560.000000 0.001899 -0.002391 0.007934 +6371 1 0.000212 1560.000000 -0.000544 -0.001229 0.000191 +6372 1 0.000273 1560.000000 0.001591 -0.002073 0.008645 +6373 1 0.000223 1560.000000 0.000389 0.001928 0.004711 +6374 1 0.000214 1560.000000 0.002211 0.000337 0.002158 +6375 1 0.000283 1560.000000 -0.000993 -0.000168 0.009570 +6376 1 0.000223 1560.000000 0.002973 -0.000631 0.009218 +6377 1 0.000212 1560.000000 -0.002333 -0.000850 0.006779 +6378 1 0.000222 1560.000000 -0.002202 -0.002993 0.001833 +6379 1 0.000252 1560.000000 0.001165 -0.002491 0.004444 +6380 1 0.000264 1560.000000 0.000316 -0.001526 0.003862 +6381 1 0.000274 1560.000000 -0.000079 -0.002566 0.001951 +6382 1 0.000276 1560.000000 0.000289 -0.001853 0.008652 +6383 1 0.000260 1560.000000 0.001528 0.000453 0.002824 +6384 1 0.000215 1560.000000 0.001978 0.002229 0.005624 +6385 1 0.000283 1560.000000 0.000692 0.003757 0.001712 +6386 1 0.000239 1560.000000 -0.002391 -0.002254 0.006285 +6387 1 0.000226 1560.000000 -0.000497 -0.003195 0.003112 +6388 1 0.000228 1560.000000 0.002063 0.002285 0.000786 +6389 1 0.000206 1560.000000 -0.000327 0.002599 0.007643 +6390 1 0.000248 1560.000000 0.001962 0.000690 0.004739 +6391 1 0.000279 1560.000000 0.001875 -0.001245 0.002917 +6392 1 0.000266 1560.000000 0.001593 0.000480 0.009828 +6393 1 0.000228 1560.000000 -0.002855 0.000148 0.009070 +6394 1 0.000230 1560.000000 0.001230 0.003362 0.005767 +6395 1 0.000205 1560.000000 0.002958 0.001075 0.005443 +6396 1 0.000236 1560.000000 0.001444 -0.003456 0.005524 +6397 1 0.000206 1560.000000 -0.002309 0.002332 0.009532 +6398 1 0.000212 1560.000000 0.002869 -0.000655 0.003379 +6399 1 0.000246 1560.000000 0.002680 0.000166 0.001343 +6400 1 0.000282 1560.000000 -0.002646 -0.000094 0.004065 +6401 1 0.000252 1560.000000 0.001665 -0.001048 0.005705 +6402 1 0.000285 1560.000000 -0.003339 0.001206 0.006022 +6403 1 0.000214 1560.000000 -0.000230 -0.003450 0.001921 +6404 1 0.000224 1560.000000 0.000909 -0.003502 0.009276 +6405 1 0.000240 1560.000000 -0.001979 0.000366 0.005889 +6406 1 0.000197 1560.000000 -0.000327 -0.002740 0.000827 +6407 1 0.000217 1560.000000 -0.001595 -0.000487 0.006157 +6408 1 0.000224 1560.000000 -0.001541 -0.001491 0.000344 +6409 1 0.000287 1560.000000 0.003611 -0.000545 0.009756 +6410 1 0.000223 1560.000000 -0.000852 -0.000264 0.007341 +6411 1 0.000255 1560.000000 0.003225 -0.002074 0.002848 +6412 1 0.000276 1560.000000 -0.001678 0.001373 0.009556 +6413 1 0.000251 1560.000000 -0.001285 0.000860 0.002382 +6414 1 0.000218 1560.000000 -0.002541 0.000704 0.008977 +6415 1 0.000197 1560.000000 -0.002569 -0.001527 0.002556 +6416 1 0.000195 1560.000000 -0.002228 0.001925 0.004577 +6417 1 0.000212 1560.000000 0.002827 0.000531 0.008318 +6418 1 0.000230 1560.000000 -0.000699 -0.000314 0.006361 +6419 1 0.000231 1560.000000 -0.002565 0.000517 0.009590 +6420 1 0.000198 1560.000000 -0.000914 0.002692 0.009274 +6421 1 0.000238 1560.000000 -0.000245 -0.001479 0.008581 +6422 1 0.000242 1560.000000 -0.002364 0.000117 0.007348 +6423 1 0.000196 1560.000000 0.002467 -0.000257 0.004996 +6424 1 0.000219 1560.000000 -0.001564 -0.001645 0.003810 +6425 1 0.000212 1560.000000 0.001717 -0.000019 0.007936 +6426 1 0.000204 1560.000000 0.002596 0.002305 0.002624 +6427 1 0.000223 1560.000000 -0.001608 0.002742 0.003927 +6428 1 0.000240 1560.000000 -0.000862 -0.003034 0.009572 +6429 1 0.000225 1560.000000 -0.003662 0.000267 0.009233 +6430 1 0.000220 1560.000000 0.000551 0.002151 0.003772 +6431 1 0.000211 1560.000000 0.001767 -0.003302 0.005767 +6432 1 0.000194 1560.000000 0.002121 -0.001821 0.003427 +6433 1 0.000220 1560.000000 -0.000692 0.002791 0.003087 +6434 1 0.000209 1560.000000 -0.000640 -0.002999 0.008311 +6435 1 0.000242 1560.000000 -0.002500 0.000734 0.008059 +6436 1 0.000261 1560.000000 0.003489 -0.000155 0.003828 +6437 1 0.000223 1560.000000 -0.003273 0.000440 0.001870 +6438 1 0.000206 1560.000000 -0.000771 -0.000657 0.000420 +6439 1 0.000266 1560.000000 -0.001977 -0.001562 0.008394 +6440 1 0.000204 1560.000000 -0.001701 0.001833 0.007746 +6441 1 0.000277 1560.000000 -0.001273 0.002818 0.001897 +6442 1 0.000224 1560.000000 -0.001854 -0.002353 0.006932 +6443 1 0.000201 1560.000000 0.001335 -0.002648 0.004261 +6444 1 0.000238 1560.000000 -0.002027 0.001359 0.009813 +6445 1 0.000202 1560.000000 0.003109 0.000256 0.005686 +6446 1 0.000249 1560.000000 0.001602 0.001446 0.004013 +6447 1 0.000202 1560.000000 0.003460 0.001127 0.001768 +6448 1 0.000204 1560.000000 -0.001842 0.000186 0.002179 +6449 1 0.000232 1560.000000 -0.001427 0.003473 0.000353 +6450 1 0.000203 1560.000000 0.000838 0.000412 0.001095 +6451 1 0.000217 1560.000000 0.001755 -0.001605 0.006536 +6452 1 0.000249 1560.000000 -0.002763 0.000957 0.008761 +6453 1 0.000243 1560.000000 -0.000866 -0.000441 0.006124 +6454 1 0.000211 1560.000000 0.000035 0.002097 0.009809 +6455 1 0.000229 1560.000000 0.001726 0.002739 0.006331 +6456 1 0.000242 1560.000000 0.001291 -0.001012 0.006614 +6457 1 0.000233 1560.000000 0.003559 0.001400 0.006033 +6458 1 0.000287 1560.000000 0.002969 0.000486 0.002403 +6459 1 0.000240 1560.000000 0.001013 0.001967 0.008103 +6460 1 0.000203 1560.000000 -0.002545 -0.000299 0.006743 +6461 1 0.000274 1560.000000 0.001296 -0.002571 0.009758 +6462 1 0.000205 1560.000000 0.003705 0.000770 0.004764 +6463 1 0.000247 1560.000000 -0.001940 -0.000203 0.005546 +6464 1 0.000212 1560.000000 -0.002687 -0.002425 0.004104 +6465 1 0.000214 1560.000000 0.002610 0.001207 0.004908 +6466 1 0.000211 1560.000000 0.001099 0.003284 0.007602 +6467 1 0.000260 1560.000000 -0.003440 -0.000494 0.001589 +6468 1 0.000204 1560.000000 -0.000954 0.001653 0.009312 +6469 1 0.000228 1560.000000 0.000026 0.000339 0.006517 +6470 1 0.000285 1560.000000 0.002650 -0.001095 0.001779 +6471 1 0.000200 1560.000000 0.002293 0.000978 0.007919 +6472 1 0.000237 1560.000000 -0.001518 -0.002805 0.006776 +6473 1 0.000206 1560.000000 0.002554 -0.000317 0.009535 +6474 1 0.000235 1560.000000 0.000274 0.001741 0.005309 +6475 1 0.000232 1560.000000 0.000908 0.003313 0.004678 +6476 1 0.000278 1560.000000 0.000708 0.002358 0.002688 +6477 1 0.000261 1560.000000 0.000383 0.002179 0.009578 +6478 1 0.000197 1560.000000 0.000745 0.002221 0.009268 +6479 1 0.000195 1560.000000 0.000880 0.001388 0.001943 +6480 1 0.000237 1560.000000 -0.002040 0.001792 0.004591 +6481 1 0.000248 1560.000000 -0.001391 0.001632 0.000166 +6482 1 0.000209 1560.000000 0.001942 -0.000280 0.001260 +6483 1 0.000254 1560.000000 0.002312 -0.000668 0.000614 +6484 1 0.000207 1560.000000 -0.002278 0.001175 0.005859 +6485 1 0.000228 1560.000000 0.000470 -0.001237 0.006502 +6486 1 0.000221 1560.000000 -0.001102 0.000656 0.002176 +6487 1 0.000273 1560.000000 -0.001393 -0.001520 0.007953 +6488 1 0.000276 1560.000000 0.002059 -0.001954 0.000150 +6489 1 0.000197 1560.000000 -0.002050 -0.000215 0.008874 +6490 1 0.000229 1560.000000 0.001063 0.001246 0.002156 +6491 1 0.000247 1560.000000 0.000779 -0.001553 0.000334 +6492 1 0.000242 1560.000000 0.002110 -0.001504 0.002488 +6493 1 0.000242 1560.000000 -0.002241 -0.001840 0.007737 +6494 1 0.000269 1560.000000 -0.001584 -0.001410 0.005469 +6495 1 0.000204 1560.000000 0.003584 -0.001130 0.007765 +6496 1 0.000206 1560.000000 -0.001915 0.000119 0.005433 +6497 1 0.000241 1560.000000 0.003196 0.001097 0.007410 +6498 1 0.000242 1560.000000 0.001254 0.000806 0.004728 +6499 1 0.000276 1560.000000 -0.002486 0.002572 0.005026 +6500 1 0.000208 1560.000000 0.002104 -0.001206 0.005700 +6501 1 0.000214 1560.000000 -0.002911 -0.002206 0.002070 +6502 1 0.000280 1560.000000 -0.003632 0.001070 0.006255 +6503 1 0.000266 1560.000000 0.002411 0.002547 0.000763 +6504 1 0.000207 1560.000000 0.003442 0.000124 0.003326 +6505 1 0.000246 1560.000000 -0.002823 -0.000680 0.000799 +6506 1 0.000278 1560.000000 0.003207 -0.001081 0.002148 +6507 1 0.000256 1560.000000 -0.002946 0.002475 0.005752 +6508 1 0.000255 1560.000000 -0.003330 -0.000472 0.000437 +6509 1 0.000286 1560.000000 -0.000044 0.001588 0.002565 +6510 1 0.000227 1560.000000 -0.000049 -0.002601 0.005478 +6511 1 0.000202 1560.000000 0.003361 0.001305 0.003746 +6512 1 0.000219 1560.000000 -0.001686 0.000327 0.006571 +6513 1 0.000199 1560.000000 0.000601 -0.001666 0.009324 +6514 1 0.000196 1560.000000 -0.000299 0.003480 0.004157 +6515 1 0.000241 1560.000000 0.001173 -0.000866 0.000282 +6516 1 0.000206 1560.000000 -0.000661 0.000490 0.003404 +6517 1 0.000214 1560.000000 -0.002189 -0.000505 0.003246 +6518 1 0.000225 1560.000000 -0.000806 0.000308 0.003000 +6519 1 0.000219 1560.000000 0.003756 -0.000425 0.003019 +6520 1 0.000275 1560.000000 -0.001821 -0.000864 0.000867 +6521 1 0.000250 1560.000000 -0.000632 -0.000671 0.001739 +6522 1 0.000254 1560.000000 0.001107 -0.001864 0.005057 +6523 1 0.000195 1560.000000 -0.000918 -0.000724 0.003015 +6524 1 0.000255 1560.000000 0.000935 0.001105 0.000324 +6525 1 0.000261 1560.000000 -0.002450 0.001569 0.000506 +6526 1 0.000230 1560.000000 0.002695 0.001167 0.009768 +6527 1 0.000229 1560.000000 0.000380 0.002435 0.007739 +6528 1 0.000219 1560.000000 0.002064 0.002563 0.004414 +6529 1 0.000217 1560.000000 0.001333 -0.000825 0.008771 +6530 1 0.000254 1560.000000 -0.002976 0.002306 0.000205 +6531 1 0.000194 1560.000000 -0.001898 -0.000953 0.009512 +6532 1 0.000238 1560.000000 0.000122 -0.000968 0.001058 +6533 1 0.000219 1560.000000 -0.003064 0.000697 0.002414 +6534 1 0.000276 1560.000000 0.003841 0.000286 0.000956 +6535 1 0.000218 1560.000000 -0.000498 -0.003703 0.004178 +6536 1 0.000248 1560.000000 -0.000483 -0.001630 0.000404 +6537 1 0.000273 1560.000000 0.000793 0.003618 0.009685 +6538 1 0.000287 1560.000000 -0.000755 0.001665 0.000655 +6539 1 0.000195 1560.000000 -0.003209 -0.001791 0.005956 +6540 1 0.000223 1560.000000 -0.002305 0.001256 0.000679 +6541 1 0.000220 1560.000000 0.000901 0.002963 0.007798 +6542 1 0.000273 1560.000000 0.000811 -0.002208 0.008916 +6543 1 0.000239 1560.000000 -0.000622 0.000625 0.004226 +6544 1 0.000194 1560.000000 -0.001993 0.002566 0.008532 +6545 1 0.000249 1560.000000 -0.001730 -0.000449 0.005617 +6546 1 0.000212 1560.000000 -0.002451 -0.001102 0.005435 +6547 1 0.000208 1560.000000 0.001148 0.001321 0.009611 +6548 1 0.000225 1560.000000 0.001321 -0.002244 0.004898 +6549 1 0.000248 1560.000000 -0.001422 0.002401 0.005468 +6550 1 0.000287 1560.000000 -0.001661 -0.003308 0.001045 +6551 1 0.000201 1560.000000 0.000994 0.002175 0.002929 +6552 1 0.000238 1560.000000 -0.002502 -0.000957 0.001443 +6553 1 0.000254 1560.000000 -0.000699 0.000071 0.006108 +6554 1 0.000232 1560.000000 -0.001506 -0.001880 0.006840 +6555 1 0.000255 1560.000000 -0.000694 -0.000451 0.003882 +6556 1 0.000231 1560.000000 -0.002681 -0.001239 0.008881 +6557 1 0.000223 1560.000000 0.001337 -0.003110 0.004283 +6558 1 0.000196 1560.000000 0.002752 -0.000862 0.000621 +6559 1 0.000224 1560.000000 -0.003743 0.000320 0.000417 +6560 1 0.000276 1560.000000 0.001844 -0.001540 0.002694 +6561 1 0.000278 1560.000000 -0.001798 -0.002188 0.004250 +6562 1 0.000231 1560.000000 -0.003731 -0.000458 0.009689 +6563 1 0.000207 1560.000000 0.002015 0.000463 0.004353 +6564 1 0.000270 1560.000000 0.000784 0.002693 0.006676 +6565 1 0.000282 1560.000000 0.001375 0.001292 0.009750 +6566 1 0.000260 1560.000000 -0.001130 -0.000189 0.000227 +6567 1 0.000238 1560.000000 -0.003156 0.001785 0.001045 +6568 1 0.000207 1560.000000 0.000456 -0.002976 0.004058 +6569 1 0.000209 1560.000000 0.001851 -0.001890 0.002283 +6570 1 0.000226 1560.000000 0.002885 -0.001729 0.004395 +6571 1 0.000228 1560.000000 -0.000856 0.002992 0.009482 +6572 1 0.000227 1560.000000 0.002363 0.001198 0.004828 +6573 1 0.000227 1560.000000 -0.001556 -0.002504 0.002799 +6574 1 0.000199 1560.000000 -0.002420 -0.000718 0.000514 +6575 1 0.000227 1560.000000 0.001291 0.003593 0.004556 +6576 1 0.000240 1560.000000 0.000990 0.001727 0.009349 +6577 1 0.000232 1560.000000 0.000352 0.003421 0.003452 +6578 1 0.000198 1560.000000 -0.003565 -0.000792 0.007796 +6579 1 0.000273 1560.000000 -0.002186 -0.001700 0.004343 +6580 1 0.000209 1560.000000 0.000990 -0.001315 0.004469 +6581 1 0.000259 1560.000000 0.001775 -0.000836 0.005434 +6582 1 0.000242 1560.000000 0.000673 0.001302 0.009464 +6583 1 0.000244 1560.000000 -0.000430 -0.002751 0.005446 +6584 1 0.000198 1560.000000 -0.002774 0.002085 0.004718 +6585 1 0.000212 1560.000000 -0.000871 -0.000332 0.003254 +6586 1 0.000240 1560.000000 0.003167 0.000350 0.009742 +6587 1 0.000260 1560.000000 0.001882 0.002733 0.006880 +6588 1 0.000264 1560.000000 -0.000890 -0.000882 0.009650 +6589 1 0.000280 1560.000000 0.002703 0.001006 0.005902 +6590 1 0.000228 1560.000000 0.001316 -0.001354 0.009811 +6591 1 0.000202 1560.000000 -0.001553 -0.000421 0.007224 +6592 1 0.000211 1560.000000 -0.000789 0.003700 0.008250 +6593 1 0.000220 1560.000000 -0.000622 0.002863 0.005753 +6594 1 0.000198 1560.000000 0.000055 -0.000673 0.001160 +6595 1 0.000197 1560.000000 -0.000912 -0.000746 0.001958 +6596 1 0.000206 1560.000000 -0.003166 0.000279 0.006506 +6597 1 0.000214 1560.000000 -0.001740 -0.002854 0.004241 +6598 1 0.000243 1560.000000 0.001019 -0.001110 0.007462 +6599 1 0.000208 1560.000000 0.003576 -0.000406 0.008346 +6600 1 0.000245 1560.000000 0.002071 -0.000869 0.002393 +6601 1 0.000214 1560.000000 -0.002812 0.001252 0.005525 +6602 1 0.000202 1560.000000 0.003055 -0.001807 0.005167 +6603 1 0.000227 1560.000000 0.000669 -0.001168 0.005371 +6604 1 0.000238 1560.000000 -0.002372 -0.000187 0.003722 +6605 1 0.000193 1560.000000 -0.000580 -0.001830 0.004518 +6606 1 0.000281 1560.000000 -0.000556 0.003482 0.004825 +6607 1 0.000271 1560.000000 -0.000131 -0.002260 0.009674 +6608 1 0.000225 1560.000000 0.002677 0.001028 0.004473 +6609 1 0.000193 1560.000000 -0.001083 -0.000215 0.004157 +6610 1 0.000203 1560.000000 -0.002879 -0.000816 0.007228 +6611 1 0.000228 1560.000000 0.002598 0.001416 0.003005 +6612 1 0.000193 1560.000000 -0.002028 0.001512 0.008816 +6613 1 0.000258 1560.000000 0.003350 -0.000309 0.008500 +6614 1 0.000194 1560.000000 0.002243 -0.000619 0.004987 +6615 1 0.000219 1560.000000 -0.000302 -0.001295 0.003622 +6616 1 0.000266 1560.000000 0.001342 -0.001022 0.007938 +6617 1 0.000205 1560.000000 0.000317 0.002222 0.001696 +6618 1 0.000209 1560.000000 0.002749 0.000924 0.003616 +6619 1 0.000258 1560.000000 -0.001687 -0.001864 0.004146 +6620 1 0.000195 1560.000000 -0.002451 0.001370 0.008594 +6621 1 0.000233 1560.000000 0.000328 0.001210 0.003188 +6622 1 0.000217 1560.000000 -0.001936 -0.003327 0.009665 +6623 1 0.000239 1560.000000 0.000462 -0.002167 0.001994 +6624 1 0.000211 1560.000000 -0.001794 0.001956 0.000885 +6625 1 0.000198 1560.000000 -0.001675 0.001819 0.009641 +6626 1 0.000202 1560.000000 -0.001775 -0.001563 0.006036 +6627 1 0.000204 1560.000000 0.003386 -0.000636 0.005066 +6628 1 0.000201 1560.000000 0.000024 0.001118 0.006469 +6629 1 0.000198 1560.000000 0.002314 0.001696 0.000286 +6630 1 0.000236 1560.000000 0.001444 -0.002829 0.008925 +6631 1 0.000238 1560.000000 0.000288 -0.001422 0.007540 +6632 1 0.000243 1560.000000 -0.002187 0.001893 0.005293 +6633 1 0.000284 1560.000000 -0.000864 -0.002013 0.009265 +6634 1 0.000277 1560.000000 -0.000350 0.002769 0.000914 +6635 1 0.000197 1560.000000 -0.001702 0.001518 0.001426 +6636 1 0.000204 1560.000000 0.002169 -0.001217 0.009549 +6637 1 0.000258 1560.000000 -0.000125 0.001801 0.001945 +6638 1 0.000244 1560.000000 -0.002695 -0.000086 0.003333 +6639 1 0.000217 1560.000000 -0.001727 0.003435 0.006037 +6640 1 0.000200 1560.000000 0.001369 -0.000100 0.000193 +6641 1 0.000229 1560.000000 0.000546 -0.003314 0.002633 +6642 1 0.000276 1560.000000 -0.001166 -0.002054 0.004563 +6643 1 0.000222 1560.000000 0.002457 -0.000271 0.003213 +6644 1 0.000221 1560.000000 -0.001677 -0.001857 0.007803 +6645 1 0.000226 1560.000000 -0.001341 -0.002459 0.004131 +6646 1 0.000258 1560.000000 -0.000697 -0.000126 0.001657 +6647 1 0.000204 1560.000000 -0.000535 0.001065 0.000468 +6648 1 0.000214 1560.000000 0.000624 -0.001131 0.007144 +6649 1 0.000214 1560.000000 -0.001385 0.003204 0.002340 +6650 1 0.000201 1560.000000 0.001564 0.002362 0.009758 +6651 1 0.000194 1560.000000 -0.000940 -0.000460 0.006922 +6652 1 0.000213 1560.000000 -0.000897 -0.000685 0.008628 +6653 1 0.000209 1560.000000 0.001214 0.000841 0.008539 +6654 1 0.000252 1560.000000 -0.000124 0.002314 0.007234 +6655 1 0.000195 1560.000000 0.002406 -0.000643 0.007403 +6656 1 0.000221 1560.000000 -0.002053 0.002075 0.004055 +6657 1 0.000263 1560.000000 0.001128 0.001526 0.008614 +6658 1 0.000215 1560.000000 -0.000758 0.001433 0.005101 +6659 1 0.000246 1560.000000 0.002739 -0.000535 0.009510 +6660 1 0.000199 1560.000000 -0.000159 -0.000777 0.005545 +6661 1 0.000264 1560.000000 0.001299 -0.003460 0.005998 +6662 1 0.000227 1560.000000 0.000206 0.000541 0.009759 +6663 1 0.000216 1560.000000 -0.000695 -0.002975 0.009120 +6664 1 0.000193 1560.000000 -0.000274 0.003139 0.002681 +6665 1 0.000197 1560.000000 -0.001714 0.001645 0.009370 +6666 1 0.000285 1560.000000 0.002135 0.001542 0.001988 +6667 1 0.000221 1560.000000 -0.002041 0.000828 0.002949 +6668 1 0.000200 1560.000000 0.000121 0.003390 0.008508 +6669 1 0.000222 1560.000000 -0.001133 0.001680 0.001956 +6670 1 0.000229 1560.000000 0.002106 -0.003214 0.004306 +6671 1 0.000256 1560.000000 0.001844 0.000538 0.008159 +6672 1 0.000270 1560.000000 0.001792 0.001726 0.003276 +6673 1 0.000205 1560.000000 -0.000846 -0.000317 0.001783 +6674 1 0.000237 1560.000000 -0.002184 -0.002590 0.004913 +6675 1 0.000241 1560.000000 0.001686 -0.000940 0.008248 +6676 1 0.000220 1560.000000 0.000534 -0.000497 0.000179 +6677 1 0.000248 1560.000000 -0.000550 0.001335 0.009167 +6678 1 0.000267 1560.000000 0.001791 -0.001668 0.000807 +6679 1 0.000207 1560.000000 0.001937 -0.000630 0.005697 +6680 1 0.000199 1560.000000 0.000156 0.000269 0.008385 +6681 1 0.000231 1560.000000 0.001775 0.002237 0.003330 +6682 1 0.000273 1560.000000 0.001180 -0.000890 0.002353 +6683 1 0.000222 1560.000000 -0.002111 -0.001055 0.008641 +6684 1 0.000212 1560.000000 -0.000188 0.002392 0.008018 +6685 1 0.000208 1560.000000 -0.002900 0.000551 0.000888 +6686 1 0.000194 1560.000000 0.001115 -0.002341 0.008993 +6687 1 0.000216 1560.000000 0.001434 0.000805 0.008014 +6688 1 0.000203 1560.000000 0.000351 -0.002169 0.007571 +6689 1 0.000201 1560.000000 0.002203 0.003070 0.008852 +6690 1 0.000285 1560.000000 0.001832 -0.000415 0.006032 +6691 1 0.000245 1560.000000 0.000909 0.001762 0.004290 +6692 1 0.000195 1560.000000 -0.001503 0.001124 0.005140 +6693 1 0.000212 1560.000000 -0.001132 0.001128 0.007183 +6694 1 0.000204 1560.000000 0.000532 0.002424 0.004130 +6695 1 0.000194 1560.000000 -0.002094 0.000146 0.003677 +6696 1 0.000227 1560.000000 -0.002530 0.000841 0.009611 +6697 1 0.000219 1560.000000 0.000437 0.000742 0.002445 +6698 1 0.000211 1560.000000 0.001210 0.000168 0.009497 +6699 1 0.000271 1560.000000 -0.001849 -0.001545 0.005476 +6700 1 0.000240 1560.000000 -0.001436 0.002112 0.004146 +6701 1 0.000208 1560.000000 0.000254 -0.002723 0.008562 +6702 1 0.000274 1560.000000 -0.000836 -0.003357 0.003850 +6703 1 0.000205 1560.000000 0.001699 0.001245 0.006175 +6704 1 0.000199 1560.000000 -0.002037 0.003093 0.004002 +6705 1 0.000222 1560.000000 0.000941 0.000751 0.003286 +6706 1 0.000212 1560.000000 -0.003156 0.001714 0.000171 +6707 1 0.000197 1560.000000 -0.000289 0.000351 0.003277 +6708 1 0.000255 1560.000000 -0.001038 -0.001867 0.006594 +6709 1 0.000285 1560.000000 -0.000431 0.000653 0.005634 +6710 1 0.000267 1560.000000 -0.000265 -0.002235 0.003966 +6711 1 0.000277 1560.000000 0.001955 0.001446 0.005373 +6712 1 0.000288 1560.000000 -0.000515 0.000429 0.004484 +6713 1 0.000204 1560.000000 -0.001016 0.000262 0.004160 +6714 1 0.000228 1560.000000 -0.000644 -0.002918 0.005367 +6715 1 0.000238 1560.000000 -0.000371 0.000269 0.002550 +6716 1 0.000217 1560.000000 -0.000867 -0.002424 0.009658 +6717 1 0.000212 1560.000000 -0.000257 -0.001113 0.002103 +6718 1 0.000275 1560.000000 -0.001385 -0.001174 0.005132 +6719 1 0.000271 1560.000000 0.001554 -0.000433 0.007520 +6720 1 0.000281 1560.000000 0.000735 0.002802 0.008204 +6721 1 0.000207 1560.000000 0.001846 0.002808 0.009630 +6722 1 0.000275 1560.000000 0.000218 -0.002860 0.002357 +6723 1 0.000237 1560.000000 -0.001883 0.002846 0.006886 +6724 1 0.000215 1560.000000 0.000344 -0.003702 0.006888 +6725 1 0.000196 1560.000000 -0.001631 0.000182 0.008251 +6726 1 0.000281 1560.000000 -0.000296 0.001189 0.003754 +6727 1 0.000283 1560.000000 -0.001308 -0.003592 0.009461 +6728 1 0.000198 1560.000000 0.000628 -0.000018 0.007730 +6729 1 0.000218 1560.000000 -0.001270 0.002471 0.002644 +6730 1 0.000229 1560.000000 0.003103 0.002266 0.009158 +6731 1 0.000222 1560.000000 0.003647 0.000058 0.006909 +6732 1 0.000233 1560.000000 -0.003517 0.000832 0.008135 +6733 1 0.000276 1560.000000 0.000262 -0.000101 0.008558 +6734 1 0.000193 1560.000000 0.001151 -0.002915 0.003572 +6735 1 0.000248 1560.000000 -0.000841 0.000269 0.005033 +6736 1 0.000282 1560.000000 0.000235 -0.002986 0.002748 +6737 1 0.000268 1560.000000 -0.002206 0.001689 0.002465 +6738 1 0.000217 1560.000000 -0.002810 0.000729 0.004006 +6739 1 0.000259 1560.000000 0.001054 -0.001093 0.006420 +6740 1 0.000193 1560.000000 0.000101 0.002562 0.007093 +6741 1 0.000227 1560.000000 -0.002133 0.001699 0.004787 +6742 1 0.000231 1560.000000 0.000318 -0.003171 0.007436 +6743 1 0.000255 1560.000000 0.002458 -0.000824 0.001442 +6744 1 0.000196 1560.000000 -0.002468 -0.001750 0.005228 +6745 1 0.000195 1560.000000 -0.000618 0.003094 0.007966 +6746 1 0.000217 1560.000000 0.000238 -0.002527 0.004160 +6747 1 0.000217 1560.000000 -0.003513 -0.000184 0.009518 +6748 1 0.000237 1560.000000 -0.002708 0.000505 0.003543 +6749 1 0.000286 1560.000000 -0.000606 -0.000576 0.004897 +6750 1 0.000204 1560.000000 -0.000566 0.003611 0.005145 +6751 1 0.000230 1560.000000 -0.001428 0.001406 0.003483 +6752 1 0.000264 1560.000000 0.000572 0.001138 0.006712 +6753 1 0.000224 1560.000000 -0.000260 0.002283 0.005960 +6754 1 0.000202 1560.000000 -0.000357 0.000523 0.006445 +6755 1 0.000195 1560.000000 0.001784 -0.000523 0.007479 +6756 1 0.000236 1560.000000 -0.000706 0.000535 0.009650 +6757 1 0.000213 1560.000000 0.001654 -0.002680 0.003974 +6758 1 0.000213 1560.000000 -0.000240 -0.001141 0.003915 +6759 1 0.000218 1560.000000 -0.000223 -0.003667 0.002455 +6760 1 0.000265 1560.000000 0.001593 0.003351 0.008939 +6761 1 0.000271 1560.000000 0.000755 -0.001360 0.006137 +6762 1 0.000245 1560.000000 -0.001072 -0.000780 0.006192 +6763 1 0.000194 1560.000000 0.002136 0.001089 0.008353 +6764 1 0.000264 1560.000000 -0.002138 0.000251 0.004757 +6765 1 0.000241 1560.000000 -0.003676 -0.001097 0.002431 +6766 1 0.000206 1560.000000 0.003449 -0.000610 0.004356 +6767 1 0.000210 1560.000000 -0.002029 0.002156 0.008914 +6768 1 0.000243 1560.000000 0.001972 0.001246 0.000334 +6769 1 0.000284 1560.000000 -0.001093 -0.000208 0.008365 +6770 1 0.000285 1560.000000 -0.001996 0.002370 0.001333 +6771 1 0.000271 1560.000000 -0.002287 0.001554 0.000168 +6772 1 0.000266 1560.000000 0.001341 -0.000164 0.008832 +6773 1 0.000225 1560.000000 -0.000015 0.000637 0.007392 +6774 1 0.000201 1560.000000 0.000820 0.002397 0.007644 +6775 1 0.000234 1560.000000 -0.001006 0.000918 0.008356 +6776 1 0.000194 1560.000000 -0.003705 -0.000382 0.001851 +6777 1 0.000280 1560.000000 0.001101 0.003348 0.004352 +6778 1 0.000206 1560.000000 -0.001179 -0.001517 0.007772 +6779 1 0.000196 1560.000000 -0.001367 0.003014 0.005769 +6780 1 0.000217 1560.000000 0.001527 -0.001450 0.005090 +6781 1 0.000194 1560.000000 0.000975 0.000259 0.008117 +6782 1 0.000286 1560.000000 0.002264 0.002084 0.008210 +6783 1 0.000284 1560.000000 -0.003401 -0.000306 0.002728 +6784 1 0.000252 1560.000000 0.001638 0.000795 0.003104 +6785 1 0.000216 1560.000000 0.000046 -0.003383 0.007691 +6786 1 0.000217 1560.000000 -0.001899 -0.001769 0.001908 +6787 1 0.000280 1560.000000 -0.003262 0.000198 0.001699 +6788 1 0.000212 1560.000000 -0.001237 -0.002980 0.006779 +6789 1 0.000200 1560.000000 0.002013 0.000017 0.006051 +6790 1 0.000201 1560.000000 -0.002582 -0.000836 0.003864 +6791 1 0.000227 1560.000000 -0.002468 -0.002378 0.009546 +6792 1 0.000272 1560.000000 0.000287 -0.003182 0.000325 +6793 1 0.000201 1560.000000 -0.000455 0.001885 0.008064 +6794 1 0.000218 1560.000000 0.000518 -0.002811 0.001214 +6795 1 0.000197 1560.000000 0.000621 0.000218 0.000987 +6796 1 0.000221 1560.000000 0.000498 0.002823 0.006587 +6797 1 0.000200 1560.000000 -0.000110 -0.000630 0.006078 +6798 1 0.000247 1560.000000 0.003570 -0.001022 0.006804 +6799 1 0.000249 1560.000000 -0.001765 0.002975 0.004523 +6800 1 0.000194 1560.000000 -0.002834 0.002010 0.006718 +6801 1 0.000240 1560.000000 0.001338 -0.001479 0.008615 +6802 1 0.000262 1560.000000 -0.000447 0.001452 0.005692 +6803 1 0.000193 1560.000000 -0.001892 -0.000316 0.005067 +6804 1 0.000206 1560.000000 -0.000525 -0.000100 0.000124 +6805 1 0.000256 1560.000000 -0.001532 -0.001611 0.005052 +6806 1 0.000286 1560.000000 0.001814 0.001525 0.001597 +6807 1 0.000261 1560.000000 -0.001435 0.000039 0.007403 +6808 1 0.000194 1560.000000 0.002981 0.001691 0.000595 +6809 1 0.000213 1560.000000 0.001449 -0.001952 0.002957 +6810 1 0.000216 1560.000000 -0.001390 0.000363 0.005190 +6811 1 0.000242 1560.000000 -0.001761 0.003293 0.008514 +6812 1 0.000205 1560.000000 -0.002777 0.002627 0.003502 +6813 1 0.000226 1560.000000 0.001421 -0.000964 0.001304 +6814 1 0.000231 1560.000000 0.000084 -0.001665 0.002534 +6815 1 0.000231 1560.000000 0.002039 -0.000860 0.003616 +6816 1 0.000282 1560.000000 0.001702 0.001020 0.006668 +6817 1 0.000199 1560.000000 0.001974 0.002747 0.003649 +6818 1 0.000240 1560.000000 0.000178 0.001494 0.005806 +6819 1 0.000220 1560.000000 -0.002509 -0.001871 0.004504 +6820 1 0.000228 1560.000000 -0.000870 0.000503 0.000141 +6821 1 0.000216 1560.000000 0.000092 0.000006 0.003348 +6822 1 0.000208 1560.000000 0.002996 0.002354 0.005046 +6823 1 0.000197 1560.000000 0.002342 -0.002959 0.003855 +6824 1 0.000194 1560.000000 0.002494 0.001802 0.007630 +6825 1 0.000215 1560.000000 -0.000087 -0.002867 0.005786 +6826 1 0.000209 1560.000000 0.002431 -0.000074 0.002863 +6827 1 0.000222 1560.000000 0.000072 -0.002386 0.007082 +6828 1 0.000224 1560.000000 -0.000461 -0.002453 0.009470 +6829 1 0.000271 1560.000000 -0.002335 -0.002426 0.003094 +6830 1 0.000246 1560.000000 0.000506 0.002532 0.004400 +6831 1 0.000212 1560.000000 0.001973 -0.001823 0.009044 +6832 1 0.000230 1560.000000 0.003752 0.000077 0.008022 +6833 1 0.000203 1560.000000 -0.001337 0.000584 0.003241 +6834 1 0.000210 1560.000000 0.001274 0.000095 0.000813 +6835 1 0.000225 1560.000000 0.002374 -0.002874 0.002227 +6836 1 0.000277 1560.000000 -0.002624 -0.002187 0.008781 +6837 1 0.000218 1560.000000 -0.002122 0.002340 0.006581 +6838 1 0.000266 1560.000000 -0.000393 -0.001779 0.003798 +6839 1 0.000204 1560.000000 -0.001554 0.002775 0.009037 +6840 1 0.000222 1560.000000 0.001958 0.001508 0.006040 +6841 1 0.000232 1560.000000 -0.001723 -0.000459 0.004623 +6842 1 0.000242 1560.000000 -0.000845 0.000441 0.006827 +6843 1 0.000276 1560.000000 0.000117 0.002238 0.001560 +6844 1 0.000273 1560.000000 0.002721 -0.001104 0.000972 +6845 1 0.000236 1560.000000 0.000309 -0.002576 0.002241 +6846 1 0.000206 1560.000000 0.000580 -0.001897 0.002271 +6847 1 0.000238 1560.000000 0.001211 0.001131 0.006375 +6848 1 0.000194 1560.000000 -0.002232 0.003131 0.003105 +6849 1 0.000225 1560.000000 0.000806 0.000611 0.006200 +6850 1 0.000241 1560.000000 -0.003233 -0.001274 0.004758 +6851 1 0.000198 1560.000000 -0.001919 0.000678 0.005100 +6852 1 0.000203 1560.000000 0.000100 0.000106 0.007471 +6853 1 0.000282 1560.000000 -0.000743 -0.003187 0.001209 +6854 1 0.000213 1560.000000 -0.000398 -0.002352 0.000448 +6855 1 0.000275 1560.000000 0.000170 0.001310 0.004550 +6856 1 0.000211 1560.000000 -0.002847 -0.000258 0.009209 +6857 1 0.000235 1560.000000 -0.002297 0.000695 0.000873 +6858 1 0.000194 1560.000000 0.000960 0.000042 0.002096 +6859 1 0.000238 1560.000000 -0.000428 0.003410 0.004453 +6860 1 0.000233 1560.000000 0.001336 0.001579 0.006733 +6861 1 0.000225 1560.000000 -0.000920 -0.003423 0.004339 +6862 1 0.000212 1560.000000 0.000176 0.000209 0.003232 +6863 1 0.000281 1560.000000 -0.000732 -0.002373 0.001659 +6864 1 0.000205 1560.000000 0.000387 0.003530 0.004384 +6865 1 0.000222 1560.000000 0.003049 0.000472 0.004193 +6866 1 0.000258 1560.000000 -0.001901 -0.001475 0.009703 +6867 1 0.000280 1560.000000 -0.000267 0.003726 0.004566 +6868 1 0.000212 1560.000000 -0.001590 -0.001899 0.005308 +6869 1 0.000226 1560.000000 0.000841 -0.002328 0.004698 +6870 1 0.000260 1560.000000 0.000591 -0.003559 0.007417 +6871 1 0.000220 1560.000000 -0.001373 0.003089 0.009563 +6872 1 0.000239 1560.000000 0.001295 0.002512 0.001298 +6873 1 0.000244 1560.000000 0.001600 -0.000432 0.000153 +6874 1 0.000256 1560.000000 -0.000775 0.000595 0.001464 +6875 1 0.000249 1560.000000 0.001133 0.000557 0.007777 +6876 1 0.000265 1560.000000 -0.001684 -0.003447 0.004648 +6877 1 0.000210 1560.000000 0.000633 0.001286 0.008406 +6878 1 0.000197 1560.000000 -0.000110 -0.000585 0.001986 +6879 1 0.000236 1560.000000 0.003273 -0.001303 0.008225 +6880 1 0.000268 1560.000000 0.000636 0.000468 0.001377 +6881 1 0.000215 1560.000000 0.000557 -0.001215 0.006871 +6882 1 0.000224 1560.000000 -0.001803 0.000397 0.002312 +6883 1 0.000231 1560.000000 -0.001101 -0.000316 0.004979 +6884 1 0.000199 1560.000000 0.002616 0.002557 0.003080 +6885 1 0.000258 1560.000000 0.002363 -0.000352 0.007158 +6886 1 0.000214 1560.000000 0.000654 -0.000893 0.002598 +6887 1 0.000194 1560.000000 0.000052 0.000386 0.005706 +6888 1 0.000234 1560.000000 0.002493 0.001987 0.004160 +6889 1 0.000197 1560.000000 0.000459 -0.000124 0.002806 +6890 1 0.000197 1560.000000 0.001648 0.003346 0.004607 +6891 1 0.000212 1560.000000 0.001127 -0.002588 0.008883 +6892 1 0.000259 1560.000000 0.003105 -0.001518 0.006029 +6893 1 0.000196 1560.000000 -0.000663 0.003025 0.003477 +6894 1 0.000205 1560.000000 -0.001489 0.001803 0.008171 +6895 1 0.000250 1560.000000 -0.003670 0.000516 0.002024 +6896 1 0.000233 1560.000000 -0.001395 0.002505 0.005152 +6897 1 0.000233 1560.000000 0.000528 0.002230 0.004936 +6898 1 0.000214 1560.000000 0.000883 -0.002447 0.000947 +6899 1 0.000226 1560.000000 0.001448 0.000689 0.004640 +6900 1 0.000239 1560.000000 0.003324 0.001122 0.000971 +6901 1 0.000282 1560.000000 -0.002275 -0.002371 0.001685 +6902 1 0.000227 1560.000000 -0.002083 -0.000974 0.003728 +6903 1 0.000263 1560.000000 -0.000816 -0.000159 0.001205 +6904 1 0.000268 1560.000000 -0.000860 0.002699 0.006554 +6905 1 0.000221 1560.000000 -0.002794 -0.001508 0.009777 +6906 1 0.000195 1560.000000 0.001862 -0.001992 0.008634 +6907 1 0.000243 1560.000000 -0.003139 0.000689 0.003116 +6908 1 0.000268 1560.000000 0.000402 -0.000697 0.007835 +6909 1 0.000266 1560.000000 -0.002582 0.002740 0.001296 +6910 1 0.000202 1560.000000 -0.002274 -0.000026 0.004690 +6911 1 0.000209 1560.000000 -0.002769 -0.002496 0.007668 +6912 1 0.000265 1560.000000 -0.000793 0.001050 0.001261 +6913 1 0.000267 1560.000000 -0.001995 0.001478 0.006690 +6914 1 0.000271 1560.000000 0.002647 0.002190 0.004340 +6915 1 0.000276 1560.000000 -0.003274 -0.002022 0.000731 +6916 1 0.000271 1560.000000 0.002454 0.000809 0.007791 +6917 1 0.000271 1560.000000 0.000772 -0.002235 0.002882 +6918 1 0.000252 1560.000000 0.002371 -0.001869 0.007194 +6919 1 0.000211 1560.000000 -0.003633 -0.000978 0.009210 +6920 1 0.000253 1560.000000 0.001944 0.001088 0.001243 +6921 1 0.000207 1560.000000 0.000736 -0.001900 0.007362 +6922 1 0.000215 1560.000000 -0.000235 0.001505 0.001867 +6923 1 0.000209 1560.000000 -0.001619 -0.001378 0.008874 +6924 1 0.000207 1560.000000 0.002255 -0.001103 0.001274 +6925 1 0.000252 1560.000000 0.000900 -0.001926 0.003810 +6926 1 0.000220 1560.000000 0.001786 -0.002324 0.003408 +6927 1 0.000224 1560.000000 0.002294 -0.001135 0.005358 +6928 1 0.000212 1560.000000 -0.001505 -0.000509 0.001585 +6929 1 0.000203 1560.000000 0.001805 -0.000690 0.008423 +6930 1 0.000227 1560.000000 0.001709 -0.003141 0.006961 +6931 1 0.000240 1560.000000 0.000348 0.001071 0.002918 +6932 1 0.000217 1560.000000 -0.002706 -0.002503 0.001316 +6933 1 0.000251 1560.000000 -0.000564 -0.001592 0.002849 +6934 1 0.000250 1560.000000 0.001936 -0.002021 0.008300 +6935 1 0.000214 1560.000000 -0.000758 -0.001887 0.003220 +6936 1 0.000264 1560.000000 -0.002221 -0.001456 0.008441 +6937 1 0.000201 1560.000000 -0.000935 -0.001380 0.002968 +6938 1 0.000240 1560.000000 0.001759 -0.000470 0.004139 +6939 1 0.000219 1560.000000 0.000293 0.000259 0.002063 +6940 1 0.000216 1560.000000 -0.002296 0.000983 0.004942 +6941 1 0.000204 1560.000000 -0.001592 0.000073 0.007738 +6942 1 0.000262 1560.000000 -0.000768 -0.002953 0.004292 +6943 1 0.000204 1560.000000 -0.000113 -0.002344 0.002885 +6944 1 0.000265 1560.000000 0.000092 0.002705 0.000864 +6945 1 0.000197 1560.000000 0.000442 -0.000874 0.001702 +6946 1 0.000196 1560.000000 -0.002634 0.001895 0.001931 +6947 1 0.000225 1560.000000 0.001018 -0.000048 0.009679 +6948 1 0.000268 1560.000000 0.002799 0.001980 0.000635 +6949 1 0.000269 1560.000000 0.000682 0.003781 0.002863 +6950 1 0.000222 1560.000000 0.002029 -0.001284 0.005216 +6951 1 0.000209 1560.000000 0.001127 -0.003499 0.000736 +6952 1 0.000214 1560.000000 0.002835 0.001311 0.005848 +6953 1 0.000215 1560.000000 0.000638 -0.000295 0.002284 +6954 1 0.000214 1560.000000 -0.000504 -0.000324 0.001254 +6955 1 0.000252 1560.000000 -0.003778 -0.000532 0.006384 +6956 1 0.000192 1560.000000 0.000487 -0.001459 0.009366 +6957 1 0.000231 1560.000000 -0.000928 -0.002798 0.009793 +6958 1 0.000192 1560.000000 0.002239 0.001908 0.003883 +6959 1 0.000195 1560.000000 -0.000323 0.000932 0.006269 +6960 1 0.000285 1560.000000 -0.000864 0.000855 0.002477 +6961 1 0.000270 1560.000000 -0.000498 0.003092 0.009127 +6962 1 0.000213 1560.000000 0.002392 0.000917 0.000678 +6963 1 0.000246 1560.000000 -0.000976 -0.001046 0.006471 +6964 1 0.000244 1560.000000 0.000759 0.003308 0.005185 +6965 1 0.000232 1560.000000 0.000758 0.003152 0.005886 +6966 1 0.000202 1560.000000 -0.000770 -0.002229 0.002622 +6967 1 0.000209 1560.000000 0.002760 -0.000870 0.008000 +6968 1 0.000193 1560.000000 0.000922 0.002412 0.002494 +6969 1 0.000255 1560.000000 0.001615 -0.000491 0.005136 +6970 1 0.000262 1560.000000 -0.000406 -0.001927 0.000318 +6971 1 0.000252 1560.000000 0.002290 0.001262 0.002545 +6972 1 0.000196 1560.000000 -0.000801 0.000238 0.001037 +6973 1 0.000270 1560.000000 0.000653 -0.001472 0.006465 +6974 1 0.000241 1560.000000 -0.003213 -0.000318 0.007291 +6975 1 0.000253 1560.000000 0.001352 -0.002419 0.007480 +6976 1 0.000200 1560.000000 -0.000355 0.001197 0.004473 +6977 1 0.000196 1560.000000 0.002212 -0.001714 0.002178 +6978 1 0.000274 1560.000000 0.002712 -0.002476 0.006170 +6979 1 0.000225 1560.000000 0.000856 0.003548 0.007980 +6980 1 0.000210 1560.000000 -0.002510 0.000664 0.004449 +6981 1 0.000269 1560.000000 -0.000564 -0.001110 0.003899 +6982 1 0.000203 1560.000000 0.000465 -0.003144 0.000628 +6983 1 0.000201 1560.000000 0.000732 -0.001712 0.004930 +6984 1 0.000231 1560.000000 -0.001989 -0.002256 0.002993 +6985 1 0.000201 1560.000000 0.003071 0.002224 0.007797 +6986 1 0.000195 1560.000000 -0.001475 0.000949 0.005252 +6987 1 0.000199 1560.000000 0.002340 -0.001736 0.001355 +6988 1 0.000208 1560.000000 0.000991 -0.002539 0.003904 +6989 1 0.000246 1560.000000 0.001326 0.000319 0.005162 +6990 1 0.000244 1560.000000 0.002167 0.000248 0.006384 +6991 1 0.000259 1560.000000 -0.001067 -0.002515 0.002452 +6992 1 0.000197 1560.000000 0.001100 0.000211 0.000207 +6993 1 0.000217 1560.000000 0.000831 0.002517 0.002172 +6994 1 0.000242 1560.000000 0.001442 0.003219 0.006695 +6995 1 0.000209 1560.000000 -0.002686 0.000678 0.007137 +6996 1 0.000268 1560.000000 -0.002347 0.000374 0.006147 +6997 1 0.000232 1560.000000 -0.001653 0.001589 0.008429 +6998 1 0.000220 1560.000000 -0.003430 -0.000660 0.005742 +6999 1 0.000197 1560.000000 -0.000173 0.000134 0.004782 +7000 1 0.000206 1560.000000 -0.002293 0.002316 0.003875 +7001 1 0.000208 1560.000000 -0.000431 0.002266 0.006232 +7002 1 0.000221 1560.000000 -0.000091 -0.001145 0.006058 +7003 1 0.000228 1560.000000 -0.003289 -0.000811 0.009098 +7004 1 0.000225 1560.000000 0.002930 -0.000127 0.000253 +7005 1 0.000221 1560.000000 0.003418 0.000511 0.005704 +7006 1 0.000218 1560.000000 0.001620 -0.003174 0.009179 +7007 1 0.000193 1560.000000 -0.000562 0.001670 0.001824 +7008 1 0.000206 1560.000000 0.000311 0.001049 0.009360 +7009 1 0.000250 1560.000000 -0.001516 0.002111 0.003437 +7010 1 0.000244 1560.000000 0.000226 -0.001652 0.000639 +7011 1 0.000250 1560.000000 -0.002453 0.001190 0.009123 +7012 1 0.000281 1560.000000 -0.002002 -0.002496 0.001009 +7013 1 0.000258 1560.000000 -0.000954 0.000845 0.009628 +7014 1 0.000270 1560.000000 -0.003448 -0.001093 0.008344 +7015 1 0.000247 1560.000000 0.001471 -0.001596 0.000623 +7016 1 0.000222 1560.000000 0.000033 0.000475 0.004705 +7017 1 0.000230 1560.000000 0.002978 -0.001497 0.004800 +7018 1 0.000201 1560.000000 -0.001724 -0.001065 0.004221 +7019 1 0.000283 1560.000000 0.002407 0.002377 0.005507 +7020 1 0.000195 1560.000000 -0.003765 0.000804 0.002003 +7021 1 0.000287 1560.000000 -0.002218 -0.000417 0.003615 +7022 1 0.000203 1560.000000 0.000469 -0.000022 0.006393 +7023 1 0.000244 1560.000000 -0.003034 0.001253 0.005458 +7024 1 0.000266 1560.000000 0.003213 -0.000786 0.009689 +7025 1 0.000238 1560.000000 -0.002999 0.000698 0.006388 +7026 1 0.000192 1560.000000 -0.002023 0.001568 0.006398 +7027 1 0.000235 1560.000000 0.002387 0.002854 0.003201 +7028 1 0.000264 1560.000000 -0.002356 0.000959 0.007267 +7029 1 0.000235 1560.000000 0.002965 0.002346 0.001699 +7030 1 0.000196 1560.000000 -0.002900 -0.000461 0.003009 +7031 1 0.000285 1560.000000 -0.003576 -0.001024 0.009851 +7032 1 0.000268 1560.000000 -0.003275 -0.001320 0.001729 +7033 1 0.000258 1560.000000 -0.002373 0.001054 0.005492 +7034 1 0.000198 1560.000000 -0.001606 -0.000446 0.004842 +7035 1 0.000206 1560.000000 0.001317 0.000239 0.006239 +7036 1 0.000281 1560.000000 0.000297 -0.002919 0.001333 +7037 1 0.000212 1560.000000 -0.000612 -0.000327 0.008585 +7038 1 0.000199 1560.000000 0.000530 -0.002556 0.006462 +7039 1 0.000231 1560.000000 -0.002153 0.000616 0.002550 +7040 1 0.000213 1560.000000 0.000294 0.001304 0.005309 +7041 1 0.000202 1560.000000 -0.000491 0.002678 0.007449 +7042 1 0.000275 1560.000000 0.001297 -0.002771 0.005502 +7043 1 0.000213 1560.000000 -0.003094 -0.001398 0.009429 +7044 1 0.000256 1560.000000 0.001139 -0.000249 0.001385 +7045 1 0.000202 1560.000000 0.000631 0.000866 0.001837 +7046 1 0.000234 1560.000000 0.000385 0.003595 0.001032 +7047 1 0.000195 1560.000000 0.000681 0.001141 0.000514 +7048 1 0.000237 1560.000000 -0.000506 0.001326 0.005220 +7049 1 0.000195 1560.000000 -0.001220 0.002014 0.006028 +7050 1 0.000201 1560.000000 0.000470 0.002036 0.003433 +7051 1 0.000225 1560.000000 0.001483 0.002207 0.008889 +7052 1 0.000250 1560.000000 -0.003099 -0.001559 0.005446 +7053 1 0.000210 1560.000000 -0.002519 -0.002770 0.007010 +7054 1 0.000220 1560.000000 -0.002062 -0.000891 0.000462 +7055 1 0.000217 1560.000000 0.002348 0.001369 0.001081 +7056 1 0.000258 1560.000000 -0.003346 -0.000560 0.006961 +7057 1 0.000203 1560.000000 -0.000287 -0.000520 0.003558 +7058 1 0.000206 1560.000000 0.002818 0.001206 0.009265 +7059 1 0.000215 1560.000000 0.000730 -0.000999 0.002414 +7060 1 0.000243 1560.000000 -0.000722 0.000328 0.006536 +7061 1 0.000203 1560.000000 -0.003752 0.000233 0.007617 +7062 1 0.000216 1560.000000 -0.001967 0.002669 0.007292 +7063 1 0.000198 1560.000000 0.000760 -0.001120 0.000779 +7064 1 0.000200 1560.000000 -0.002104 -0.001360 0.007417 +7065 1 0.000284 1560.000000 0.003431 -0.000941 0.000208 +7066 1 0.000203 1560.000000 -0.000774 0.002647 0.002397 +7067 1 0.000201 1560.000000 0.000376 -0.000519 0.005689 +7068 1 0.000264 1560.000000 0.000208 0.003272 0.007315 +7069 1 0.000203 1560.000000 -0.001324 0.002126 0.004804 +7070 1 0.000282 1560.000000 0.001926 0.002180 0.001915 +7071 1 0.000225 1560.000000 0.001094 0.003622 0.004182 +7072 1 0.000214 1560.000000 -0.001482 0.003508 0.009471 +7073 1 0.000238 1560.000000 0.003486 0.001353 0.001011 +7074 1 0.000211 1560.000000 0.000544 -0.000753 0.004407 +7075 1 0.000209 1560.000000 -0.001192 -0.003296 0.001563 +7076 1 0.000268 1560.000000 0.001711 -0.001971 0.003481 +7077 1 0.000258 1560.000000 -0.000981 -0.002990 0.008271 +7078 1 0.000232 1560.000000 0.002782 -0.001895 0.005286 +7079 1 0.000235 1560.000000 0.001876 -0.002214 0.000816 +7080 1 0.000239 1560.000000 -0.002805 -0.002469 0.007170 +7081 1 0.000220 1560.000000 0.001652 -0.000502 0.007852 +7082 1 0.000219 1560.000000 -0.002131 -0.000211 0.001797 +7083 1 0.000225 1560.000000 -0.001575 0.003089 0.006403 +7084 1 0.000200 1560.000000 0.000634 0.003179 0.009723 +7085 1 0.000199 1560.000000 0.001067 -0.001338 0.002140 +7086 1 0.000230 1560.000000 -0.002992 -0.001908 0.000469 +7087 1 0.000247 1560.000000 0.002207 0.003112 0.005438 +7088 1 0.000254 1560.000000 0.001180 0.003339 0.000442 +7089 1 0.000272 1560.000000 -0.000922 -0.002537 0.002973 +7090 1 0.000257 1560.000000 -0.003542 -0.000532 0.002787 +7091 1 0.000221 1560.000000 -0.002682 0.001897 0.003951 +7092 1 0.000229 1560.000000 0.001969 0.001812 0.000259 +7093 1 0.000195 1560.000000 0.000284 -0.000142 0.008166 +7094 1 0.000260 1560.000000 0.000408 -0.002626 0.002904 +7095 1 0.000214 1560.000000 -0.003366 0.001832 0.006367 +7096 1 0.000221 1560.000000 -0.002527 0.001663 0.008288 +7097 1 0.000258 1560.000000 0.002958 -0.000223 0.000714 +7098 1 0.000221 1560.000000 0.001940 0.000736 0.004103 +7099 1 0.000199 1560.000000 0.002630 0.000603 0.006410 +7100 1 0.000211 1560.000000 -0.002315 0.001091 0.008062 +7101 1 0.000223 1560.000000 0.000231 0.001130 0.005911 +7102 1 0.000205 1560.000000 -0.002166 0.000592 0.002981 +7103 1 0.000248 1560.000000 0.000671 0.001704 0.006390 +7104 1 0.000197 1560.000000 -0.001338 0.000761 0.005070 +7105 1 0.000257 1560.000000 0.002330 -0.002653 0.000425 +7106 1 0.000271 1560.000000 0.000961 -0.003248 0.008588 +7107 1 0.000258 1560.000000 0.001625 -0.000495 0.001068 +7108 1 0.000233 1560.000000 0.001584 0.000903 0.001809 +7109 1 0.000255 1560.000000 0.000850 0.003634 0.003695 +7110 1 0.000230 1560.000000 0.001210 -0.000375 0.007752 +7111 1 0.000198 1560.000000 0.000296 0.000737 0.002117 +7112 1 0.000244 1560.000000 0.002494 -0.000762 0.009766 +7113 1 0.000250 1560.000000 -0.002530 -0.001249 0.008072 +7114 1 0.000263 1560.000000 0.003011 -0.002237 0.003325 +7115 1 0.000264 1560.000000 0.001024 -0.000756 0.003746 +7116 1 0.000258 1560.000000 0.001312 0.001776 0.009396 +7117 1 0.000209 1560.000000 -0.003073 0.000715 0.001670 +7118 1 0.000197 1560.000000 0.000816 0.000189 0.003699 +7119 1 0.000224 1560.000000 -0.002144 -0.000308 0.005737 +7120 1 0.000203 1560.000000 -0.000603 -0.000022 0.001962 +7121 1 0.000247 1560.000000 -0.001386 -0.001978 0.002284 +7122 1 0.000194 1560.000000 0.001146 -0.000029 0.003622 +7123 1 0.000198 1560.000000 0.001760 -0.001993 0.002637 +7124 1 0.000244 1560.000000 -0.000615 0.003377 0.006988 +7125 1 0.000225 1560.000000 -0.001791 0.001125 0.005406 +7126 1 0.000204 1560.000000 -0.000012 -0.000692 0.000704 +7127 1 0.000288 1560.000000 0.003492 0.000979 0.006278 +7128 1 0.000254 1560.000000 -0.001613 0.001676 0.003162 +7129 1 0.000215 1560.000000 0.001868 0.000489 0.007874 +7130 1 0.000257 1560.000000 0.001654 -0.001560 0.004801 +7131 1 0.000197 1560.000000 -0.000761 0.000656 0.000692 +7132 1 0.000208 1560.000000 0.000723 0.001833 0.008937 +7133 1 0.000284 1560.000000 0.002450 -0.002363 0.002299 +7134 1 0.000193 1560.000000 0.000814 -0.000261 0.007929 +7135 1 0.000201 1560.000000 0.000813 0.002196 0.008671 +7136 1 0.000216 1560.000000 0.000139 0.001301 0.004236 +7137 1 0.000281 1560.000000 0.000574 -0.003050 0.009742 +7138 1 0.000211 1560.000000 0.002589 -0.000399 0.006073 +7139 1 0.000244 1560.000000 -0.001226 0.000794 0.004801 +7140 1 0.000259 1560.000000 0.001103 0.002235 0.009768 +7141 1 0.000215 1560.000000 0.000422 -0.003479 0.000669 +7142 1 0.000282 1560.000000 0.002376 -0.002639 0.008600 +7143 1 0.000204 1560.000000 -0.001947 -0.001935 0.006332 +7144 1 0.000251 1560.000000 0.002701 0.001294 0.001021 +7145 1 0.000225 1560.000000 0.000884 -0.002205 0.001343 +7146 1 0.000235 1560.000000 0.002445 -0.002205 0.005277 +7147 1 0.000241 1560.000000 -0.002507 0.000209 0.001116 +7148 1 0.000201 1560.000000 0.000768 -0.000129 0.003190 +7149 1 0.000260 1560.000000 0.002289 0.002919 0.007827 +7150 1 0.000235 1560.000000 0.000128 -0.001223 0.002887 +7151 1 0.000235 1560.000000 0.002551 0.002830 0.005326 +7152 1 0.000211 1560.000000 -0.002629 0.000909 0.002332 +7153 1 0.000231 1560.000000 0.001990 0.002500 0.002171 +7154 1 0.000240 1560.000000 0.000672 0.001649 0.009295 +7155 1 0.000227 1560.000000 -0.000005 -0.000658 0.008847 +7156 1 0.000229 1560.000000 0.003034 -0.001386 0.009043 +7157 1 0.000193 1560.000000 -0.001151 0.000138 0.006052 +7158 1 0.000288 1560.000000 0.001227 0.001278 0.008754 +7159 1 0.000269 1560.000000 -0.000339 -0.003634 0.005958 +7160 1 0.000255 1560.000000 -0.000166 -0.000317 0.003550 +7161 1 0.000262 1560.000000 -0.001629 -0.003266 0.006938 +7162 1 0.000198 1560.000000 0.001060 0.002142 0.006900 +7163 1 0.000200 1560.000000 0.002777 -0.002358 0.009132 +7164 1 0.000278 1560.000000 -0.002057 0.002552 0.004767 +7165 1 0.000205 1560.000000 0.002408 -0.000270 0.002582 +7166 1 0.000221 1560.000000 0.001031 0.001633 0.007781 +7167 1 0.000243 1560.000000 0.003038 0.000067 0.004598 +7168 1 0.000261 1560.000000 -0.001949 0.000470 0.001108 +7169 1 0.000236 1560.000000 0.001461 0.000248 0.000346 +7170 1 0.000193 1560.000000 0.000889 0.003617 0.007414 +7171 1 0.000276 1560.000000 0.002739 0.000748 0.009556 +7172 1 0.000212 1560.000000 -0.002922 0.000122 0.007603 +7173 1 0.000211 1560.000000 -0.002726 -0.001895 0.006163 +7174 1 0.000252 1560.000000 -0.001051 -0.003000 0.004546 +7175 1 0.000259 1560.000000 -0.000332 0.002754 0.003802 +7176 1 0.000274 1560.000000 -0.001006 0.000036 0.003672 +7177 1 0.000239 1560.000000 0.001349 -0.001990 0.000395 +7178 1 0.000197 1560.000000 0.002027 -0.002502 0.000108 +7179 1 0.000239 1560.000000 -0.000704 0.002721 0.002093 +7180 1 0.000274 1560.000000 -0.000656 -0.002518 0.005067 +7181 1 0.000219 1560.000000 -0.000551 0.003686 0.004141 +7182 1 0.000258 1560.000000 -0.001737 0.001482 0.001911 +7183 1 0.000235 1560.000000 0.000789 0.000397 0.008149 +7184 1 0.000234 1560.000000 0.000387 -0.002338 0.004519 +7185 1 0.000214 1560.000000 -0.001673 0.003168 0.002999 +7186 1 0.000277 1560.000000 0.001803 -0.002263 0.001370 +7187 1 0.000223 1560.000000 0.002365 0.002882 0.008907 +7188 1 0.000193 1560.000000 0.000117 -0.003380 0.004820 +7189 1 0.000229 1560.000000 -0.000672 -0.002632 0.003000 +7190 1 0.000271 1560.000000 0.001737 0.001925 0.000416 +7191 1 0.000207 1560.000000 0.003163 -0.002025 0.001177 +7192 1 0.000273 1560.000000 0.001181 0.000692 0.007046 +7193 1 0.000237 1560.000000 0.003251 0.001755 0.005433 +7194 1 0.000193 1560.000000 0.002508 -0.000514 0.001326 +7195 1 0.000257 1560.000000 -0.000923 0.002035 0.007089 +7196 1 0.000202 1560.000000 -0.002041 -0.002007 0.002879 +7197 1 0.000227 1560.000000 0.000113 -0.000279 0.009021 +7198 1 0.000278 1560.000000 -0.001194 0.000003 0.009696 +7199 1 0.000270 1560.000000 -0.000733 0.000025 0.002940 +7200 1 0.000257 1560.000000 0.003329 0.001500 0.008113 +7201 1 0.000205 1560.000000 -0.001237 0.002396 0.008190 +7202 1 0.000262 1560.000000 -0.001553 0.000591 0.007769 +7203 1 0.000240 1560.000000 0.000492 -0.002150 0.003575 +7204 1 0.000210 1560.000000 -0.000697 0.003450 0.006765 +7205 1 0.000195 1560.000000 0.002759 -0.001871 0.008074 +7206 1 0.000247 1560.000000 -0.001019 0.001454 0.007744 +7207 1 0.000284 1560.000000 -0.000485 -0.003717 0.007645 +7208 1 0.000214 1560.000000 -0.002629 -0.000262 0.002113 +7209 1 0.000224 1560.000000 -0.002582 0.001438 0.001339 +7210 1 0.000221 1560.000000 0.001187 -0.001609 0.005343 +7211 1 0.000251 1560.000000 -0.003245 0.001190 0.003648 +7212 1 0.000194 1560.000000 0.000443 -0.001939 0.002532 +7213 1 0.000195 1560.000000 0.001861 -0.002060 0.007735 +7214 1 0.000195 1560.000000 0.002802 -0.001386 0.004986 +7215 1 0.000222 1560.000000 0.001618 -0.002628 0.003333 +7216 1 0.000228 1560.000000 0.000538 -0.002385 0.004883 +7217 1 0.000278 1560.000000 -0.000514 0.000380 0.002890 +7218 1 0.000279 1560.000000 -0.001477 0.003292 0.003086 +7219 1 0.000222 1560.000000 0.001454 -0.000593 0.008645 +7220 1 0.000257 1560.000000 -0.001126 0.003503 0.009466 +7221 1 0.000230 1560.000000 -0.003000 -0.001657 0.001235 +7222 1 0.000230 1560.000000 -0.000115 -0.003312 0.006491 +7223 1 0.000232 1560.000000 0.001606 -0.001747 0.001284 +7224 1 0.000206 1560.000000 0.001017 0.000237 0.007688 +7225 1 0.000278 1560.000000 0.000551 -0.003548 0.004784 +7226 1 0.000218 1560.000000 0.000258 0.001549 0.001446 +7227 1 0.000204 1560.000000 -0.000765 -0.000505 0.003178 +7228 1 0.000244 1560.000000 -0.001139 0.000615 0.001359 +7229 1 0.000194 1560.000000 -0.001593 -0.000519 0.009386 +7230 1 0.000247 1560.000000 0.000080 0.000569 0.000509 +7231 1 0.000217 1560.000000 0.001535 0.000707 0.009665 +7232 1 0.000239 1560.000000 0.000272 -0.001543 0.008037 +7233 1 0.000269 1560.000000 0.002458 -0.000438 0.004850 +7234 1 0.000288 1560.000000 0.001860 0.002068 0.003812 +7235 1 0.000201 1560.000000 -0.000422 -0.002450 0.006383 +7236 1 0.000208 1560.000000 0.003269 0.001502 0.005111 +7237 1 0.000275 1560.000000 -0.002461 -0.002550 0.009168 +7238 1 0.000205 1560.000000 0.000605 -0.003805 0.003175 +7239 1 0.000233 1560.000000 -0.002098 -0.002193 0.009502 +7240 1 0.000228 1560.000000 -0.003095 0.001681 0.009416 +7241 1 0.000225 1560.000000 -0.001365 0.000112 0.006332 +7242 1 0.000251 1560.000000 -0.000746 0.000583 0.008498 +7243 1 0.000271 1560.000000 0.000510 -0.001662 0.007018 +7244 1 0.000209 1560.000000 0.001117 0.001268 0.008979 +7245 1 0.000283 1560.000000 -0.001955 0.002320 0.000466 +7246 1 0.000250 1560.000000 0.000225 0.003609 0.001716 +7247 1 0.000244 1560.000000 -0.001615 -0.003401 0.006678 +7248 1 0.000195 1560.000000 0.000113 -0.003386 0.000656 +7249 1 0.000280 1560.000000 -0.001480 0.000090 0.001227 +7250 1 0.000205 1560.000000 0.003076 -0.001727 0.001364 +7251 1 0.000225 1560.000000 0.003357 -0.000450 0.005317 +7252 1 0.000209 1560.000000 -0.002523 0.002357 0.004325 +7253 1 0.000203 1560.000000 0.001082 -0.002748 0.004130 +7254 1 0.000241 1560.000000 0.002766 0.001283 0.007029 +7255 1 0.000250 1560.000000 0.001840 0.001246 0.005159 +7256 1 0.000208 1560.000000 0.000908 -0.001811 0.000743 +7257 1 0.000213 1560.000000 0.001129 0.001756 0.001012 +7258 1 0.000265 1560.000000 -0.000673 0.002506 0.001648 +7259 1 0.000196 1560.000000 0.002928 0.001335 0.005135 +7260 1 0.000256 1560.000000 0.000644 0.001618 0.002809 +7261 1 0.000199 1560.000000 -0.002136 0.002237 0.005655 +7262 1 0.000275 1560.000000 -0.001073 0.002025 0.004600 +7263 1 0.000197 1560.000000 0.001353 0.000322 0.009561 +7264 1 0.000197 1560.000000 0.000695 -0.000005 0.005718 +7265 1 0.000227 1560.000000 -0.000050 -0.002240 0.006882 +7266 1 0.000233 1560.000000 0.002564 0.000613 0.001946 +7267 1 0.000243 1560.000000 0.000148 -0.000635 0.000146 +7268 1 0.000193 1560.000000 0.000134 0.001352 0.006493 +7269 1 0.000230 1560.000000 -0.003128 0.000268 0.000485 +7270 1 0.000216 1560.000000 -0.001564 -0.003417 0.000147 +7271 1 0.000197 1560.000000 0.000253 0.000006 0.002202 +7272 1 0.000243 1560.000000 0.001388 -0.000542 0.003066 +7273 1 0.000222 1560.000000 0.000448 -0.000826 0.009820 +7274 1 0.000273 1560.000000 0.002145 -0.001797 0.007874 +7275 1 0.000277 1560.000000 0.000581 -0.001419 0.009083 +7276 1 0.000264 1560.000000 -0.001876 -0.000787 0.006613 +7277 1 0.000199 1560.000000 0.002396 0.001346 0.004476 +7278 1 0.000278 1560.000000 -0.002784 0.000766 0.005782 +7279 1 0.000249 1560.000000 0.001437 0.003180 0.005688 +7280 1 0.000229 1560.000000 -0.002561 0.002368 0.000977 +7281 1 0.000241 1560.000000 0.001571 -0.001119 0.002870 +7282 1 0.000266 1560.000000 -0.000955 0.002954 0.003557 +7283 1 0.000251 1560.000000 0.003560 -0.000532 0.002638 +7284 1 0.000227 1560.000000 0.000706 0.001921 0.008532 +7285 1 0.000275 1560.000000 -0.001896 0.001812 0.006288 +7286 1 0.000217 1560.000000 0.000171 0.003760 0.009294 +7287 1 0.000250 1560.000000 -0.002244 0.002336 0.003025 +7288 1 0.000194 1560.000000 0.000291 0.002908 0.007618 +7289 1 0.000196 1560.000000 -0.003081 -0.002159 0.005340 +7290 1 0.000192 1560.000000 0.001258 -0.003367 0.003278 +7291 1 0.000204 1560.000000 0.000613 0.002295 0.005667 +7292 1 0.000219 1560.000000 0.001945 -0.000535 0.000434 +7293 1 0.000194 1560.000000 0.003015 -0.000852 0.006445 +7294 1 0.000195 1560.000000 -0.000625 -0.003325 0.002420 +7295 1 0.000213 1560.000000 0.001946 -0.002578 0.004048 +7296 1 0.000262 1560.000000 0.000947 0.001296 0.009271 +7297 1 0.000222 1560.000000 0.002977 0.000383 0.003470 +7298 1 0.000237 1560.000000 -0.000774 0.000903 0.000611 +7299 1 0.000240 1560.000000 0.003718 0.000438 0.000623 +7300 1 0.000262 1560.000000 0.002931 0.002439 0.000714 +7301 1 0.000259 1560.000000 0.000266 -0.001634 0.004207 +7302 1 0.000198 1560.000000 0.001334 -0.001890 0.002109 +7303 1 0.000241 1560.000000 -0.002508 -0.002187 0.006511 +7304 1 0.000228 1560.000000 -0.001282 0.001817 0.008736 +7305 1 0.000251 1560.000000 -0.002625 0.001647 0.002485 +7306 1 0.000196 1560.000000 -0.001337 -0.000498 0.002581 +7307 1 0.000272 1560.000000 0.002390 -0.002760 0.004092 +7308 1 0.000275 1560.000000 -0.002838 0.001494 0.006177 +7309 1 0.000224 1560.000000 0.001333 0.000360 0.003200 +7310 1 0.000250 1560.000000 -0.002838 -0.001986 0.005041 +7311 1 0.000244 1560.000000 0.002720 0.000490 0.009621 +7312 1 0.000238 1560.000000 0.000882 0.002030 0.004417 +7313 1 0.000228 1560.000000 -0.003011 0.001443 0.002511 +7314 1 0.000284 1560.000000 0.001251 -0.001992 0.009787 +7315 1 0.000194 1560.000000 -0.001786 -0.002323 0.004712 +7316 1 0.000261 1560.000000 -0.000309 -0.003046 0.004815 +7317 1 0.000211 1560.000000 -0.001698 -0.000288 0.001913 +7318 1 0.000227 1560.000000 -0.001605 0.000744 0.000959 +7319 1 0.000204 1560.000000 -0.002906 0.002277 0.007946 +7320 1 0.000233 1560.000000 0.000155 -0.000996 0.009644 +7321 1 0.000260 1560.000000 0.002506 0.002250 0.000808 +7322 1 0.000231 1560.000000 -0.001142 -0.002390 0.006334 +7323 1 0.000219 1560.000000 0.000383 0.003626 0.009710 +7324 1 0.000204 1560.000000 0.000906 0.002839 0.007367 +7325 1 0.000195 1560.000000 0.000427 0.002484 0.005890 +7326 1 0.000255 1560.000000 -0.001276 -0.002408 0.009433 +7327 1 0.000246 1560.000000 -0.002162 -0.002260 0.001293 +7328 1 0.000254 1560.000000 -0.000888 -0.002184 0.002893 +7329 1 0.000207 1560.000000 0.002805 -0.000221 0.007565 +7330 1 0.000225 1560.000000 0.001223 -0.000401 0.002456 +7331 1 0.000263 1560.000000 -0.000735 0.002751 0.003645 +7332 1 0.000207 1560.000000 0.000796 0.001125 0.002143 +7333 1 0.000254 1560.000000 -0.000595 0.003045 0.004191 +7334 1 0.000205 1560.000000 0.000635 0.000548 0.009616 +7335 1 0.000226 1560.000000 -0.000821 0.002302 0.001089 +7336 1 0.000200 1560.000000 0.001138 -0.003152 0.009205 +7337 1 0.000195 1560.000000 -0.001539 0.002923 0.002737 +7338 1 0.000197 1560.000000 -0.001913 0.001134 0.001760 +7339 1 0.000225 1560.000000 -0.000839 0.002945 0.003921 +7340 1 0.000276 1560.000000 0.001430 0.001070 0.007394 +7341 1 0.000223 1560.000000 0.001682 0.001401 0.007431 +7342 1 0.000196 1560.000000 -0.000382 -0.000701 0.003492 +7343 1 0.000266 1560.000000 -0.003462 -0.001392 0.001973 +7344 1 0.000239 1560.000000 -0.000614 -0.003169 0.006537 +7345 1 0.000282 1560.000000 -0.002399 -0.002999 0.002525 +7346 1 0.000195 1560.000000 -0.000521 0.003290 0.008182 +7347 1 0.000195 1560.000000 0.000811 0.002499 0.001930 +7348 1 0.000194 1560.000000 -0.001226 -0.002886 0.004411 +7349 1 0.000210 1560.000000 -0.000050 -0.003333 0.000962 +7350 1 0.000232 1560.000000 -0.002940 0.001099 0.001181 +7351 1 0.000214 1560.000000 -0.000902 0.001620 0.001985 +7352 1 0.000218 1560.000000 -0.000573 -0.001829 0.006743 +7353 1 0.000209 1560.000000 0.000370 -0.001768 0.009014 +7354 1 0.000276 1560.000000 -0.001194 0.002782 0.000233 +7355 1 0.000195 1560.000000 -0.000666 0.001016 0.006468 +7356 1 0.000280 1560.000000 -0.000946 0.001248 0.009411 +7357 1 0.000198 1560.000000 -0.001491 -0.002422 0.004401 +7358 1 0.000279 1560.000000 0.000041 -0.003284 0.008928 +7359 1 0.000238 1560.000000 -0.001643 -0.001879 0.003229 +7360 1 0.000236 1560.000000 0.000819 0.000480 0.008415 +7361 1 0.000276 1560.000000 0.003043 0.002129 0.000257 +7362 1 0.000195 1560.000000 -0.001757 0.002077 0.001282 +7363 1 0.000232 1560.000000 0.001791 -0.001716 0.007932 +7364 1 0.000226 1560.000000 0.000169 -0.000349 0.001756 +7365 1 0.000286 1560.000000 0.002236 -0.000775 0.005700 +7366 1 0.000214 1560.000000 -0.000816 -0.001550 0.001648 +7367 1 0.000286 1560.000000 -0.002134 0.002874 0.004959 +7368 1 0.000193 1560.000000 0.000352 0.000016 0.005643 +7369 1 0.000285 1560.000000 -0.000850 -0.003622 0.009768 +7370 1 0.000262 1560.000000 -0.003368 -0.000494 0.009701 +7371 1 0.000194 1560.000000 -0.001719 0.001398 0.004695 +7372 1 0.000241 1560.000000 -0.001501 -0.002330 0.008276 +7373 1 0.000201 1560.000000 0.003323 0.000308 0.006858 +7374 1 0.000233 1560.000000 -0.001042 -0.000126 0.006822 +7375 1 0.000208 1560.000000 -0.001368 -0.002014 0.005783 +7376 1 0.000248 1560.000000 0.002214 0.002129 0.000588 +7377 1 0.000205 1560.000000 0.001803 -0.000352 0.000789 +7378 1 0.000238 1560.000000 0.001280 -0.000327 0.001096 +7379 1 0.000215 1560.000000 -0.002189 0.002885 0.007228 +7380 1 0.000212 1560.000000 0.001364 -0.001735 0.006217 +7381 1 0.000231 1560.000000 -0.003138 0.000175 0.003341 +7382 1 0.000195 1560.000000 0.000619 0.001637 0.004140 +7383 1 0.000214 1560.000000 0.001496 0.003072 0.004945 +7384 1 0.000250 1560.000000 0.000016 -0.002592 0.000964 +7385 1 0.000284 1560.000000 0.000203 -0.002165 0.009354 +7386 1 0.000274 1560.000000 0.002300 0.002813 0.004321 +7387 1 0.000193 1560.000000 -0.000125 0.002019 0.000166 +7388 1 0.000242 1560.000000 0.003422 0.001618 0.006806 +7389 1 0.000215 1560.000000 -0.000119 -0.001535 0.007536 +7390 1 0.000223 1560.000000 -0.000621 -0.001696 0.001662 +7391 1 0.000206 1560.000000 0.000846 -0.000045 0.008282 +7392 1 0.000198 1560.000000 -0.002184 -0.002252 0.005504 +7393 1 0.000228 1560.000000 0.002974 0.000430 0.001222 +7394 1 0.000257 1560.000000 0.001313 -0.002568 0.003564 +7395 1 0.000237 1560.000000 -0.001845 0.000120 0.003362 +7396 1 0.000230 1560.000000 -0.001831 -0.000122 0.000628 +7397 1 0.000207 1560.000000 -0.000492 0.000260 0.008239 +7398 1 0.000202 1560.000000 0.001849 -0.000231 0.003831 +7399 1 0.000235 1560.000000 -0.000146 -0.003708 0.000888 +7400 1 0.000202 1560.000000 -0.000970 0.000093 0.003364 +7401 1 0.000205 1560.000000 -0.003833 0.000082 0.007434 +7402 1 0.000224 1560.000000 0.001066 0.000791 0.007985 +7403 1 0.000193 1560.000000 -0.000041 -0.001208 0.005644 +7404 1 0.000211 1560.000000 0.002374 -0.000797 0.001015 +7405 1 0.000197 1560.000000 0.000454 -0.000103 0.006939 +7406 1 0.000196 1560.000000 0.000041 -0.000963 0.004204 +7407 1 0.000229 1560.000000 -0.001491 -0.000290 0.008345 +7408 1 0.000199 1560.000000 0.002490 -0.001084 0.008250 +7409 1 0.000210 1560.000000 -0.003233 0.000990 0.002949 +7410 1 0.000201 1560.000000 -0.001971 0.001055 0.001255 +7411 1 0.000201 1560.000000 -0.003572 -0.000995 0.005810 +7412 1 0.000222 1560.000000 -0.000110 -0.000886 0.002219 +7413 1 0.000259 1560.000000 0.000128 0.003852 0.001455 +7414 1 0.000198 1560.000000 -0.001832 -0.003103 0.008394 +7415 1 0.000205 1560.000000 0.000865 -0.003211 0.003718 +7416 1 0.000247 1560.000000 -0.000373 -0.001902 0.009826 +7417 1 0.000223 1560.000000 -0.001317 -0.001021 0.004355 +7418 1 0.000207 1560.000000 0.001138 0.003096 0.005424 +7419 1 0.000236 1560.000000 -0.000629 0.003276 0.001009 +7420 1 0.000250 1560.000000 -0.000375 -0.003340 0.001173 +7421 1 0.000213 1560.000000 -0.002564 0.000410 0.005738 +7422 1 0.000198 1560.000000 -0.002775 0.001161 0.009624 +7423 1 0.000284 1560.000000 0.000196 -0.003687 0.008783 +7424 1 0.000284 1560.000000 -0.002491 0.001102 0.000760 +7425 1 0.000210 1560.000000 -0.000523 0.002323 0.002218 +7426 1 0.000210 1560.000000 -0.002576 -0.000955 0.008538 +7427 1 0.000229 1560.000000 0.001714 -0.002915 0.000716 +7428 1 0.000259 1560.000000 -0.002845 0.000899 0.001294 +7429 1 0.000210 1560.000000 0.003121 0.000904 0.009388 +7430 1 0.000213 1560.000000 -0.000534 0.002549 0.005596 +7431 1 0.000259 1560.000000 0.002269 -0.000873 0.005302 +7432 1 0.000201 1560.000000 0.002231 0.000331 0.002428 +7433 1 0.000210 1560.000000 -0.001397 -0.001776 0.000167 +7434 1 0.000257 1560.000000 0.003039 0.001087 0.000181 +7435 1 0.000219 1560.000000 0.000576 -0.003602 0.006717 +7436 1 0.000240 1560.000000 -0.000966 0.002485 0.003572 +7437 1 0.000245 1560.000000 0.000590 0.002481 0.006563 +7438 1 0.000254 1560.000000 0.002788 -0.001924 0.002119 +7439 1 0.000268 1560.000000 0.003714 -0.000920 0.008452 +7440 1 0.000232 1560.000000 -0.000421 0.002105 0.002576 +7441 1 0.000219 1560.000000 0.001454 -0.000754 0.009724 +7442 1 0.000242 1560.000000 0.001083 0.001026 0.007041 +7443 1 0.000277 1560.000000 0.002613 -0.002102 0.001240 +7444 1 0.000228 1560.000000 -0.000662 0.003149 0.005844 +7445 1 0.000208 1560.000000 -0.001090 0.003336 0.004200 +7446 1 0.000234 1560.000000 -0.000194 0.001953 0.007874 +7447 1 0.000250 1560.000000 -0.001941 0.000916 0.005446 +7448 1 0.000209 1560.000000 0.002485 0.001429 0.003658 +7449 1 0.000212 1560.000000 -0.000497 0.000102 0.000962 +7450 1 0.000261 1560.000000 0.000487 -0.003249 0.002292 +7451 1 0.000233 1560.000000 -0.000505 0.000954 0.003489 +7452 1 0.000216 1560.000000 0.001648 0.003434 0.008703 +7453 1 0.000214 1560.000000 -0.001079 -0.001393 0.009359 +7454 1 0.000282 1560.000000 0.000523 0.001190 0.000776 +7455 1 0.000205 1560.000000 -0.001763 0.000390 0.004995 +7456 1 0.000204 1560.000000 -0.002487 -0.002794 0.005058 +7457 1 0.000207 1560.000000 0.000300 -0.003250 0.006012 +7458 1 0.000253 1560.000000 0.002116 0.002783 0.002297 +7459 1 0.000199 1560.000000 0.001853 -0.000880 0.002747 +7460 1 0.000248 1560.000000 0.001186 -0.002173 0.001955 +7461 1 0.000267 1560.000000 0.001070 0.000693 0.006733 +7462 1 0.000215 1560.000000 0.001954 -0.000559 0.005336 +7463 1 0.000199 1560.000000 0.001105 -0.000137 0.002232 +7464 1 0.000202 1560.000000 0.000519 0.000747 0.008868 +7465 1 0.000220 1560.000000 0.002801 -0.000223 0.001447 +7466 1 0.000215 1560.000000 0.001185 -0.001065 0.001744 +7467 1 0.000249 1560.000000 0.003007 -0.002312 0.001122 +7468 1 0.000193 1560.000000 -0.001606 -0.001508 0.007236 +7469 1 0.000235 1560.000000 -0.001384 -0.000163 0.001931 +7470 1 0.000221 1560.000000 -0.000398 -0.003308 0.000128 +7471 1 0.000230 1560.000000 -0.001916 0.002922 0.002856 +7472 1 0.000207 1560.000000 0.001269 0.001432 0.005153 +7473 1 0.000208 1560.000000 -0.000603 0.001829 0.006621 +7474 1 0.000238 1560.000000 0.000704 -0.002133 0.004641 +7475 1 0.000215 1560.000000 -0.001005 0.000616 0.004591 +7476 1 0.000199 1560.000000 -0.002418 -0.000922 0.009533 +7477 1 0.000220 1560.000000 -0.001812 -0.001038 0.000657 +7478 1 0.000229 1560.000000 -0.001456 0.001737 0.009561 +7479 1 0.000222 1560.000000 -0.000620 0.000728 0.003437 +7480 1 0.000207 1560.000000 0.001894 0.002313 0.004779 +7481 1 0.000214 1560.000000 -0.001017 -0.002051 0.006404 +7482 1 0.000236 1560.000000 -0.003617 0.000133 0.004591 +7483 1 0.000194 1560.000000 0.002439 0.000935 0.002488 +7484 1 0.000201 1560.000000 -0.000582 0.000192 0.001823 +7485 1 0.000285 1560.000000 0.001541 -0.000592 0.000594 +7486 1 0.000263 1560.000000 -0.000824 0.003454 0.008312 +7487 1 0.000251 1560.000000 0.003448 -0.000854 0.004313 +7488 1 0.000239 1560.000000 -0.001539 -0.001892 0.004479 +7489 1 0.000232 1560.000000 0.001549 -0.002787 0.004706 +7490 1 0.000233 1560.000000 0.000492 0.000819 0.008162 +7491 1 0.000273 1560.000000 -0.003077 -0.001500 0.006952 +7492 1 0.000217 1560.000000 0.002350 0.001046 0.001704 +7493 1 0.000234 1560.000000 -0.001890 -0.002862 0.002003 +7494 1 0.000222 1560.000000 0.001033 0.002751 0.001007 +7495 1 0.000199 1560.000000 0.003748 -0.000238 0.009720 +7496 1 0.000219 1560.000000 0.001628 0.001455 0.000564 +7497 1 0.000268 1560.000000 0.000872 -0.002244 0.007164 +7498 1 0.000238 1560.000000 -0.000156 0.003763 0.000881 +7499 1 0.000227 1560.000000 -0.000826 0.000723 0.003272 +7500 1 0.000197 1560.000000 0.001592 0.000805 0.008573 +7501 1 0.000246 1560.000000 0.002383 0.000150 0.006867 +7502 1 0.000232 1560.000000 0.003641 -0.000916 0.005769 +7503 1 0.000254 1560.000000 0.000510 -0.001917 0.007826 +7504 1 0.000262 1560.000000 -0.002518 -0.001615 0.006101 +7505 1 0.000197 1560.000000 0.000849 -0.001907 0.001527 +7506 1 0.000261 1560.000000 -0.000862 0.000580 0.003655 +7507 1 0.000220 1560.000000 -0.000441 -0.003597 0.002358 +7508 1 0.000214 1560.000000 0.001919 0.001346 0.002391 +7509 1 0.000196 1560.000000 -0.001670 0.000082 0.006310 +7510 1 0.000203 1560.000000 -0.003078 0.000159 0.003082 +7511 1 0.000193 1560.000000 0.001444 0.000196 0.009748 +7512 1 0.000208 1560.000000 0.001905 -0.002112 0.005538 +7513 1 0.000260 1560.000000 0.001251 0.002481 0.005719 +7514 1 0.000269 1560.000000 0.003432 0.001738 0.009769 +7515 1 0.000248 1560.000000 0.000232 0.002042 0.000581 +7516 1 0.000237 1560.000000 -0.003371 -0.001506 0.004523 +7517 1 0.000271 1560.000000 -0.001129 -0.002407 0.008079 +7518 1 0.000242 1560.000000 0.002797 0.001720 0.004402 +7519 1 0.000286 1560.000000 0.000797 -0.002569 0.009211 +7520 1 0.000207 1560.000000 -0.001679 0.000612 0.005403 +7521 1 0.000248 1560.000000 -0.000842 -0.002605 0.009452 +7522 1 0.000193 1560.000000 -0.000741 0.001586 0.006553 +7523 1 0.000246 1560.000000 -0.001926 -0.001688 0.007494 +7524 1 0.000198 1560.000000 -0.000633 0.001866 0.004640 +7525 1 0.000213 1560.000000 -0.001343 0.002929 0.004522 +7526 1 0.000281 1560.000000 0.000009 -0.000773 0.004591 +7527 1 0.000236 1560.000000 -0.001835 -0.003155 0.007175 +7528 1 0.000203 1560.000000 0.001401 0.000058 0.005259 +7529 1 0.000244 1560.000000 0.001900 -0.001805 0.003565 +7530 1 0.000208 1560.000000 0.000511 -0.000889 0.007394 +7531 1 0.000227 1560.000000 0.002955 0.000185 0.007268 +7532 1 0.000231 1560.000000 -0.000593 -0.001302 0.007490 +7533 1 0.000276 1560.000000 0.001089 0.001535 0.003897 +7534 1 0.000235 1560.000000 -0.002214 0.000171 0.005473 +7535 1 0.000250 1560.000000 0.000840 0.003106 0.007284 +7536 1 0.000217 1560.000000 -0.002503 -0.000751 0.002784 +7537 1 0.000229 1560.000000 0.000941 -0.001437 0.005305 +7538 1 0.000195 1560.000000 -0.002880 -0.001363 0.008123 +7539 1 0.000193 1560.000000 -0.001527 0.000718 0.000419 +7540 1 0.000214 1560.000000 0.002695 0.000101 0.008151 +7541 1 0.000210 1560.000000 -0.002230 -0.000615 0.007686 +7542 1 0.000202 1560.000000 -0.000651 0.000468 0.007761 +7543 1 0.000199 1560.000000 -0.000613 -0.003647 0.009231 +7544 1 0.000194 1560.000000 -0.001049 0.003326 0.000393 +7545 1 0.000242 1560.000000 0.001124 -0.000979 0.007666 +7546 1 0.000214 1560.000000 -0.000766 0.001506 0.007575 +7547 1 0.000247 1560.000000 0.000298 0.000340 0.001377 +7548 1 0.000262 1560.000000 0.001972 0.001627 0.002759 +7549 1 0.000236 1560.000000 -0.000746 -0.000106 0.007681 +7550 1 0.000247 1560.000000 0.000964 -0.001575 0.006168 +7551 1 0.000216 1560.000000 -0.003338 -0.000127 0.004084 +7552 1 0.000213 1560.000000 -0.000143 0.002660 0.000192 +7553 1 0.000218 1560.000000 0.000674 -0.001125 0.009573 +7554 1 0.000245 1560.000000 0.001476 0.001328 0.003292 +7555 1 0.000282 1560.000000 -0.002086 -0.002154 0.004388 +7556 1 0.000244 1560.000000 -0.001570 0.000539 0.009168 +7557 1 0.000241 1560.000000 0.002161 -0.001487 0.000296 +7558 1 0.000220 1560.000000 -0.000528 0.000460 0.000290 +7559 1 0.000196 1560.000000 0.000136 -0.003196 0.006322 +7560 1 0.000249 1560.000000 -0.000779 0.001822 0.005678 +7561 1 0.000239 1560.000000 -0.000011 -0.000922 0.008338 +7562 1 0.000232 1560.000000 -0.002133 0.001013 0.009752 +7563 1 0.000224 1560.000000 0.002102 0.002563 0.008650 +7564 1 0.000220 1560.000000 0.001562 0.000217 0.005677 +7565 1 0.000266 1560.000000 0.001823 -0.001378 0.007998 +7566 1 0.000220 1560.000000 -0.001116 0.002500 0.001335 +7567 1 0.000226 1560.000000 -0.000454 -0.000971 0.005223 +7568 1 0.000222 1560.000000 0.000430 0.002153 0.006536 +7569 1 0.000262 1560.000000 0.000786 -0.001553 0.007919 +7570 1 0.000210 1560.000000 0.002743 0.002584 0.006982 +7571 1 0.000221 1560.000000 -0.002248 -0.000569 0.000847 +7572 1 0.000193 1560.000000 -0.002780 -0.002418 0.003144 +7573 1 0.000232 1560.000000 -0.000429 0.000703 0.002970 +7574 1 0.000259 1560.000000 0.001840 -0.001279 0.003606 +7575 1 0.000248 1560.000000 -0.000427 -0.000068 0.000682 +7576 1 0.000213 1560.000000 0.003118 0.002163 0.004699 +7577 1 0.000231 1560.000000 0.001136 -0.002625 0.006181 +7578 1 0.000206 1560.000000 0.002075 -0.002486 0.004354 +7579 1 0.000209 1560.000000 0.000314 -0.000705 0.001580 +7580 1 0.000207 1560.000000 0.000645 -0.001486 0.007706 +7581 1 0.000196 1560.000000 -0.001564 -0.002026 0.002810 +7582 1 0.000256 1560.000000 0.001109 0.002040 0.006153 +7583 1 0.000217 1560.000000 0.003026 -0.001428 0.000256 +7584 1 0.000236 1560.000000 0.001275 0.002731 0.008493 +7585 1 0.000245 1560.000000 0.002192 -0.001816 0.003063 +7586 1 0.000250 1560.000000 -0.001908 0.002209 0.006761 +7587 1 0.000242 1560.000000 0.003279 0.000114 0.001924 +7588 1 0.000207 1560.000000 -0.000230 -0.001840 0.006134 +7589 1 0.000270 1560.000000 0.002587 -0.001325 0.009023 +7590 1 0.000236 1560.000000 -0.001126 -0.002190 0.001376 +7591 1 0.000260 1560.000000 0.000638 -0.002686 0.007452 +7592 1 0.000194 1560.000000 0.001931 0.002108 0.006480 +7593 1 0.000281 1560.000000 0.002183 -0.001408 0.007192 +7594 1 0.000250 1560.000000 0.000332 -0.000410 0.000737 +7595 1 0.000262 1560.000000 0.001355 -0.000609 0.002339 +7596 1 0.000235 1560.000000 0.001685 -0.002454 0.000566 +7597 1 0.000198 1560.000000 0.000274 0.003020 0.002154 +7598 1 0.000273 1560.000000 -0.002620 -0.001227 0.005036 +7599 1 0.000251 1560.000000 0.000293 -0.003039 0.001001 +7600 1 0.000232 1560.000000 0.000644 0.002505 0.006815 +7601 1 0.000243 1560.000000 -0.000185 -0.000411 0.001568 +7602 1 0.000202 1560.000000 0.002046 -0.001857 0.008770 +7603 1 0.000218 1560.000000 0.001627 0.002831 0.006653 +7604 1 0.000268 1560.000000 -0.003392 0.001707 0.001434 +7605 1 0.000203 1560.000000 -0.000786 -0.001039 0.002343 +7606 1 0.000274 1560.000000 0.003333 -0.001605 0.005053 +7607 1 0.000220 1560.000000 0.002745 0.002275 0.008669 +7608 1 0.000240 1560.000000 0.002044 0.001542 0.004003 +7609 1 0.000235 1560.000000 -0.003446 -0.000630 0.006720 +7610 1 0.000212 1560.000000 0.000130 0.002161 0.008525 +7611 1 0.000280 1560.000000 0.002829 0.000942 0.006846 +7612 1 0.000224 1560.000000 -0.001749 -0.001456 0.003072 +7613 1 0.000237 1560.000000 -0.001410 0.002614 0.008351 +7614 1 0.000250 1560.000000 0.001235 -0.000570 0.006989 +7615 1 0.000215 1560.000000 0.001443 -0.001465 0.006363 +7616 1 0.000225 1560.000000 0.000231 0.000681 0.004959 +7617 1 0.000253 1560.000000 0.003043 0.001194 0.009151 +7618 1 0.000233 1560.000000 0.001806 0.001701 0.000701 +7619 1 0.000257 1560.000000 -0.003227 0.001640 0.006410 +7620 1 0.000215 1560.000000 -0.001168 -0.002614 0.001485 +7621 1 0.000238 1560.000000 -0.001055 0.002137 0.002352 +7622 1 0.000194 1560.000000 -0.001912 0.000827 0.002018 +7623 1 0.000245 1560.000000 0.001462 0.000049 0.008630 +7624 1 0.000214 1560.000000 -0.000717 -0.002349 0.001190 +7625 1 0.000219 1560.000000 -0.001517 0.000666 0.000737 +7626 1 0.000226 1560.000000 0.000361 0.000511 0.006742 +7627 1 0.000214 1560.000000 -0.000660 0.000959 0.004796 +7628 1 0.000288 1560.000000 0.001827 -0.002304 0.004015 +7629 1 0.000215 1560.000000 -0.000867 -0.003673 0.008110 +7630 1 0.000258 1560.000000 -0.003594 -0.001058 0.003679 +7631 1 0.000206 1560.000000 0.000889 0.000423 0.002864 +7632 1 0.000277 1560.000000 0.000820 0.001417 0.006956 +7633 1 0.000239 1560.000000 0.002533 -0.002584 0.009811 +7634 1 0.000218 1560.000000 0.001498 0.000942 0.000410 +7635 1 0.000206 1560.000000 -0.001212 0.001685 0.008991 +7636 1 0.000269 1560.000000 0.000808 0.003215 0.002071 +7637 1 0.000258 1560.000000 -0.001308 -0.001546 0.004234 +7638 1 0.000201 1560.000000 0.001195 -0.001397 0.003911 +7639 1 0.000200 1560.000000 0.003151 0.001505 0.008306 +7640 1 0.000220 1560.000000 0.002244 0.000991 0.002420 +7641 1 0.000203 1560.000000 -0.002942 -0.001002 0.003499 +7642 1 0.000250 1560.000000 -0.001575 0.000858 0.005926 +7643 1 0.000214 1560.000000 0.003142 -0.000740 0.008993 +7644 1 0.000288 1560.000000 0.002062 0.000665 0.007354 +7645 1 0.000239 1560.000000 0.000974 0.000987 0.005796 +7646 1 0.000200 1560.000000 0.000216 0.001216 0.009665 +7647 1 0.000270 1560.000000 0.000598 -0.002644 0.003722 +7648 1 0.000233 1560.000000 -0.000136 0.001607 0.009429 +7649 1 0.000288 1560.000000 -0.002160 -0.003144 0.001404 +7650 1 0.000254 1560.000000 0.002612 0.000956 0.008542 +7651 1 0.000204 1560.000000 0.003259 0.000970 0.005575 +7652 1 0.000250 1560.000000 0.002620 -0.002384 0.008471 +7653 1 0.000222 1560.000000 0.000965 0.001921 0.002468 +7654 1 0.000202 1560.000000 -0.001378 0.001137 0.009777 +7655 1 0.000218 1560.000000 -0.000492 0.000978 0.006653 +7656 1 0.000225 1560.000000 0.002489 -0.002927 0.008933 +7657 1 0.000211 1560.000000 0.001281 -0.002276 0.003500 +7658 1 0.000196 1560.000000 -0.001862 0.001077 0.006132 +7659 1 0.000219 1560.000000 0.001387 -0.000011 0.003366 +7660 1 0.000212 1560.000000 -0.002374 -0.001602 0.006504 +7661 1 0.000227 1560.000000 0.000911 -0.000709 0.000268 +7662 1 0.000270 1560.000000 0.002039 -0.002288 0.006305 +7663 1 0.000200 1560.000000 0.000852 -0.003348 0.006199 +7664 1 0.000246 1560.000000 -0.002973 0.002358 0.008335 +7665 1 0.000211 1560.000000 -0.001155 0.002017 0.006912 +7666 1 0.000205 1560.000000 -0.000975 0.002948 0.001781 +7667 1 0.000195 1560.000000 -0.002718 0.001750 0.006417 +7668 1 0.000266 1560.000000 0.002967 -0.002185 0.003032 +7669 1 0.000209 1560.000000 -0.000686 0.002386 0.000522 +7670 1 0.000208 1560.000000 -0.001952 0.001990 0.009416 +7671 1 0.000225 1560.000000 0.002359 0.002244 0.009633 +7672 1 0.000277 1560.000000 -0.000804 -0.001270 0.005729 +7673 1 0.000232 1560.000000 0.002160 -0.001521 0.009203 +7674 1 0.000250 1560.000000 -0.000385 -0.001077 0.008620 +7675 1 0.000233 1560.000000 0.000747 -0.002353 0.006253 +7676 1 0.000222 1560.000000 0.001807 0.000011 0.006764 +7677 1 0.000215 1560.000000 -0.001460 0.000738 0.004548 +7678 1 0.000204 1560.000000 0.000221 0.002613 0.006746 +7679 1 0.000265 1560.000000 -0.003489 -0.000161 0.004484 +7680 1 0.000210 1560.000000 -0.001542 0.003205 0.006109 +7681 1 0.000237 1560.000000 -0.001242 -0.001529 0.003287 +7682 1 0.000208 1560.000000 -0.000813 0.001140 0.000974 +7683 1 0.000234 1560.000000 0.000616 -0.001343 0.007399 +7684 1 0.000226 1560.000000 0.002187 -0.000993 0.009023 +7685 1 0.000247 1560.000000 -0.000627 -0.001479 0.006965 +7686 1 0.000256 1560.000000 0.000451 0.003802 0.002996 +7687 1 0.000261 1560.000000 0.001802 -0.001789 0.006862 +7688 1 0.000276 1560.000000 0.001172 0.001919 0.006770 +7689 1 0.000234 1560.000000 -0.000799 -0.001602 0.000752 +7690 1 0.000223 1560.000000 -0.000351 -0.000538 0.000155 +7691 1 0.000222 1560.000000 -0.000071 0.003169 0.001796 +7692 1 0.000197 1560.000000 -0.001191 -0.001516 0.005572 +7693 1 0.000270 1560.000000 0.001598 -0.001966 0.003732 +7694 1 0.000226 1560.000000 -0.003104 -0.000337 0.009750 +7695 1 0.000202 1560.000000 -0.002148 0.001538 0.007529 +7696 1 0.000200 1560.000000 0.000161 0.003585 0.003720 +7697 1 0.000216 1560.000000 -0.002588 -0.001137 0.000628 +7698 1 0.000248 1560.000000 0.002122 -0.000077 0.004936 +7699 1 0.000233 1560.000000 -0.001736 0.000368 0.004536 +7700 1 0.000275 1560.000000 0.001363 0.003100 0.007185 +7701 1 0.000252 1560.000000 0.003165 0.000588 0.007391 +7702 1 0.000272 1560.000000 -0.002338 -0.002156 0.008288 +7703 1 0.000201 1560.000000 -0.000243 0.002785 0.009725 +7704 1 0.000201 1560.000000 -0.001401 -0.000385 0.003941 +7705 1 0.000274 1560.000000 -0.000334 0.002930 0.004049 +7706 1 0.000196 1560.000000 0.003000 -0.002087 0.001697 +7707 1 0.000210 1560.000000 0.001217 0.001226 0.001376 +7708 1 0.000235 1560.000000 -0.002856 0.002094 0.005250 +7709 1 0.000209 1560.000000 -0.001702 -0.001335 0.002809 +7710 1 0.000218 1560.000000 -0.000446 -0.001767 0.006409 +7711 1 0.000228 1560.000000 -0.001584 -0.002268 0.002966 +7712 1 0.000216 1560.000000 0.002602 -0.001323 0.009432 +7713 1 0.000215 1560.000000 0.000100 -0.000465 0.006047 +7714 1 0.000200 1560.000000 -0.000558 0.001210 0.009774 +7715 1 0.000199 1560.000000 0.002673 -0.000103 0.005003 +7716 1 0.000235 1560.000000 0.000260 0.001613 0.008423 +7717 1 0.000202 1560.000000 0.002162 0.002991 0.001156 +7718 1 0.000196 1560.000000 -0.001236 0.003541 0.004224 +7719 1 0.000218 1560.000000 -0.001836 -0.000523 0.006190 +7720 1 0.000219 1560.000000 0.001916 0.003250 0.004695 +7721 1 0.000220 1560.000000 -0.002118 0.000690 0.000686 +7722 1 0.000248 1560.000000 0.002205 -0.000106 0.004498 +7723 1 0.000246 1560.000000 -0.002964 -0.001642 0.002299 +7724 1 0.000215 1560.000000 0.000722 -0.001338 0.008513 +7725 1 0.000252 1560.000000 -0.003024 0.001042 0.006879 +7726 1 0.000208 1560.000000 -0.001251 0.001841 0.009255 +7727 1 0.000192 1560.000000 -0.002794 0.001618 0.006601 +7728 1 0.000252 1560.000000 -0.000456 -0.003654 0.000508 +7729 1 0.000215 1560.000000 0.003484 -0.001052 0.007271 +7730 1 0.000243 1560.000000 0.002467 0.001726 0.008951 +7731 1 0.000207 1560.000000 -0.000417 -0.001690 0.009581 +7732 1 0.000244 1560.000000 -0.000883 -0.003512 0.006342 +7733 1 0.000207 1560.000000 0.002358 -0.000915 0.006724 +7734 1 0.000257 1560.000000 -0.000070 -0.002526 0.007845 +7735 1 0.000214 1560.000000 0.003444 0.001132 0.002451 +7736 1 0.000280 1560.000000 -0.001426 -0.001044 0.003233 +7737 1 0.000234 1560.000000 -0.003190 0.000718 0.001420 +7738 1 0.000266 1560.000000 -0.001810 -0.000380 0.008135 +7739 1 0.000259 1560.000000 0.002116 0.002369 0.003949 +7740 1 0.000251 1560.000000 -0.002670 -0.002776 0.004149 +7741 1 0.000233 1560.000000 -0.002922 0.000938 0.004131 +7742 1 0.000234 1560.000000 -0.001173 -0.003049 0.009229 +7743 1 0.000194 1560.000000 0.002757 0.000324 0.008753 +7744 1 0.000228 1560.000000 0.000326 -0.002885 0.000583 +7745 1 0.000253 1560.000000 0.001142 0.001667 0.009580 +7746 1 0.000276 1560.000000 -0.002553 0.002826 0.000439 +7747 1 0.000270 1560.000000 0.000352 0.002772 0.000963 +7748 1 0.000279 1560.000000 -0.002052 -0.001330 0.005437 +7749 1 0.000254 1560.000000 0.001227 0.003637 0.008878 +7750 1 0.000221 1560.000000 0.003340 0.001034 0.006576 +7751 1 0.000201 1560.000000 -0.000690 0.000047 0.001279 +7752 1 0.000240 1560.000000 -0.000193 0.003824 0.007286 +7753 1 0.000249 1560.000000 0.000385 0.002054 0.009222 +7754 1 0.000243 1560.000000 -0.000502 0.000997 0.009811 +7755 1 0.000239 1560.000000 -0.002892 -0.000461 0.004934 +7756 1 0.000227 1560.000000 -0.000999 -0.002799 0.002657 +7757 1 0.000219 1560.000000 -0.002030 0.001319 0.001660 +7758 1 0.000274 1560.000000 0.000384 0.000867 0.007615 +7759 1 0.000206 1560.000000 -0.001068 0.002721 0.007718 +7760 1 0.000238 1560.000000 0.001398 0.003380 0.008648 +7761 1 0.000239 1560.000000 -0.000206 -0.001194 0.003290 +7762 1 0.000198 1560.000000 -0.002610 -0.001559 0.000117 +7763 1 0.000195 1560.000000 -0.001173 0.000679 0.009566 +7764 1 0.000192 1560.000000 -0.002323 0.002996 0.008249 +7765 1 0.000214 1560.000000 0.002723 -0.002018 0.009240 +7766 1 0.000264 1560.000000 -0.001109 -0.001773 0.001529 +7767 1 0.000288 1560.000000 0.002529 -0.000302 0.000187 +7768 1 0.000199 1560.000000 0.001950 -0.002039 0.004143 +7769 1 0.000222 1560.000000 -0.000558 0.000396 0.005714 +7770 1 0.000203 1560.000000 0.001090 -0.003430 0.007765 +7771 1 0.000278 1560.000000 -0.001721 -0.000630 0.006920 +7772 1 0.000250 1560.000000 -0.002772 -0.001031 0.001927 +7773 1 0.000234 1560.000000 -0.000779 -0.000437 0.009391 +7774 1 0.000270 1560.000000 -0.001289 -0.001999 0.008397 +7775 1 0.000226 1560.000000 0.000522 -0.003603 0.003731 +7776 1 0.000278 1560.000000 0.003665 0.001029 0.005311 +7777 1 0.000272 1560.000000 -0.002348 0.000084 0.003046 +7778 1 0.000208 1560.000000 -0.003793 -0.000205 0.007433 +7779 1 0.000278 1560.000000 -0.000808 0.003328 0.002321 +7780 1 0.000237 1560.000000 0.003354 0.000839 0.004235 +7781 1 0.000194 1560.000000 0.001703 -0.000049 0.004968 +7782 1 0.000241 1560.000000 -0.001786 -0.002463 0.001390 +7783 1 0.000244 1560.000000 -0.002735 0.000731 0.000595 +7784 1 0.000195 1560.000000 -0.001278 -0.000885 0.006066 +7785 1 0.000250 1560.000000 -0.001639 -0.000013 0.002188 +7786 1 0.000247 1560.000000 0.001743 0.002659 0.009770 +7787 1 0.000238 1560.000000 0.000434 0.000316 0.008116 +7788 1 0.000219 1560.000000 0.002990 -0.002277 0.001995 +7789 1 0.000211 1560.000000 0.001942 0.001089 0.002681 +7790 1 0.000234 1560.000000 0.000854 -0.000146 0.006654 +7791 1 0.000194 1560.000000 0.001701 0.000839 0.006463 +7792 1 0.000231 1560.000000 0.002206 0.000324 0.004863 +7793 1 0.000240 1560.000000 0.000266 0.001344 0.001903 +7794 1 0.000205 1560.000000 -0.000040 0.002027 0.001487 +7795 1 0.000241 1560.000000 -0.000264 -0.003374 0.008952 +7796 1 0.000260 1560.000000 -0.002517 -0.002906 0.007875 +7797 1 0.000193 1560.000000 -0.001592 -0.002784 0.005013 +7798 1 0.000263 1560.000000 -0.002708 0.000650 0.004228 +7799 1 0.000192 1560.000000 0.002337 -0.000170 0.006167 +7800 1 0.000233 1560.000000 0.000634 -0.003423 0.006083 +7801 1 0.000259 1560.000000 0.001143 0.002061 0.005532 +7802 1 0.000195 1560.000000 0.000863 -0.000324 0.004603 +7803 1 0.000280 1560.000000 0.001124 0.001654 0.005525 +7804 1 0.000211 1560.000000 -0.000624 0.002573 0.001062 +7805 1 0.000233 1560.000000 -0.001503 -0.000139 0.007911 +7806 1 0.000194 1560.000000 -0.000944 0.001321 0.004618 +7807 1 0.000196 1560.000000 -0.000928 -0.002671 0.006164 +7808 1 0.000277 1560.000000 0.001231 0.002353 0.003785 +7809 1 0.000234 1560.000000 0.002810 -0.001254 0.007940 +7810 1 0.000218 1560.000000 -0.002421 -0.001743 0.001262 +7811 1 0.000268 1560.000000 -0.002716 -0.001934 0.000422 +7812 1 0.000226 1560.000000 -0.000064 -0.001593 0.008163 +7813 1 0.000283 1560.000000 -0.000274 0.001987 0.008211 +7814 1 0.000218 1560.000000 0.000620 -0.001031 0.003304 +7815 1 0.000212 1560.000000 -0.003657 0.000817 0.009392 +7816 1 0.000283 1560.000000 0.003715 0.000329 0.002952 +7817 1 0.000194 1560.000000 0.000551 0.002495 0.007865 +7818 1 0.000194 1560.000000 0.000181 -0.001018 0.000236 +7819 1 0.000195 1560.000000 -0.001261 -0.001975 0.005605 +7820 1 0.000199 1560.000000 0.000057 -0.002333 0.004934 +7821 1 0.000218 1560.000000 0.001302 0.001004 0.001530 +7822 1 0.000286 1560.000000 -0.003048 0.000305 0.009695 +7823 1 0.000259 1560.000000 -0.002214 -0.001208 0.006068 +7824 1 0.000211 1560.000000 -0.000752 0.002715 0.005608 +7825 1 0.000275 1560.000000 0.000607 -0.000449 0.009568 +7826 1 0.000245 1560.000000 -0.001193 -0.002156 0.008835 +7827 1 0.000215 1560.000000 -0.000082 -0.001747 0.001944 +7828 1 0.000281 1560.000000 0.002369 -0.002294 0.004512 +7829 1 0.000255 1560.000000 0.000194 0.002206 0.006592 +7830 1 0.000241 1560.000000 0.001955 -0.001864 0.008038 +7831 1 0.000226 1560.000000 0.001644 0.000815 0.009104 +7832 1 0.000215 1560.000000 -0.002175 0.000903 0.008387 +7833 1 0.000232 1560.000000 0.001470 0.000530 0.008118 +7834 1 0.000203 1560.000000 0.001097 0.002502 0.004659 +7835 1 0.000194 1560.000000 -0.002077 -0.002342 0.008446 +7836 1 0.000251 1560.000000 0.000817 -0.003357 0.007745 +7837 1 0.000261 1560.000000 0.000191 0.000124 0.000207 +7838 1 0.000201 1560.000000 -0.000359 0.001761 0.004752 +7839 1 0.000243 1560.000000 -0.001633 -0.000888 0.006085 +7840 1 0.000243 1560.000000 -0.001029 -0.003457 0.001876 +7841 1 0.000237 1560.000000 -0.003189 -0.000849 0.001389 +7842 1 0.000209 1560.000000 -0.002076 0.000664 0.008254 +7843 1 0.000223 1560.000000 -0.002068 0.000666 0.005624 +7844 1 0.000236 1560.000000 0.000409 0.002164 0.005560 +7845 1 0.000223 1560.000000 -0.001820 -0.001211 0.009690 +7846 1 0.000250 1560.000000 0.002630 -0.002739 0.001437 +7847 1 0.000192 1560.000000 0.003112 -0.001528 0.004440 +7848 1 0.000284 1560.000000 0.001414 -0.003574 0.004323 +7849 1 0.000217 1560.000000 0.000704 0.001263 0.009100 +7850 1 0.000240 1560.000000 0.000829 -0.003531 0.001593 +7851 1 0.000199 1560.000000 0.000187 -0.000200 0.006001 +7852 1 0.000240 1560.000000 0.002932 -0.000700 0.008081 +7853 1 0.000197 1560.000000 -0.002590 0.000479 0.006719 +7854 1 0.000217 1560.000000 -0.000372 0.002923 0.006035 +7855 1 0.000267 1560.000000 -0.001333 -0.003562 0.002762 +7856 1 0.000220 1560.000000 0.001216 -0.001556 0.005678 +7857 1 0.000202 1560.000000 -0.000619 -0.003664 0.002225 +7858 1 0.000234 1560.000000 0.000208 0.001850 0.004184 +7859 1 0.000240 1560.000000 0.001839 0.001596 0.003663 +7860 1 0.000216 1560.000000 0.002460 -0.001054 0.003303 +7861 1 0.000266 1560.000000 -0.003237 0.001023 0.007415 +7862 1 0.000230 1560.000000 -0.001305 0.000368 0.005591 +7863 1 0.000206 1560.000000 -0.002831 -0.002473 0.000872 +7864 1 0.000228 1560.000000 -0.000579 0.001143 0.003612 +7865 1 0.000203 1560.000000 0.002249 -0.001998 0.002630 +7866 1 0.000197 1560.000000 0.000522 0.003653 0.000782 +7867 1 0.000206 1560.000000 -0.000873 0.001345 0.009042 +7868 1 0.000255 1560.000000 0.001828 -0.003306 0.005215 +7869 1 0.000260 1560.000000 0.002414 0.000881 0.003082 +7870 1 0.000211 1560.000000 0.003014 0.001095 0.008874 +7871 1 0.000276 1560.000000 0.001676 -0.002349 0.002559 +7872 1 0.000229 1560.000000 -0.001542 -0.002103 0.001343 +7873 1 0.000223 1560.000000 0.000039 -0.002748 0.009466 +7874 1 0.000232 1560.000000 -0.002661 0.002490 0.005342 +7875 1 0.000275 1560.000000 -0.000387 0.003723 0.003068 +7876 1 0.000192 1560.000000 0.001300 0.001353 0.002761 +7877 1 0.000193 1560.000000 0.000468 0.001425 0.009229 +7878 1 0.000204 1560.000000 0.001076 0.001275 0.008259 +7879 1 0.000208 1560.000000 -0.001257 -0.001900 0.004880 +7880 1 0.000213 1560.000000 -0.002784 0.002588 0.003948 +7881 1 0.000275 1560.000000 0.001532 0.002439 0.005458 +7882 1 0.000233 1560.000000 0.000369 -0.002094 0.007039 +7883 1 0.000201 1560.000000 0.001142 -0.003236 0.008115 +7884 1 0.000198 1560.000000 -0.000857 0.000179 0.000706 +7885 1 0.000222 1560.000000 0.002565 -0.000517 0.008519 +7886 1 0.000234 1560.000000 -0.002917 -0.002297 0.002856 +7887 1 0.000243 1560.000000 -0.000715 -0.002083 0.004936 +7888 1 0.000227 1560.000000 -0.001102 -0.000569 0.000649 +7889 1 0.000232 1560.000000 0.001064 -0.000101 0.001899 +7890 1 0.000238 1560.000000 0.002173 -0.000291 0.003003 +7891 1 0.000286 1560.000000 -0.001021 -0.003417 0.005950 +7892 1 0.000242 1560.000000 -0.000975 -0.002848 0.003008 +7893 1 0.000245 1560.000000 -0.002590 -0.001134 0.003802 +7894 1 0.000253 1560.000000 0.001840 0.003202 0.008705 +7895 1 0.000200 1560.000000 -0.002123 0.002654 0.005949 +7896 1 0.000279 1560.000000 -0.000947 -0.002333 0.006158 +7897 1 0.000207 1560.000000 -0.000111 0.002073 0.007152 +7898 1 0.000219 1560.000000 -0.001284 0.000503 0.003565 +7899 1 0.000197 1560.000000 0.000483 -0.000411 0.003109 +7900 1 0.000216 1560.000000 -0.002876 0.000972 0.004802 +7901 1 0.000258 1560.000000 0.001562 0.001057 0.003135 +7902 1 0.000249 1560.000000 -0.001378 -0.002982 0.006011 +7903 1 0.000217 1560.000000 0.001766 0.001744 0.001402 +7904 1 0.000205 1560.000000 0.001143 0.003186 0.001963 +7905 1 0.000220 1560.000000 0.002664 0.002005 0.006771 +7906 1 0.000266 1560.000000 -0.002783 -0.000135 0.006932 +7907 1 0.000203 1560.000000 -0.000224 0.002208 0.001558 +7908 1 0.000263 1560.000000 -0.001286 -0.003221 0.007008 +7909 1 0.000286 1560.000000 -0.000642 -0.000695 0.002893 +7910 1 0.000238 1560.000000 0.000554 -0.002808 0.006761 +7911 1 0.000197 1560.000000 0.001016 0.000389 0.005098 +7912 1 0.000249 1560.000000 0.003039 -0.002161 0.000276 +7913 1 0.000198 1560.000000 -0.002151 -0.000018 0.007553 +7914 1 0.000231 1560.000000 -0.000784 -0.000907 0.003476 +7915 1 0.000248 1560.000000 0.001850 -0.003224 0.007713 +7916 1 0.000207 1560.000000 -0.001770 0.002545 0.000274 +7917 1 0.000213 1560.000000 0.000297 0.002544 0.007464 +7918 1 0.000195 1560.000000 -0.003483 0.000382 0.004571 +7919 1 0.000201 1560.000000 -0.002346 0.002676 0.000419 +7920 1 0.000211 1560.000000 0.001172 0.002372 0.000125 +7921 1 0.000210 1560.000000 0.000464 -0.000861 0.006602 +7922 1 0.000223 1560.000000 0.001854 -0.002646 0.005375 +7923 1 0.000237 1560.000000 -0.000912 0.003459 0.007181 +7924 1 0.000229 1560.000000 0.001888 -0.000791 0.008787 +7925 1 0.000217 1560.000000 -0.003491 -0.000992 0.006798 +7926 1 0.000221 1560.000000 0.000716 -0.000162 0.000175 +7927 1 0.000219 1560.000000 0.003680 -0.000264 0.006367 +7928 1 0.000240 1560.000000 0.000647 -0.003590 0.009667 +7929 1 0.000253 1560.000000 0.000049 -0.001421 0.005344 +7930 1 0.000264 1560.000000 0.000901 -0.003309 0.002343 +7931 1 0.000209 1560.000000 -0.001866 0.000816 0.009451 +7932 1 0.000259 1560.000000 -0.002526 0.001904 0.008477 +7933 1 0.000268 1560.000000 0.001038 -0.002642 0.007416 +7934 1 0.000269 1560.000000 0.002377 -0.000458 0.007921 +7935 1 0.000282 1560.000000 -0.002801 0.001523 0.007498 +7936 1 0.000275 1560.000000 0.000892 0.001087 0.007621 +7937 1 0.000232 1560.000000 -0.000397 0.003367 0.000376 +7938 1 0.000207 1560.000000 -0.000670 0.003239 0.003040 +7939 1 0.000206 1560.000000 -0.002294 -0.000661 0.009405 +7940 1 0.000218 1560.000000 0.001500 -0.002641 0.008015 +7941 1 0.000273 1560.000000 -0.002366 0.001722 0.003502 +7942 1 0.000253 1560.000000 0.003309 -0.000346 0.003905 +7943 1 0.000242 1560.000000 0.000850 -0.003245 0.005021 +7944 1 0.000231 1560.000000 0.000812 0.001194 0.002656 +7945 1 0.000200 1560.000000 -0.000333 -0.002247 0.004238 +7946 1 0.000244 1560.000000 0.000224 0.001761 0.002957 +7947 1 0.000287 1560.000000 0.002178 0.000256 0.009044 +7948 1 0.000274 1560.000000 0.000447 -0.001217 0.000968 +7949 1 0.000237 1560.000000 -0.001338 -0.002036 0.004350 +7950 1 0.000248 1560.000000 -0.003035 -0.001754 0.007919 +7951 1 0.000200 1560.000000 0.000990 -0.000761 0.000468 +7952 1 0.000237 1560.000000 -0.001547 -0.002287 0.004162 +7953 1 0.000217 1560.000000 0.001415 -0.003134 0.005377 +7954 1 0.000233 1560.000000 0.001599 -0.000016 0.005587 +7955 1 0.000240 1560.000000 -0.002309 0.002943 0.004028 +7956 1 0.000195 1560.000000 0.001580 -0.000754 0.000393 +7957 1 0.000219 1560.000000 0.001785 -0.000181 0.004601 +7958 1 0.000237 1560.000000 -0.000469 0.001838 0.008668 +7959 1 0.000258 1560.000000 -0.000532 0.001796 0.005763 +7960 1 0.000272 1560.000000 0.002636 -0.000254 0.007088 +7961 1 0.000228 1560.000000 0.000114 -0.003096 0.008648 +7962 1 0.000230 1560.000000 -0.001747 0.000396 0.008614 +7963 1 0.000282 1560.000000 0.001291 0.002729 0.008839 +7964 1 0.000227 1560.000000 -0.001583 -0.002073 0.003820 +7965 1 0.000222 1560.000000 -0.001630 0.002699 0.007376 +7966 1 0.000214 1560.000000 0.003740 0.000473 0.006494 +7967 1 0.000219 1560.000000 -0.000319 -0.002097 0.003645 +7968 1 0.000239 1560.000000 -0.002948 0.000045 0.003411 +7969 1 0.000200 1560.000000 0.001430 0.003414 0.002620 +7970 1 0.000244 1560.000000 0.001721 -0.001242 0.007379 +7971 1 0.000253 1560.000000 0.000052 0.003146 0.009712 +7972 1 0.000197 1560.000000 -0.000410 0.001788 0.002583 +7973 1 0.000287 1560.000000 -0.003268 -0.000183 0.006605 +7974 1 0.000272 1560.000000 0.002116 0.002252 0.009323 +7975 1 0.000230 1560.000000 0.002079 -0.002510 0.005792 +7976 1 0.000248 1560.000000 -0.000503 0.001795 0.009687 +7977 1 0.000214 1560.000000 -0.001559 -0.000735 0.007511 +7978 1 0.000217 1560.000000 -0.002473 -0.000721 0.004263 +7979 1 0.000196 1560.000000 -0.000702 0.003715 0.000529 +7980 1 0.000276 1560.000000 0.002164 -0.002980 0.001950 +7981 1 0.000211 1560.000000 -0.001513 0.000250 0.005034 +7982 1 0.000252 1560.000000 -0.003360 -0.001375 0.004119 +7983 1 0.000195 1560.000000 0.002251 0.001729 0.009302 +7984 1 0.000229 1560.000000 -0.000263 0.001873 0.006343 +7985 1 0.000280 1560.000000 -0.001341 -0.001891 0.009314 +7986 1 0.000201 1560.000000 0.001651 -0.002541 0.005587 +7987 1 0.000227 1560.000000 -0.002364 0.000362 0.009724 +7988 1 0.000230 1560.000000 -0.000937 0.001868 0.008821 +7989 1 0.000258 1560.000000 0.001205 0.002303 0.002576 +7990 1 0.000257 1560.000000 -0.001704 -0.002705 0.001004 +7991 1 0.000260 1560.000000 0.001976 0.002451 0.005804 +7992 1 0.000206 1560.000000 0.001163 -0.001070 0.000151 +7993 1 0.000210 1560.000000 -0.002537 -0.002485 0.005021 +7994 1 0.000238 1560.000000 0.002627 0.002045 0.003958 +7995 1 0.000286 1560.000000 -0.000298 -0.003227 0.004218 +7996 1 0.000233 1560.000000 -0.001265 0.002109 0.007701 +7997 1 0.000205 1560.000000 0.000262 -0.001135 0.004159 +7998 1 0.000223 1560.000000 0.001432 -0.000694 0.007260 +7999 1 0.000278 1560.000000 -0.001481 -0.003082 0.003834 +8000 1 0.000234 1560.000000 -0.002113 -0.000875 0.004189 +8001 1 0.000196 1560.000000 -0.001584 0.001761 0.004427 +8002 1 0.000194 1560.000000 -0.002501 -0.001153 0.003316 +8003 1 0.000260 1560.000000 0.000715 -0.001111 0.008262 +8004 1 0.000220 1560.000000 -0.003537 -0.000637 0.004569 +8005 1 0.000273 1560.000000 -0.000841 0.003381 0.005210 +8006 1 0.000224 1560.000000 0.002215 0.000564 0.000467 +8007 1 0.000252 1560.000000 -0.002608 0.002390 0.008043 +8008 1 0.000284 1560.000000 0.000522 -0.001847 0.004593 +8009 1 0.000210 1560.000000 0.001562 0.002211 0.006943 +8010 1 0.000198 1560.000000 -0.000440 0.002015 0.001603 +8011 1 0.000207 1560.000000 0.000660 0.001402 0.005471 +8012 1 0.000244 1560.000000 0.000762 -0.001195 0.001242 +8013 1 0.000259 1560.000000 -0.000714 0.001993 0.002508 +8014 1 0.000208 1560.000000 0.000552 -0.003105 0.003605 +8015 1 0.000278 1560.000000 -0.002452 -0.001251 0.006999 +8016 1 0.000244 1560.000000 0.000105 0.003439 0.001286 +8017 1 0.000224 1560.000000 -0.000111 0.003619 0.004071 +8018 1 0.000198 1560.000000 -0.001448 0.002566 0.001435 +8019 1 0.000271 1560.000000 0.002693 -0.002626 0.007646 +8020 1 0.000209 1560.000000 0.000745 -0.001348 0.001967 +8021 1 0.000211 1560.000000 -0.003292 0.001028 0.001280 +8022 1 0.000213 1560.000000 -0.002790 -0.001589 0.005890 +8023 1 0.000236 1560.000000 0.001912 -0.001234 0.001320 +8024 1 0.000214 1560.000000 -0.000058 -0.000151 0.006044 +8025 1 0.000267 1560.000000 -0.001734 -0.001662 0.000498 +8026 1 0.000246 1560.000000 -0.002724 -0.000855 0.009772 +8027 1 0.000234 1560.000000 0.001578 -0.002950 0.005218 +8028 1 0.000230 1560.000000 0.002977 -0.002001 0.004833 +8029 1 0.000279 1560.000000 0.000837 -0.003281 0.002885 +8030 1 0.000268 1560.000000 -0.000470 -0.000709 0.006707 +8031 1 0.000248 1560.000000 -0.001301 -0.001697 0.005982 +8032 1 0.000193 1560.000000 0.000727 -0.003327 0.001141 +8033 1 0.000194 1560.000000 0.003612 -0.000111 0.004672 +8034 1 0.000199 1560.000000 0.002345 0.002897 0.004096 +8035 1 0.000209 1560.000000 0.001699 0.001766 0.002607 +8036 1 0.000213 1560.000000 0.002775 0.001703 0.002618 +8037 1 0.000238 1560.000000 -0.000063 0.003482 0.005846 +8038 1 0.000209 1560.000000 0.002107 0.000835 0.008591 +8039 1 0.000210 1560.000000 -0.002928 0.001153 0.009140 +8040 1 0.000200 1560.000000 -0.000793 -0.000204 0.002530 +8041 1 0.000269 1560.000000 0.001407 0.002623 0.002170 +8042 1 0.000228 1560.000000 -0.002740 -0.001987 0.008518 +8043 1 0.000213 1560.000000 0.001752 0.001732 0.005527 +8044 1 0.000276 1560.000000 -0.001501 0.002766 0.007919 +8045 1 0.000231 1560.000000 0.003086 -0.000242 0.000486 +8046 1 0.000199 1560.000000 -0.001761 -0.000777 0.003129 +8047 1 0.000225 1560.000000 -0.002017 -0.001675 0.000409 +8048 1 0.000276 1560.000000 0.000534 0.002745 0.003326 +8049 1 0.000217 1560.000000 0.000364 0.001040 0.001078 +8050 1 0.000205 1560.000000 -0.001761 0.003144 0.000908 +8051 1 0.000206 1560.000000 -0.002063 -0.001982 0.004928 +8052 1 0.000276 1560.000000 0.002775 -0.002454 0.007947 +8053 1 0.000287 1560.000000 0.000275 0.002633 0.005442 +8054 1 0.000203 1560.000000 0.002471 -0.001979 0.001583 +8055 1 0.000257 1560.000000 0.002104 0.001977 0.005414 +8056 1 0.000270 1560.000000 0.001666 0.000930 0.005763 +8057 1 0.000246 1560.000000 0.003047 -0.000483 0.005474 +8058 1 0.000194 1560.000000 -0.000200 -0.001022 0.001827 +8059 1 0.000194 1560.000000 -0.003637 0.000295 0.005452 +8060 1 0.000273 1560.000000 0.001050 0.002525 0.004974 +8061 1 0.000197 1560.000000 -0.002353 0.001223 0.004096 +8062 1 0.000215 1560.000000 -0.002025 0.000611 0.003573 +8063 1 0.000236 1560.000000 -0.000317 -0.001497 0.009786 +8064 1 0.000252 1560.000000 -0.002978 -0.000021 0.001222 +8065 1 0.000202 1560.000000 0.001751 0.001972 0.007798 +8066 1 0.000211 1560.000000 -0.003400 -0.001190 0.008601 +8067 1 0.000255 1560.000000 0.003086 -0.001084 0.007679 +8068 1 0.000254 1560.000000 -0.001627 0.002675 0.003096 +8069 1 0.000230 1560.000000 0.001837 -0.001427 0.000929 +8070 1 0.000194 1560.000000 0.000109 0.001088 0.003940 +8071 1 0.000215 1560.000000 -0.003182 0.001236 0.004481 +8072 1 0.000270 1560.000000 -0.002622 -0.001044 0.001692 +8073 1 0.000214 1560.000000 -0.000416 -0.000301 0.009123 +8074 1 0.000288 1560.000000 -0.001772 -0.000678 0.009324 +8075 1 0.000269 1560.000000 -0.002319 -0.001303 0.000989 +8076 1 0.000268 1560.000000 0.001339 -0.002562 0.003098 +8077 1 0.000256 1560.000000 0.002614 -0.001548 0.007431 +8078 1 0.000256 1560.000000 -0.003559 0.000417 0.007372 +8079 1 0.000284 1560.000000 0.001981 0.002400 0.005330 +8080 1 0.000249 1560.000000 -0.001763 -0.000674 0.001861 +8081 1 0.000267 1560.000000 0.001400 -0.001368 0.002417 +8082 1 0.000241 1560.000000 -0.002715 0.002395 0.002322 +8083 1 0.000221 1560.000000 0.002020 0.000702 0.002840 +8084 1 0.000242 1560.000000 0.001478 0.001328 0.004301 +8085 1 0.000250 1560.000000 0.002579 0.002603 0.000282 +8086 1 0.000209 1560.000000 -0.000081 -0.000044 0.007516 +8087 1 0.000264 1560.000000 -0.001724 0.000972 0.000452 +8088 1 0.000209 1560.000000 0.000091 -0.002909 0.008117 +8089 1 0.000270 1560.000000 0.001287 0.000278 0.007677 +8090 1 0.000254 1560.000000 -0.000470 0.001789 0.000802 +8091 1 0.000207 1560.000000 -0.000171 0.003281 0.001967 +8092 1 0.000280 1560.000000 0.001623 0.002962 0.004669 +8093 1 0.000268 1560.000000 -0.000685 0.002706 0.003349 +8094 1 0.000261 1560.000000 0.000641 -0.000753 0.000649 +8095 1 0.000201 1560.000000 0.002759 -0.001297 0.003323 +8096 1 0.000201 1560.000000 0.000720 -0.002498 0.008349 +8097 1 0.000214 1560.000000 0.001308 -0.001875 0.009543 +8098 1 0.000262 1560.000000 0.002039 0.001850 0.008556 +8099 1 0.000240 1560.000000 0.003722 0.000307 0.000379 +8100 1 0.000271 1560.000000 0.003677 0.000172 0.001690 +8101 1 0.000214 1560.000000 -0.001099 0.001850 0.004811 +8102 1 0.000227 1560.000000 0.002858 -0.000226 0.003201 +8103 1 0.000236 1560.000000 -0.001328 -0.001935 0.003726 +8104 1 0.000216 1560.000000 0.000814 0.000880 0.008938 +8105 1 0.000201 1560.000000 0.002443 -0.001639 0.001011 +8106 1 0.000212 1560.000000 0.002726 -0.000336 0.001003 +8107 1 0.000202 1560.000000 0.002056 -0.001379 0.006781 +8108 1 0.000204 1560.000000 -0.000254 -0.003255 0.008110 +8109 1 0.000205 1560.000000 -0.000291 -0.000415 0.008257 +8110 1 0.000195 1560.000000 0.001789 -0.000340 0.007641 +8111 1 0.000247 1560.000000 0.003368 -0.001172 0.004792 +8112 1 0.000284 1560.000000 -0.000159 -0.000767 0.006849 +8113 1 0.000215 1560.000000 -0.003668 0.000996 0.002028 +8114 1 0.000198 1560.000000 0.001481 0.003292 0.005332 +8115 1 0.000224 1560.000000 -0.002711 0.002345 0.007641 +8116 1 0.000217 1560.000000 0.001181 0.000510 0.005244 +8117 1 0.000260 1560.000000 0.000344 -0.002307 0.002184 +8118 1 0.000207 1560.000000 -0.000776 -0.000363 0.009778 +8119 1 0.000229 1560.000000 -0.000695 -0.001862 0.006077 +8120 1 0.000261 1560.000000 0.002034 0.002241 0.006075 +8121 1 0.000207 1560.000000 -0.003416 -0.001546 0.007532 +8122 1 0.000248 1560.000000 -0.001969 0.000944 0.003981 +8123 1 0.000272 1560.000000 0.001153 0.000684 0.000785 +8124 1 0.000248 1560.000000 -0.002302 -0.000573 0.005867 +8125 1 0.000257 1560.000000 0.000097 -0.002575 0.006696 +8126 1 0.000230 1560.000000 0.001928 -0.001890 0.004718 +8127 1 0.000215 1560.000000 0.000448 -0.002506 0.000854 +8128 1 0.000198 1560.000000 0.002686 -0.001722 0.000741 +8129 1 0.000242 1560.000000 0.002190 0.000808 0.000332 +8130 1 0.000276 1560.000000 -0.001146 -0.002525 0.000417 +8131 1 0.000216 1560.000000 -0.002473 0.002476 0.007736 +8132 1 0.000237 1560.000000 0.001866 -0.000403 0.004867 +8133 1 0.000231 1560.000000 -0.001656 -0.002135 0.009666 +8134 1 0.000211 1560.000000 0.001048 0.002031 0.003812 +8135 1 0.000211 1560.000000 0.001042 -0.001528 0.007548 +8136 1 0.000193 1560.000000 -0.000750 -0.003447 0.002305 +8137 1 0.000282 1560.000000 -0.001821 0.000088 0.004207 +8138 1 0.000192 1560.000000 -0.000478 0.003697 0.008276 +8139 1 0.000197 1560.000000 -0.001911 -0.001606 0.003045 +8140 1 0.000220 1560.000000 0.000803 -0.000911 0.000895 +8141 1 0.000261 1560.000000 -0.002014 0.000308 0.009762 +8142 1 0.000265 1560.000000 -0.002316 0.003045 0.002528 +8143 1 0.000197 1560.000000 0.000987 -0.001220 0.009065 +8144 1 0.000196 1560.000000 -0.002274 -0.002727 0.001811 +8145 1 0.000207 1560.000000 -0.000714 -0.001822 0.007695 +8146 1 0.000207 1560.000000 0.002096 -0.000743 0.006354 +8147 1 0.000265 1560.000000 0.001276 0.001065 0.004415 +8148 1 0.000228 1560.000000 -0.001411 -0.000547 0.004979 +8149 1 0.000202 1560.000000 0.001640 0.001630 0.001003 +8150 1 0.000218 1560.000000 -0.002429 0.000427 0.001440 +8151 1 0.000207 1560.000000 -0.000180 -0.000921 0.000612 +8152 1 0.000282 1560.000000 0.001653 0.001019 0.004929 +8153 1 0.000278 1560.000000 0.002481 -0.000455 0.008812 +8154 1 0.000255 1560.000000 -0.000486 -0.001450 0.008028 +8155 1 0.000256 1560.000000 -0.001607 -0.001546 0.002572 +8156 1 0.000274 1560.000000 -0.001730 -0.000377 0.006691 +8157 1 0.000226 1560.000000 0.001627 -0.001307 0.004095 +8158 1 0.000202 1560.000000 0.001409 0.000086 0.008170 +8159 1 0.000245 1560.000000 -0.003116 0.000555 0.001021 +8160 1 0.000258 1560.000000 -0.002459 0.000991 0.009837 +8161 1 0.000282 1560.000000 -0.002511 -0.001693 0.002055 +8162 1 0.000266 1560.000000 0.000111 0.000740 0.002495 +8163 1 0.000251 1560.000000 0.000290 0.000461 0.009268 +8164 1 0.000202 1560.000000 0.002251 0.000297 0.001619 +8165 1 0.000201 1560.000000 -0.002499 -0.000218 0.008728 +8166 1 0.000226 1560.000000 0.003529 -0.001492 0.006670 +8167 1 0.000221 1560.000000 -0.001952 0.002208 0.007890 +8168 1 0.000275 1560.000000 -0.000259 0.001179 0.000931 +8169 1 0.000226 1560.000000 -0.001809 -0.002138 0.006596 +8170 1 0.000267 1560.000000 -0.002619 0.000323 0.008993 +8171 1 0.000228 1560.000000 0.003459 -0.001693 0.004437 +8172 1 0.000193 1560.000000 0.001284 0.001099 0.006806 +8173 1 0.000268 1560.000000 0.002055 0.002461 0.000577 +8174 1 0.000193 1560.000000 -0.003340 -0.001225 0.006591 +8175 1 0.000250 1560.000000 -0.001859 0.001318 0.000730 +8176 1 0.000205 1560.000000 -0.000174 0.002819 0.006121 +8177 1 0.000199 1560.000000 0.000918 -0.000940 0.006750 +8178 1 0.000261 1560.000000 -0.000635 0.000406 0.005099 +8179 1 0.000274 1560.000000 0.000434 0.000877 0.001306 +8180 1 0.000270 1560.000000 0.002957 -0.000830 0.000506 +8181 1 0.000264 1560.000000 -0.000965 0.001343 0.006349 +8182 1 0.000245 1560.000000 -0.002197 -0.002504 0.006040 +8183 1 0.000241 1560.000000 0.000673 -0.003695 0.004375 +8184 1 0.000248 1560.000000 0.000908 0.002656 0.003059 +8185 1 0.000256 1560.000000 -0.001509 -0.000384 0.006517 +8186 1 0.000204 1560.000000 0.002144 0.003132 0.005123 +8187 1 0.000220 1560.000000 0.002911 0.000737 0.004934 +8188 1 0.000226 1560.000000 0.001291 -0.001591 0.000208 +8189 1 0.000234 1560.000000 0.000326 -0.002779 0.006180 +8190 1 0.000203 1560.000000 -0.001956 0.002592 0.007818 +8191 1 0.000277 1560.000000 0.002157 0.000283 0.006116 +8192 1 0.000203 1560.000000 0.001324 0.001602 0.003605 +8193 1 0.000206 1560.000000 0.001238 -0.000840 0.009538 +8194 1 0.000277 1560.000000 -0.003372 0.001332 0.000205 +8195 1 0.000208 1560.000000 -0.002052 -0.000473 0.007358 +8196 1 0.000224 1560.000000 -0.002889 -0.000264 0.000893 +8197 1 0.000198 1560.000000 -0.000229 0.000118 0.006973 +8198 1 0.000249 1560.000000 -0.000857 -0.000783 0.001740 +8199 1 0.000266 1560.000000 -0.003754 -0.000716 0.008599 +8200 1 0.000246 1560.000000 -0.002563 0.001219 0.005438 +8201 1 0.000205 1560.000000 -0.001095 0.001967 0.007933 +8202 1 0.000245 1560.000000 -0.000566 -0.000516 0.006403 +8203 1 0.000259 1560.000000 0.003650 0.000012 0.002320 +8204 1 0.000228 1560.000000 -0.001984 -0.000022 0.005132 +8205 1 0.000219 1560.000000 -0.000161 -0.003638 0.006676 +8206 1 0.000216 1560.000000 -0.003396 0.001750 0.002865 +8207 1 0.000276 1560.000000 -0.002429 0.002201 0.009070 +8208 1 0.000199 1560.000000 -0.002733 0.000633 0.005199 +8209 1 0.000268 1560.000000 0.001145 -0.003250 0.009788 +8210 1 0.000255 1560.000000 0.002865 -0.000021 0.004847 +8211 1 0.000217 1560.000000 -0.002328 -0.002797 0.007408 +8212 1 0.000232 1560.000000 -0.001592 0.001466 0.002451 +8213 1 0.000201 1560.000000 0.003650 0.000142 0.005706 +8214 1 0.000210 1560.000000 0.000082 -0.003108 0.009101 +8215 1 0.000216 1560.000000 0.001776 0.001229 0.009526 +8216 1 0.000199 1560.000000 -0.001960 -0.000335 0.008354 +8217 1 0.000199 1560.000000 -0.000409 -0.002231 0.000772 +8218 1 0.000225 1560.000000 0.001689 0.002543 0.000334 +8219 1 0.000235 1560.000000 0.001077 0.000661 0.008266 +8220 1 0.000249 1560.000000 0.000744 0.003515 0.001308 +8221 1 0.000201 1560.000000 0.000639 0.001490 0.005856 +8222 1 0.000255 1560.000000 -0.003421 -0.001184 0.003306 +8223 1 0.000199 1560.000000 -0.000199 -0.000094 0.008132 +8224 1 0.000266 1560.000000 0.002004 0.003037 0.008225 +8225 1 0.000206 1560.000000 0.003793 0.000538 0.005219 +8226 1 0.000248 1560.000000 0.000137 -0.002431 0.003973 +8227 1 0.000209 1560.000000 -0.000359 -0.001499 0.004510 +8228 1 0.000238 1560.000000 0.002254 -0.002918 0.001370 +8229 1 0.000230 1560.000000 0.003734 -0.000359 0.004479 +8230 1 0.000192 1560.000000 -0.000970 0.002903 0.000178 +8231 1 0.000201 1560.000000 0.002236 -0.001940 0.005810 +8232 1 0.000260 1560.000000 -0.001839 -0.000179 0.009359 +8233 1 0.000277 1560.000000 -0.002657 0.002766 0.005195 +8234 1 0.000230 1560.000000 -0.000150 -0.002317 0.001936 +8235 1 0.000217 1560.000000 -0.002191 0.002540 0.007714 +8236 1 0.000211 1560.000000 -0.001472 -0.000278 0.004661 +8237 1 0.000240 1560.000000 -0.000754 0.003778 0.002478 +8238 1 0.000235 1560.000000 -0.002595 -0.001366 0.000945 +8239 1 0.000219 1560.000000 -0.001866 -0.002453 0.000474 +8240 1 0.000228 1560.000000 -0.001853 -0.000597 0.005892 +8241 1 0.000255 1560.000000 0.001081 0.003146 0.009156 +8242 1 0.000214 1560.000000 0.001990 -0.001087 0.007689 +8243 1 0.000213 1560.000000 -0.001191 -0.003326 0.006694 +8244 1 0.000206 1560.000000 0.002299 -0.001895 0.006026 +8245 1 0.000200 1560.000000 0.000735 -0.002494 0.003054 +8246 1 0.000275 1560.000000 -0.000918 -0.001958 0.009703 +8247 1 0.000267 1560.000000 -0.001502 -0.002733 0.002625 +8248 1 0.000209 1560.000000 -0.002204 -0.002800 0.000840 +8249 1 0.000275 1560.000000 0.001488 0.002390 0.000439 +8250 1 0.000212 1560.000000 0.002868 0.001524 0.008618 +8251 1 0.000279 1560.000000 -0.002244 -0.002637 0.002884 +8252 1 0.000231 1560.000000 0.002713 -0.002300 0.005741 +8253 1 0.000194 1560.000000 0.000103 0.003823 0.003689 +8254 1 0.000203 1560.000000 0.000452 0.000948 0.003351 +8255 1 0.000194 1560.000000 0.000689 -0.003257 0.003509 +8256 1 0.000199 1560.000000 0.000567 -0.002435 0.005657 +8257 1 0.000287 1560.000000 0.001286 0.000788 0.009813 +8258 1 0.000192 1560.000000 0.002200 -0.000441 0.007292 +8259 1 0.000277 1560.000000 0.001187 0.001712 0.002400 +8260 1 0.000275 1560.000000 -0.001950 -0.001888 0.005996 +8261 1 0.000245 1560.000000 -0.002743 -0.000072 0.006490 +8262 1 0.000199 1560.000000 0.001853 -0.002129 0.009540 +8263 1 0.000283 1560.000000 0.002111 0.001035 0.000533 +8264 1 0.000211 1560.000000 0.002769 0.001573 0.008881 +8265 1 0.000197 1560.000000 0.001407 0.000637 0.006043 +8266 1 0.000200 1560.000000 0.001885 -0.000709 0.002248 +8267 1 0.000271 1560.000000 0.001973 0.002918 0.009268 +8268 1 0.000250 1560.000000 -0.001385 0.000961 0.003837 +8269 1 0.000219 1560.000000 0.000108 0.001769 0.003750 +8270 1 0.000252 1560.000000 0.000139 0.002515 0.003298 +8271 1 0.000239 1560.000000 0.001015 0.003699 0.002371 +8272 1 0.000197 1560.000000 -0.000638 0.001709 0.004888 +8273 1 0.000235 1560.000000 0.001910 0.000717 0.006551 +8274 1 0.000287 1560.000000 -0.002661 0.002466 0.001570 +8275 1 0.000286 1560.000000 0.003701 -0.000524 0.006788 +8276 1 0.000278 1560.000000 -0.002175 0.002316 0.009106 +8277 1 0.000211 1560.000000 0.001066 0.002339 0.002779 +8278 1 0.000198 1560.000000 0.001008 0.002976 0.003438 +8279 1 0.000226 1560.000000 0.001930 0.003179 0.009422 +8280 1 0.000213 1560.000000 -0.001957 -0.003304 0.006685 +8281 1 0.000230 1560.000000 0.002621 -0.001610 0.005627 +8282 1 0.000259 1560.000000 -0.003564 0.000872 0.007129 +8283 1 0.000249 1560.000000 0.001931 -0.001745 0.007330 +8284 1 0.000267 1560.000000 0.002921 0.000982 0.009663 +8285 1 0.000199 1560.000000 0.000140 -0.002728 0.001196 +8286 1 0.000255 1560.000000 -0.001373 -0.000408 0.006872 +8287 1 0.000212 1560.000000 0.000097 0.002522 0.009128 +8288 1 0.000223 1560.000000 0.000657 -0.002531 0.001708 +8289 1 0.000257 1560.000000 0.002023 -0.000047 0.001990 +8290 1 0.000216 1560.000000 0.001283 0.002162 0.002274 +8291 1 0.000285 1560.000000 0.000099 0.003658 0.005060 +8292 1 0.000195 1560.000000 0.001713 0.001502 0.009112 +8293 1 0.000194 1560.000000 -0.001264 -0.001132 0.003851 +8294 1 0.000207 1560.000000 -0.000603 -0.000281 0.006913 +8295 1 0.000256 1560.000000 0.002836 0.002106 0.000934 +8296 1 0.000197 1560.000000 -0.000336 0.002191 0.002922 +8297 1 0.000270 1560.000000 -0.000383 -0.002118 0.001939 +8298 1 0.000256 1560.000000 -0.002478 -0.001978 0.002749 +8299 1 0.000273 1560.000000 0.003352 0.000160 0.009833 +8300 1 0.000196 1560.000000 -0.002728 0.000754 0.000259 +8301 1 0.000193 1560.000000 -0.002269 -0.002892 0.006471 +8302 1 0.000273 1560.000000 0.002328 0.002905 0.007484 +8303 1 0.000230 1560.000000 0.000031 -0.001416 0.002002 +8304 1 0.000253 1560.000000 -0.001458 -0.002085 0.000345 +8305 1 0.000223 1560.000000 -0.000009 -0.003167 0.001304 +8306 1 0.000260 1560.000000 0.003612 0.001332 0.007537 +8307 1 0.000271 1560.000000 -0.003330 0.000776 0.008623 +8308 1 0.000261 1560.000000 -0.002297 0.002973 0.001623 +8309 1 0.000264 1560.000000 -0.002873 -0.000793 0.003783 +8310 1 0.000204 1560.000000 0.000415 0.001711 0.002324 +8311 1 0.000249 1560.000000 -0.003322 -0.000537 0.002097 +8312 1 0.000257 1560.000000 -0.001665 -0.002589 0.003974 +8313 1 0.000253 1560.000000 -0.000102 -0.000941 0.002621 +8314 1 0.000219 1560.000000 0.001273 0.001195 0.000847 +8315 1 0.000214 1560.000000 -0.000302 0.001435 0.009476 +8316 1 0.000210 1560.000000 0.003285 -0.000686 0.006239 +8317 1 0.000230 1560.000000 0.001864 0.002333 0.009472 +8318 1 0.000252 1560.000000 0.001401 -0.001858 0.002549 +8319 1 0.000238 1560.000000 0.002809 -0.000338 0.009792 +8320 1 0.000207 1560.000000 -0.003036 -0.000332 0.001446 +8321 1 0.000240 1560.000000 0.003481 0.000390 0.007439 +8322 1 0.000253 1560.000000 0.002960 0.002166 0.008942 +8323 1 0.000202 1560.000000 0.002064 -0.000961 0.001553 +8324 1 0.000196 1560.000000 -0.000862 -0.003676 0.007257 +8325 1 0.000252 1560.000000 0.001647 -0.000581 0.008790 +8326 1 0.000214 1560.000000 0.000785 -0.001005 0.006354 +8327 1 0.000220 1560.000000 -0.002086 0.002661 0.001132 +8328 1 0.000214 1560.000000 -0.000287 -0.003845 0.008917 +8329 1 0.000248 1560.000000 -0.001540 -0.000568 0.001321 +8330 1 0.000281 1560.000000 -0.000951 0.001488 0.001211 +8331 1 0.000260 1560.000000 0.003536 -0.001249 0.003911 +8332 1 0.000250 1560.000000 -0.001526 0.001656 0.004804 +8333 1 0.000215 1560.000000 -0.003393 0.001383 0.005214 +8334 1 0.000258 1560.000000 -0.000900 0.003615 0.004958 +8335 1 0.000283 1560.000000 0.002754 0.000992 0.007562 +8336 1 0.000207 1560.000000 0.002889 0.001875 0.008174 +8337 1 0.000270 1560.000000 0.003683 -0.000958 0.005416 +8338 1 0.000235 1560.000000 0.000153 0.000844 0.003594 +8339 1 0.000255 1560.000000 -0.002719 0.001332 0.005746 +8340 1 0.000232 1560.000000 0.001799 -0.002831 0.002390 +8341 1 0.000217 1560.000000 -0.002044 0.002440 0.001922 +8342 1 0.000193 1560.000000 -0.000345 -0.002475 0.005856 +8343 1 0.000206 1560.000000 0.002065 0.002631 0.003509 +8344 1 0.000207 1560.000000 0.000237 -0.000685 0.009675 +8345 1 0.000194 1560.000000 0.003708 -0.000080 0.001933 +8346 1 0.000260 1560.000000 -0.001161 0.001008 0.002930 +8347 1 0.000240 1560.000000 0.000851 -0.002377 0.002350 +8348 1 0.000212 1560.000000 -0.001432 0.003576 0.002177 +8349 1 0.000229 1560.000000 -0.003552 0.000662 0.002717 +8350 1 0.000286 1560.000000 0.001908 -0.003067 0.003245 +8351 1 0.000228 1560.000000 0.002443 0.000854 0.006802 +8352 1 0.000204 1560.000000 0.000863 0.001946 0.000750 +8353 1 0.000214 1560.000000 -0.002365 -0.002491 0.005284 +8354 1 0.000263 1560.000000 -0.002214 0.000654 0.006622 +8355 1 0.000242 1560.000000 0.002389 -0.001947 0.007570 +8356 1 0.000221 1560.000000 0.001584 0.000609 0.008392 +8357 1 0.000281 1560.000000 -0.003521 0.000836 0.006496 +8358 1 0.000255 1560.000000 -0.002430 -0.000056 0.005430 +8359 1 0.000219 1560.000000 0.002830 0.000049 0.002298 +8360 1 0.000249 1560.000000 -0.000523 0.003743 0.009748 +8361 1 0.000201 1560.000000 -0.000267 -0.002933 0.006207 +8362 1 0.000254 1560.000000 -0.000739 0.000593 0.006996 +8363 1 0.000244 1560.000000 0.002735 0.000618 0.006173 +8364 1 0.000246 1560.000000 -0.001912 -0.000151 0.004056 +8365 1 0.000212 1560.000000 -0.000572 0.002790 0.004906 +8366 1 0.000241 1560.000000 -0.001004 0.001634 0.008895 +8367 1 0.000204 1560.000000 0.002361 -0.002870 0.002762 +8368 1 0.000220 1560.000000 0.000456 0.002647 0.006885 +8369 1 0.000196 1560.000000 0.002785 0.000054 0.005546 +8370 1 0.000251 1560.000000 -0.000564 0.000882 0.001353 +8371 1 0.000204 1560.000000 0.001602 -0.000703 0.004834 +8372 1 0.000250 1560.000000 -0.002191 -0.001620 0.007491 +8373 1 0.000193 1560.000000 -0.001788 0.003022 0.003084 +8374 1 0.000200 1560.000000 0.002043 -0.001710 0.002930 +8375 1 0.000246 1560.000000 -0.003382 0.000569 0.007493 +8376 1 0.000201 1560.000000 0.000721 -0.003721 0.001995 +8377 1 0.000288 1560.000000 -0.001518 0.003207 0.000452 +8378 1 0.000201 1560.000000 0.000559 -0.003752 0.001404 +8379 1 0.000277 1560.000000 0.002337 0.001976 0.000405 +8380 1 0.000209 1560.000000 0.000153 -0.000395 0.005445 +8381 1 0.000204 1560.000000 -0.000581 -0.000982 0.007573 +8382 1 0.000201 1560.000000 -0.000979 0.002669 0.007530 +8383 1 0.000209 1560.000000 0.000688 0.000185 0.001994 +8384 1 0.000204 1560.000000 0.002075 0.001905 0.009655 +8385 1 0.000228 1560.000000 -0.001328 -0.002432 0.003366 +8386 1 0.000252 1560.000000 -0.000508 -0.002861 0.000239 +8387 1 0.000196 1560.000000 -0.001336 0.002770 0.004196 +8388 1 0.000226 1560.000000 0.002670 -0.000675 0.001951 +8389 1 0.000228 1560.000000 -0.002048 0.002206 0.006302 +8390 1 0.000204 1560.000000 0.000943 -0.000315 0.004311 +8391 1 0.000210 1560.000000 0.002065 0.001216 0.007288 +8392 1 0.000242 1560.000000 0.001706 -0.001987 0.005054 +8393 1 0.000215 1560.000000 0.001495 0.002227 0.003656 +8394 1 0.000201 1560.000000 0.003560 0.000591 0.001013 +8395 1 0.000215 1560.000000 -0.002271 0.001079 0.006933 +8396 1 0.000203 1560.000000 0.000367 0.001554 0.004840 +8397 1 0.000240 1560.000000 -0.001685 0.003410 0.007898 +8398 1 0.000195 1560.000000 0.001479 0.000031 0.006694 +8399 1 0.000203 1560.000000 -0.000019 0.002589 0.005840 +8400 1 0.000231 1560.000000 0.002168 0.001195 0.006166 +8401 1 0.000218 1560.000000 0.000770 -0.001106 0.005802 +8402 1 0.000209 1560.000000 -0.001065 0.001650 0.004958 +8403 1 0.000229 1560.000000 -0.003471 -0.000814 0.004442 +8404 1 0.000218 1560.000000 0.000161 0.003043 0.000202 +8405 1 0.000202 1560.000000 -0.000155 -0.002228 0.000484 +8406 1 0.000214 1560.000000 0.003289 -0.000102 0.000284 +8407 1 0.000254 1560.000000 0.000054 -0.003552 0.001564 +8408 1 0.000203 1560.000000 0.000055 0.002728 0.002591 +8409 1 0.000206 1560.000000 0.000055 -0.003539 0.008008 +8410 1 0.000218 1560.000000 0.001695 0.002587 0.007232 +8411 1 0.000278 1560.000000 -0.001230 0.002051 0.001897 +8412 1 0.000207 1560.000000 -0.000377 -0.000102 0.004405 +8413 1 0.000216 1560.000000 -0.003593 0.000265 0.001161 +8414 1 0.000250 1560.000000 -0.001650 0.002280 0.003651 +8415 1 0.000220 1560.000000 0.001544 -0.000385 0.003177 +8416 1 0.000223 1560.000000 -0.002828 0.001460 0.004327 +8417 1 0.000205 1560.000000 0.001569 -0.002434 0.004418 +8418 1 0.000204 1560.000000 0.000971 -0.000838 0.004804 +8419 1 0.000251 1560.000000 -0.001883 -0.001344 0.002600 +8420 1 0.000233 1560.000000 0.003029 -0.001148 0.002977 +8421 1 0.000213 1560.000000 -0.003481 -0.001017 0.000710 +8422 1 0.000198 1560.000000 0.001438 0.000967 0.002352 +8423 1 0.000221 1560.000000 -0.002962 -0.000290 0.008430 +8424 1 0.000194 1560.000000 0.002315 0.000183 0.001169 +8425 1 0.000218 1560.000000 -0.002776 -0.000668 0.001432 +8426 1 0.000245 1560.000000 -0.002204 0.000905 0.008138 +8427 1 0.000257 1560.000000 0.001702 -0.002897 0.002877 +8428 1 0.000218 1560.000000 -0.000860 -0.000336 0.000280 +8429 1 0.000196 1560.000000 -0.000765 -0.001150 0.003503 +8430 1 0.000279 1560.000000 -0.002034 -0.003251 0.003309 +8431 1 0.000201 1560.000000 -0.001101 0.000930 0.005726 +8432 1 0.000271 1560.000000 -0.000999 0.001376 0.001532 +8433 1 0.000251 1560.000000 -0.000436 0.001703 0.006007 +8434 1 0.000229 1560.000000 0.001578 0.002151 0.002382 +8435 1 0.000202 1560.000000 -0.002658 0.000692 0.007855 +8436 1 0.000247 1560.000000 0.000412 -0.001704 0.005715 +8437 1 0.000249 1560.000000 0.003231 0.000253 0.004103 +8438 1 0.000202 1560.000000 -0.000530 0.000034 0.002222 +8439 1 0.000215 1560.000000 0.000314 0.002346 0.005106 +8440 1 0.000242 1560.000000 0.001779 0.003316 0.008263 +8441 1 0.000223 1560.000000 0.002637 0.001547 0.008016 +8442 1 0.000201 1560.000000 0.000898 0.001668 0.003057 +8443 1 0.000243 1560.000000 0.002409 -0.001677 0.007845 +8444 1 0.000244 1560.000000 -0.002283 -0.000733 0.009714 +8445 1 0.000213 1560.000000 -0.001141 0.000012 0.007860 +8446 1 0.000249 1560.000000 -0.003600 0.000806 0.003503 +8447 1 0.000236 1560.000000 0.000921 -0.001217 0.008438 +8448 1 0.000260 1560.000000 -0.000326 0.003071 0.001273 +8449 1 0.000259 1560.000000 -0.002506 -0.000303 0.006132 +8450 1 0.000261 1560.000000 -0.000186 0.002162 0.000534 +8451 1 0.000236 1560.000000 0.002730 0.000261 0.004540 +8452 1 0.000274 1560.000000 0.001697 0.002505 0.003606 +8453 1 0.000274 1560.000000 0.001642 -0.000680 0.007040 +8454 1 0.000234 1560.000000 -0.001577 0.002259 0.006555 +8455 1 0.000284 1560.000000 0.001182 -0.002904 0.006324 +8456 1 0.000193 1560.000000 0.002009 0.000310 0.004507 +8457 1 0.000196 1560.000000 0.000146 0.002597 0.008078 +8458 1 0.000211 1560.000000 0.000857 0.000305 0.007167 +8459 1 0.000226 1560.000000 0.001227 -0.001064 0.006901 +8460 1 0.000217 1560.000000 -0.000839 -0.003251 0.002087 +8461 1 0.000221 1560.000000 0.000997 0.000251 0.000663 +8462 1 0.000226 1560.000000 -0.001178 0.001033 0.004213 +8463 1 0.000276 1560.000000 0.002647 -0.001462 0.004758 +8464 1 0.000280 1560.000000 -0.002346 0.000692 0.001727 +8465 1 0.000243 1560.000000 0.001141 -0.002581 0.002095 +8466 1 0.000218 1560.000000 -0.001243 0.003348 0.001568 +8467 1 0.000271 1560.000000 0.000745 0.002324 0.003864 +8468 1 0.000204 1560.000000 0.001482 0.003463 0.003101 +8469 1 0.000268 1560.000000 -0.000521 0.001491 0.007491 +8470 1 0.000274 1560.000000 -0.002448 -0.000785 0.004705 +8471 1 0.000196 1560.000000 -0.001044 -0.000564 0.004124 +8472 1 0.000205 1560.000000 -0.001810 0.002191 0.006467 +8473 1 0.000274 1560.000000 -0.003693 0.000208 0.006769 +8474 1 0.000229 1560.000000 -0.002397 -0.001573 0.005354 +8475 1 0.000225 1560.000000 0.000830 -0.001973 0.009039 +8476 1 0.000217 1560.000000 0.002855 0.001233 0.001187 +8477 1 0.000248 1560.000000 0.003010 0.001164 0.008495 +8478 1 0.000231 1560.000000 -0.002414 -0.002136 0.003423 +8479 1 0.000201 1560.000000 0.001476 -0.000288 0.006391 +8480 1 0.000215 1560.000000 -0.000737 0.002516 0.009021 +8481 1 0.000275 1560.000000 -0.002198 -0.000170 0.000199 +8482 1 0.000221 1560.000000 -0.001193 -0.003514 0.001651 +8483 1 0.000287 1560.000000 0.000830 -0.002998 0.000702 +8484 1 0.000251 1560.000000 0.000291 -0.000213 0.006452 +8485 1 0.000196 1560.000000 -0.001753 0.002186 0.009646 +8486 1 0.000226 1560.000000 0.002475 -0.000705 0.002068 +8487 1 0.000259 1560.000000 0.000387 -0.000709 0.006352 +8488 1 0.000238 1560.000000 -0.001029 -0.001458 0.008834 +8489 1 0.000270 1560.000000 -0.002702 -0.002288 0.001944 +8490 1 0.000231 1560.000000 -0.000824 -0.001862 0.008145 +8491 1 0.000207 1560.000000 0.003132 0.000197 0.002618 +8492 1 0.000207 1560.000000 -0.000763 0.000384 0.009144 +8493 1 0.000225 1560.000000 0.001272 0.003473 0.003629 +8494 1 0.000229 1560.000000 -0.003708 -0.000287 0.004281 +8495 1 0.000201 1560.000000 0.000583 -0.002157 0.007062 +8496 1 0.000221 1560.000000 0.001789 -0.001333 0.005117 +8497 1 0.000213 1560.000000 0.000565 0.003434 0.002128 +8498 1 0.000217 1560.000000 0.002402 0.001051 0.009386 +8499 1 0.000258 1560.000000 0.002738 0.000079 0.006255 +8500 1 0.000270 1560.000000 -0.001648 0.001955 0.005472 +8501 1 0.000202 1560.000000 -0.002294 -0.002041 0.000367 +8502 1 0.000227 1560.000000 0.002406 0.002623 0.004789 +8503 1 0.000260 1560.000000 -0.001450 0.001027 0.001050 +8504 1 0.000246 1560.000000 0.001834 0.002972 0.005045 +8505 1 0.000226 1560.000000 -0.000588 0.003137 0.006129 +8506 1 0.000212 1560.000000 -0.000399 -0.001226 0.009811 +8507 1 0.000245 1560.000000 0.002384 -0.001617 0.002941 +8508 1 0.000280 1560.000000 -0.001220 0.000510 0.008574 +8509 1 0.000240 1560.000000 -0.001041 0.003533 0.000691 +8510 1 0.000256 1560.000000 -0.003178 0.000983 0.006560 +8511 1 0.000281 1560.000000 -0.001109 -0.000170 0.005577 +8512 1 0.000231 1560.000000 0.002092 0.001384 0.008406 +8513 1 0.000271 1560.000000 -0.001360 -0.001305 0.000992 +8514 1 0.000213 1560.000000 0.001616 0.000716 0.001260 +8515 1 0.000259 1560.000000 0.003438 -0.000689 0.005626 +8516 1 0.000251 1560.000000 -0.001773 0.001287 0.008445 +8517 1 0.000210 1560.000000 -0.000284 -0.001925 0.003153 +8518 1 0.000222 1560.000000 -0.001842 0.001154 0.008843 +8519 1 0.000214 1560.000000 -0.000147 0.000886 0.005464 +8520 1 0.000239 1560.000000 -0.000530 0.001425 0.004324 +8521 1 0.000210 1560.000000 0.001957 0.001815 0.007666 +8522 1 0.000283 1560.000000 -0.002287 0.003049 0.009549 +8523 1 0.000209 1560.000000 0.002216 0.000237 0.000792 +8524 1 0.000200 1560.000000 -0.001139 0.001792 0.002271 +8525 1 0.000282 1560.000000 -0.000090 0.002901 0.006556 +8526 1 0.000196 1560.000000 0.000305 0.001023 0.006298 +8527 1 0.000230 1560.000000 -0.002228 -0.001581 0.005883 +8528 1 0.000280 1560.000000 -0.000150 -0.001605 0.000817 +8529 1 0.000280 1560.000000 0.000096 0.003243 0.007049 +8530 1 0.000203 1560.000000 -0.003404 0.001132 0.000714 +8531 1 0.000232 1560.000000 -0.001105 -0.001796 0.007235 +8532 1 0.000200 1560.000000 0.002683 -0.001727 0.001215 +8533 1 0.000225 1560.000000 0.001544 -0.000798 0.007628 +8534 1 0.000207 1560.000000 -0.000946 -0.003096 0.006228 +8535 1 0.000194 1560.000000 -0.000394 -0.002418 0.004056 +8536 1 0.000263 1560.000000 -0.001131 0.001341 0.008097 +8537 1 0.000224 1560.000000 -0.002631 0.000408 0.004311 +8538 1 0.000207 1560.000000 0.000291 0.001831 0.006034 +8539 1 0.000215 1560.000000 -0.000522 -0.000580 0.002353 +8540 1 0.000230 1560.000000 -0.001771 0.000296 0.000319 +8541 1 0.000237 1560.000000 0.002359 0.000074 0.008405 +8542 1 0.000242 1560.000000 0.000689 0.003271 0.007847 +8543 1 0.000288 1560.000000 0.001547 -0.001113 0.006898 +8544 1 0.000264 1560.000000 0.003690 -0.000789 0.000514 +8545 1 0.000219 1560.000000 0.002243 0.001187 0.007034 +8546 1 0.000204 1560.000000 -0.003690 0.000556 0.000487 +8547 1 0.000220 1560.000000 -0.001987 -0.002475 0.001615 +8548 1 0.000241 1560.000000 -0.001537 0.001101 0.009528 +8549 1 0.000215 1560.000000 0.002769 0.001981 0.007266 +8550 1 0.000203 1560.000000 0.000693 0.001963 0.006551 +8551 1 0.000277 1560.000000 -0.000380 0.002430 0.009448 +8552 1 0.000250 1560.000000 -0.002620 -0.001838 0.004956 +8553 1 0.000225 1560.000000 -0.001033 0.003586 0.005759 +8554 1 0.000277 1560.000000 0.001505 0.001536 0.009653 +8555 1 0.000252 1560.000000 -0.001995 0.000917 0.000371 +8556 1 0.000198 1560.000000 0.001343 -0.001888 0.008562 +8557 1 0.000212 1560.000000 -0.002601 0.001581 0.001642 +8558 1 0.000228 1560.000000 0.002829 0.000646 0.001505 +8559 1 0.000222 1560.000000 -0.000765 0.000620 0.003057 +8560 1 0.000199 1560.000000 0.002027 -0.002746 0.004885 +8561 1 0.000215 1560.000000 0.003821 -0.000290 0.007667 +8562 1 0.000259 1560.000000 0.000850 -0.002336 0.000160 +8563 1 0.000246 1560.000000 0.002967 0.000355 0.003846 +8564 1 0.000232 1560.000000 0.001265 0.001382 0.006891 +8565 1 0.000226 1560.000000 0.003452 -0.000637 0.008320 +8566 1 0.000225 1560.000000 0.001679 0.002901 0.005367 +8567 1 0.000265 1560.000000 0.003793 0.000382 0.006008 +8568 1 0.000202 1560.000000 -0.000298 0.002127 0.004666 +8569 1 0.000195 1560.000000 0.000123 -0.000198 0.004842 +8570 1 0.000275 1560.000000 0.001864 0.000200 0.009834 +8571 1 0.000193 1560.000000 -0.003492 0.000650 0.001744 +8572 1 0.000271 1560.000000 0.001769 0.002687 0.001161 +8573 1 0.000195 1560.000000 0.001729 0.001764 0.008133 +8574 1 0.000247 1560.000000 0.000923 -0.002252 0.005840 +8575 1 0.000221 1560.000000 -0.001590 0.000897 0.009081 +8576 1 0.000214 1560.000000 0.001003 -0.001647 0.000194 +8577 1 0.000213 1560.000000 0.001740 0.001907 0.007573 +8578 1 0.000241 1560.000000 -0.000407 0.002817 0.008652 +8579 1 0.000265 1560.000000 0.000557 -0.002021 0.005569 +8580 1 0.000197 1560.000000 0.002463 -0.001370 0.005016 +8581 1 0.000241 1560.000000 0.002967 0.001876 0.008853 +8582 1 0.000286 1560.000000 0.001869 -0.001521 0.003432 +8583 1 0.000216 1560.000000 0.000435 -0.002248 0.009473 +8584 1 0.000209 1560.000000 0.001149 0.001721 0.003478 +8585 1 0.000229 1560.000000 -0.000562 0.003777 0.004894 +8586 1 0.000244 1560.000000 -0.003366 -0.001479 0.006011 +8587 1 0.000251 1560.000000 -0.000472 -0.003103 0.005029 +8588 1 0.000219 1560.000000 -0.000669 -0.003066 0.006989 +8589 1 0.000209 1560.000000 -0.002462 -0.001320 0.006159 +8590 1 0.000277 1560.000000 0.002381 -0.001495 0.008911 +8591 1 0.000199 1560.000000 -0.000252 0.003643 0.004910 +8592 1 0.000234 1560.000000 0.002725 0.002672 0.003976 +8593 1 0.000267 1560.000000 -0.002262 0.003087 0.009214 +8594 1 0.000218 1560.000000 0.000767 -0.001904 0.000473 +8595 1 0.000242 1560.000000 -0.002041 -0.001169 0.005142 +8596 1 0.000196 1560.000000 0.000639 0.001817 0.004409 +8597 1 0.000199 1560.000000 -0.000225 -0.001028 0.005869 +8598 1 0.000257 1560.000000 0.003590 0.000004 0.001315 +8599 1 0.000238 1560.000000 -0.001228 -0.001701 0.000386 +8600 1 0.000205 1560.000000 0.000195 0.002346 0.008220 +8601 1 0.000234 1560.000000 -0.001590 -0.000047 0.005051 +8602 1 0.000206 1560.000000 0.001816 0.001814 0.003893 +8603 1 0.000229 1560.000000 0.002206 -0.002986 0.006539 +8604 1 0.000208 1560.000000 0.001570 0.000470 0.002329 +8605 1 0.000208 1560.000000 0.002682 0.001293 0.002661 +8606 1 0.000272 1560.000000 0.003467 0.000560 0.005353 +8607 1 0.000244 1560.000000 -0.000514 -0.001224 0.002238 +8608 1 0.000248 1560.000000 -0.003215 0.000760 0.001170 +8609 1 0.000196 1560.000000 -0.000494 0.001110 0.008947 +8610 1 0.000209 1560.000000 -0.000215 -0.001443 0.001032 +8611 1 0.000217 1560.000000 0.000812 -0.002523 0.007344 +8612 1 0.000217 1560.000000 -0.003158 -0.001610 0.002152 +8613 1 0.000285 1560.000000 0.001595 0.001421 0.005214 +8614 1 0.000241 1560.000000 -0.001284 -0.001930 0.007493 +8615 1 0.000256 1560.000000 0.001985 -0.000210 0.009624 +8616 1 0.000242 1560.000000 0.001915 0.000316 0.007166 +8617 1 0.000202 1560.000000 0.001279 -0.000050 0.006400 +8618 1 0.000271 1560.000000 -0.002480 -0.000422 0.000697 +8619 1 0.000234 1560.000000 -0.000643 0.002217 0.001633 +8620 1 0.000215 1560.000000 -0.000206 0.001883 0.005750 +8621 1 0.000272 1560.000000 -0.002006 -0.001113 0.005669 +8622 1 0.000220 1560.000000 0.000449 -0.003110 0.004925 +8623 1 0.000261 1560.000000 0.001064 -0.003575 0.004928 +8624 1 0.000211 1560.000000 0.000392 -0.001277 0.007246 +8625 1 0.000218 1560.000000 -0.001954 0.002607 0.008223 +8626 1 0.000194 1560.000000 -0.003124 0.002011 0.001598 +8627 1 0.000199 1560.000000 0.000000 0.002330 0.004319 +8628 1 0.000230 1560.000000 -0.001309 0.001876 0.006231 +8629 1 0.000224 1560.000000 -0.001157 0.002100 0.003298 +8630 1 0.000202 1560.000000 -0.001208 -0.002079 0.003104 +8631 1 0.000208 1560.000000 0.003032 0.000218 0.005008 +8632 1 0.000203 1560.000000 -0.003117 0.002182 0.002127 +8633 1 0.000199 1560.000000 -0.000487 0.000177 0.004713 +8634 1 0.000276 1560.000000 -0.001484 -0.002808 0.004009 +8635 1 0.000222 1560.000000 0.001632 0.003113 0.009041 +8636 1 0.000204 1560.000000 0.000689 -0.002654 0.007046 +8637 1 0.000205 1560.000000 0.002329 -0.001778 0.005463 +8638 1 0.000262 1560.000000 -0.000449 0.003309 0.000784 +8639 1 0.000268 1560.000000 0.002271 0.000549 0.006530 +8640 1 0.000267 1560.000000 0.001825 0.002977 0.003655 +8641 1 0.000277 1560.000000 -0.001491 -0.001572 0.009248 +8642 1 0.000287 1560.000000 0.002097 -0.001467 0.004488 +8643 1 0.000199 1560.000000 0.003140 -0.001828 0.004018 +8644 1 0.000239 1560.000000 0.000341 -0.001348 0.007832 +8645 1 0.000269 1560.000000 0.000040 0.002128 0.006074 +8646 1 0.000198 1560.000000 0.001931 -0.000695 0.004837 +8647 1 0.000225 1560.000000 0.001606 -0.002938 0.008658 +8648 1 0.000223 1560.000000 0.001112 -0.000795 0.005974 +8649 1 0.000257 1560.000000 0.000751 0.002133 0.001022 +8650 1 0.000210 1560.000000 0.002407 -0.000384 0.000738 +8651 1 0.000198 1560.000000 -0.002431 0.002770 0.008086 +8652 1 0.000208 1560.000000 0.000576 0.003587 0.007470 +8653 1 0.000194 1560.000000 0.002812 0.000936 0.003297 +8654 1 0.000201 1560.000000 -0.002344 -0.000293 0.002087 +8655 1 0.000234 1560.000000 0.001103 -0.000389 0.004086 +8656 1 0.000214 1560.000000 -0.002410 -0.002441 0.004115 +8657 1 0.000260 1560.000000 0.001551 0.000847 0.003602 +8658 1 0.000277 1560.000000 -0.001631 -0.000846 0.005317 +8659 1 0.000233 1560.000000 -0.003142 -0.001933 0.002509 +8660 1 0.000206 1560.000000 0.003284 0.001074 0.007974 +8661 1 0.000199 1560.000000 -0.000876 0.001067 0.007956 +8662 1 0.000217 1560.000000 -0.000544 0.000191 0.007917 +8663 1 0.000224 1560.000000 0.002336 -0.002015 0.009672 +8664 1 0.000243 1560.000000 0.002373 0.002879 0.006606 +8665 1 0.000258 1560.000000 -0.002752 -0.000182 0.004309 +8666 1 0.000246 1560.000000 0.000547 0.001940 0.008179 +8667 1 0.000205 1560.000000 -0.001204 0.000983 0.005302 +8668 1 0.000204 1560.000000 0.000808 -0.001917 0.001866 +8669 1 0.000194 1560.000000 0.001801 -0.001010 0.002297 +8670 1 0.000200 1560.000000 -0.000121 0.001327 0.006508 +8671 1 0.000225 1560.000000 -0.002010 -0.002649 0.002156 +8672 1 0.000260 1560.000000 0.001769 -0.002508 0.000801 +8673 1 0.000198 1560.000000 -0.002672 -0.002150 0.004100 +8674 1 0.000288 1560.000000 0.000917 0.001567 0.002658 +8675 1 0.000257 1560.000000 0.002006 0.001959 0.002680 +8676 1 0.000274 1560.000000 0.001951 0.000834 0.008060 +8677 1 0.000226 1560.000000 0.001447 0.001730 0.005810 +8678 1 0.000237 1560.000000 -0.000107 0.002636 0.008076 +8679 1 0.000222 1560.000000 -0.002010 0.000783 0.006148 +8680 1 0.000252 1560.000000 -0.000798 -0.000658 0.008008 +8681 1 0.000193 1560.000000 0.000646 -0.000745 0.007321 +8682 1 0.000235 1560.000000 -0.000976 -0.000111 0.003081 +8683 1 0.000245 1560.000000 -0.000535 0.001561 0.003403 +8684 1 0.000235 1560.000000 0.000650 0.000952 0.007084 +8685 1 0.000234 1560.000000 -0.002848 0.000632 0.009575 +8686 1 0.000223 1560.000000 -0.002443 -0.000196 0.005902 +8687 1 0.000213 1560.000000 0.000110 0.000002 0.003602 +8688 1 0.000196 1560.000000 0.000380 0.003256 0.008667 +8689 1 0.000193 1560.000000 -0.000566 -0.002927 0.000769 +8690 1 0.000287 1560.000000 0.002700 0.002044 0.003511 +8691 1 0.000248 1560.000000 -0.000539 0.002357 0.008703 +8692 1 0.000277 1560.000000 0.003307 -0.000854 0.009297 +8693 1 0.000222 1560.000000 -0.002107 -0.003099 0.009167 +8694 1 0.000206 1560.000000 0.000682 -0.001021 0.001824 +8695 1 0.000193 1560.000000 -0.002233 0.003122 0.005466 +8696 1 0.000210 1560.000000 0.001104 -0.001873 0.006139 +8697 1 0.000233 1560.000000 0.000045 -0.000646 0.008584 +8698 1 0.000220 1560.000000 -0.002853 -0.001496 0.004787 +8699 1 0.000218 1560.000000 0.000743 0.001976 0.002501 +8700 1 0.000220 1560.000000 -0.001637 0.003482 0.004897 +8701 1 0.000258 1560.000000 0.002250 -0.000323 0.008252 +8702 1 0.000225 1560.000000 0.002759 -0.000612 0.001650 +8703 1 0.000249 1560.000000 0.001269 -0.001886 0.001258 +8704 1 0.000281 1560.000000 -0.000601 -0.002513 0.003794 +8705 1 0.000266 1560.000000 0.002513 -0.001215 0.006391 +8706 1 0.000208 1560.000000 -0.003324 -0.001695 0.001110 +8707 1 0.000220 1560.000000 0.000286 0.001816 0.007205 +8708 1 0.000284 1560.000000 -0.001887 -0.001089 0.004544 +8709 1 0.000249 1560.000000 -0.000819 -0.000149 0.006082 +8710 1 0.000282 1560.000000 -0.003270 0.001756 0.007131 +8711 1 0.000270 1560.000000 0.001102 -0.001882 0.002467 +8712 1 0.000208 1560.000000 0.001507 -0.003085 0.003946 +8713 1 0.000214 1560.000000 -0.000767 -0.001645 0.000373 +8714 1 0.000244 1560.000000 0.002372 -0.000773 0.008701 +8715 1 0.000207 1560.000000 0.000619 -0.002158 0.009572 +8716 1 0.000239 1560.000000 -0.001363 -0.000133 0.000791 +8717 1 0.000261 1560.000000 -0.001518 0.002537 0.001045 +8718 1 0.000200 1560.000000 0.002697 -0.001115 0.003227 +8719 1 0.000221 1560.000000 0.002865 0.002148 0.005855 +8720 1 0.000244 1560.000000 0.002711 -0.001597 0.004162 +8721 1 0.000219 1560.000000 0.000476 -0.001159 0.004206 +8722 1 0.000221 1560.000000 -0.001869 -0.000671 0.007830 +8723 1 0.000223 1560.000000 -0.000460 -0.003264 0.001932 +8724 1 0.000193 1560.000000 0.003686 -0.000339 0.009190 +8725 1 0.000216 1560.000000 -0.000572 -0.001856 0.009712 +8726 1 0.000219 1560.000000 -0.000574 0.001431 0.009433 +8727 1 0.000218 1560.000000 0.002523 -0.000030 0.003764 +8728 1 0.000255 1560.000000 -0.003032 -0.002330 0.002360 +8729 1 0.000208 1560.000000 -0.000653 -0.001511 0.004499 +8730 1 0.000249 1560.000000 -0.002569 0.002359 0.009641 +8731 1 0.000234 1560.000000 0.002456 0.001219 0.008567 +8732 1 0.000196 1560.000000 -0.002715 -0.000931 0.002132 +8733 1 0.000210 1560.000000 -0.002177 0.001087 0.000214 +8734 1 0.000210 1560.000000 0.001206 0.002963 0.003568 +8735 1 0.000224 1560.000000 0.000935 -0.001763 0.002071 +8736 1 0.000201 1560.000000 -0.002890 0.000417 0.004585 +8737 1 0.000248 1560.000000 0.000223 -0.001062 0.005241 +8738 1 0.000246 1560.000000 0.001538 0.000359 0.001763 +8739 1 0.000202 1560.000000 -0.001529 -0.001895 0.003007 +8740 1 0.000239 1560.000000 0.002479 0.002802 0.002816 +8741 1 0.000237 1560.000000 -0.002191 0.001833 0.004275 +8742 1 0.000219 1560.000000 0.001797 -0.001645 0.008515 +8743 1 0.000229 1560.000000 0.002594 -0.002296 0.001869 +8744 1 0.000219 1560.000000 -0.000103 0.001915 0.002558 +8745 1 0.000225 1560.000000 0.000349 -0.000814 0.004213 +8746 1 0.000249 1560.000000 -0.000686 0.002781 0.000811 +8747 1 0.000221 1560.000000 0.000229 0.003356 0.000856 +8748 1 0.000232 1560.000000 0.003536 -0.000612 0.007119 +8749 1 0.000229 1560.000000 -0.000340 -0.002777 0.000492 +8750 1 0.000245 1560.000000 -0.000518 -0.003056 0.008037 +8751 1 0.000283 1560.000000 0.002093 0.003114 0.007536 +8752 1 0.000236 1560.000000 -0.001649 -0.001443 0.009446 +8753 1 0.000253 1560.000000 -0.002946 0.001592 0.000169 +8754 1 0.000209 1560.000000 -0.001295 -0.002691 0.006913 +8755 1 0.000286 1560.000000 0.003735 -0.000481 0.008815 +8756 1 0.000198 1560.000000 -0.001746 0.000188 0.006886 +8757 1 0.000219 1560.000000 0.001211 -0.000083 0.004613 +8758 1 0.000217 1560.000000 0.001424 -0.001933 0.001039 +8759 1 0.000257 1560.000000 -0.002824 0.002484 0.008678 +8760 1 0.000228 1560.000000 0.003012 0.001889 0.002498 +8761 1 0.000215 1560.000000 0.002375 0.000688 0.003571 +8762 1 0.000201 1560.000000 -0.000039 -0.002081 0.001567 +8763 1 0.000222 1560.000000 0.003179 0.000687 0.005833 +8764 1 0.000193 1560.000000 -0.002761 -0.001508 0.004534 +8765 1 0.000216 1560.000000 -0.002855 -0.000547 0.006080 +8766 1 0.000227 1560.000000 -0.000221 0.001488 0.001567 +8767 1 0.000194 1560.000000 0.000840 -0.000184 0.009253 +8768 1 0.000272 1560.000000 -0.003158 -0.000210 0.000724 +8769 1 0.000195 1560.000000 0.001135 0.002277 0.006663 +8770 1 0.000222 1560.000000 -0.002558 0.002253 0.008586 +8771 1 0.000264 1560.000000 0.001098 -0.002427 0.007016 +8772 1 0.000241 1560.000000 -0.000365 -0.003429 0.006489 +8773 1 0.000209 1560.000000 -0.001589 0.001754 0.000673 +8774 1 0.000238 1560.000000 -0.003124 -0.000602 0.000178 +8775 1 0.000287 1560.000000 -0.001695 -0.003276 0.008737 +8776 1 0.000285 1560.000000 0.000065 -0.002327 0.001771 +8777 1 0.000202 1560.000000 0.001906 0.000741 0.000449 +8778 1 0.000248 1560.000000 0.003798 -0.000441 0.003723 +8779 1 0.000211 1560.000000 0.002253 0.003087 0.006072 +8780 1 0.000273 1560.000000 -0.000500 0.003329 0.002670 +8781 1 0.000201 1560.000000 0.002799 -0.000804 0.003810 +8782 1 0.000251 1560.000000 0.002228 0.000195 0.005795 +8783 1 0.000219 1560.000000 -0.000038 0.000332 0.009756 +8784 1 0.000242 1560.000000 -0.002601 -0.000168 0.000864 +8785 1 0.000268 1560.000000 -0.001543 0.002418 0.006311 +8786 1 0.000246 1560.000000 -0.001241 -0.002648 0.008553 +8787 1 0.000229 1560.000000 0.002404 -0.000666 0.007148 +8788 1 0.000267 1560.000000 -0.001929 0.000288 0.008870 +8789 1 0.000212 1560.000000 0.002082 0.003203 0.006642 +8790 1 0.000263 1560.000000 -0.000860 0.001580 0.003494 +8791 1 0.000275 1560.000000 -0.001568 0.000816 0.003272 +8792 1 0.000203 1560.000000 0.001045 -0.002658 0.006929 +8793 1 0.000242 1560.000000 0.000844 0.002732 0.006950 +8794 1 0.000238 1560.000000 0.001924 0.000786 0.001460 +8795 1 0.000228 1560.000000 -0.002444 0.001513 0.004428 +8796 1 0.000200 1560.000000 0.001097 -0.000272 0.006160 +8797 1 0.000263 1560.000000 0.001167 -0.003057 0.004574 +8798 1 0.000285 1560.000000 0.003408 0.001708 0.008999 +8799 1 0.000215 1560.000000 0.002034 -0.000498 0.002252 +8800 1 0.000246 1560.000000 -0.001749 -0.001905 0.006615 +8801 1 0.000202 1560.000000 -0.000523 -0.003196 0.000282 +8802 1 0.000199 1560.000000 0.001165 0.003309 0.006036 +8803 1 0.000196 1560.000000 -0.001804 -0.001414 0.000218 +8804 1 0.000246 1560.000000 -0.000221 0.002864 0.000510 +8805 1 0.000227 1560.000000 0.000814 -0.001206 0.003381 +8806 1 0.000257 1560.000000 -0.001858 0.000612 0.007074 +8807 1 0.000215 1560.000000 0.003223 -0.001487 0.004668 +8808 1 0.000257 1560.000000 0.002052 -0.001505 0.005429 +8809 1 0.000196 1560.000000 -0.001197 -0.001898 0.005303 +8810 1 0.000253 1560.000000 -0.001848 -0.000908 0.002119 +8811 1 0.000205 1560.000000 0.002374 -0.000305 0.001545 +8812 1 0.000206 1560.000000 0.002958 0.002205 0.002186 +8813 1 0.000206 1560.000000 -0.002698 -0.001419 0.005179 +8814 1 0.000259 1560.000000 0.000076 0.002003 0.007601 +8815 1 0.000241 1560.000000 0.000005 0.002119 0.007853 +8816 1 0.000238 1560.000000 -0.000344 0.001990 0.006779 +8817 1 0.000273 1560.000000 0.001852 -0.002007 0.009320 +8818 1 0.000275 1560.000000 0.000673 -0.000314 0.002983 +8819 1 0.000245 1560.000000 0.001273 0.003037 0.000924 +8820 1 0.000286 1560.000000 0.001876 0.003202 0.003353 +8821 1 0.000225 1560.000000 -0.000074 -0.003767 0.005368 +8822 1 0.000273 1560.000000 0.002859 -0.002223 0.006225 +8823 1 0.000198 1560.000000 0.002800 -0.000939 0.007343 +8824 1 0.000217 1560.000000 0.001233 0.001825 0.000298 +8825 1 0.000276 1560.000000 -0.000639 -0.003692 0.001976 +8826 1 0.000195 1560.000000 0.001172 0.002813 0.006010 +8827 1 0.000278 1560.000000 0.003262 -0.000393 0.009318 +8828 1 0.000241 1560.000000 0.001638 0.000369 0.008332 +8829 1 0.000257 1560.000000 -0.000040 -0.003818 0.001113 +8830 1 0.000235 1560.000000 -0.001412 -0.002747 0.000407 +8831 1 0.000204 1560.000000 0.001772 -0.000639 0.001370 +8832 1 0.000203 1560.000000 -0.001686 -0.000705 0.007680 +8833 1 0.000214 1560.000000 -0.002210 -0.002068 0.006763 +8834 1 0.000270 1560.000000 0.001445 0.002315 0.001951 +8835 1 0.000232 1560.000000 0.000672 -0.002377 0.007999 +8836 1 0.000215 1560.000000 0.002313 -0.002554 0.004670 +8837 1 0.000237 1560.000000 0.003420 0.000230 0.007782 +8838 1 0.000266 1560.000000 0.002031 -0.002057 0.006770 +8839 1 0.000233 1560.000000 0.000298 0.001359 0.000546 +8840 1 0.000243 1560.000000 -0.002210 -0.001476 0.006342 +8841 1 0.000238 1560.000000 0.003377 0.001145 0.004667 +8842 1 0.000193 1560.000000 -0.003345 -0.000273 0.009794 +8843 1 0.000273 1560.000000 -0.000477 0.003008 0.001664 +8844 1 0.000279 1560.000000 -0.003803 -0.000607 0.007093 +8845 1 0.000211 1560.000000 -0.002523 -0.002380 0.007541 +8846 1 0.000236 1560.000000 0.000396 0.002710 0.009707 +8847 1 0.000212 1560.000000 -0.001886 0.003167 0.007694 +8848 1 0.000216 1560.000000 0.001381 0.002563 0.001836 +8849 1 0.000221 1560.000000 0.002009 0.000907 0.006691 +8850 1 0.000245 1560.000000 0.001784 0.000929 0.002537 +8851 1 0.000205 1560.000000 0.000760 0.003181 0.003226 +8852 1 0.000216 1560.000000 0.000930 0.000083 0.007500 +8853 1 0.000217 1560.000000 -0.003083 0.000007 0.005470 +8854 1 0.000244 1560.000000 0.000452 0.000092 0.004863 +8855 1 0.000230 1560.000000 0.001674 -0.000344 0.006261 +8856 1 0.000210 1560.000000 -0.002579 -0.000782 0.003265 +8857 1 0.000194 1560.000000 -0.001040 0.003124 0.002404 +8858 1 0.000239 1560.000000 0.001625 0.000827 0.007133 +8859 1 0.000245 1560.000000 -0.000389 0.000081 0.006259 +8860 1 0.000222 1560.000000 -0.001747 0.001783 0.002162 +8861 1 0.000247 1560.000000 0.002935 -0.000896 0.002576 +8862 1 0.000281 1560.000000 0.002635 -0.001622 0.008169 +8863 1 0.000283 1560.000000 -0.003841 0.000215 0.007074 +8864 1 0.000225 1560.000000 -0.000723 -0.000775 0.000909 +8865 1 0.000207 1560.000000 0.002286 0.002416 0.005142 +8866 1 0.000225 1560.000000 -0.000936 0.001947 0.000194 +8867 1 0.000215 1560.000000 -0.000632 -0.001065 0.009203 +8868 1 0.000204 1560.000000 0.000344 -0.002438 0.008733 +8869 1 0.000201 1560.000000 0.000298 0.000926 0.004246 +8870 1 0.000273 1560.000000 0.001463 0.000544 0.005799 +8871 1 0.000193 1560.000000 0.000577 0.000557 0.002415 +8872 1 0.000220 1560.000000 0.000278 -0.002212 0.004961 +8873 1 0.000263 1560.000000 -0.000247 0.001310 0.004128 +8874 1 0.000236 1560.000000 -0.002768 -0.000741 0.006263 +8875 1 0.000252 1560.000000 0.003234 -0.000529 0.004544 +8876 1 0.000247 1560.000000 -0.000046 -0.001918 0.005110 +8877 1 0.000200 1560.000000 0.001811 -0.002377 0.002278 +8878 1 0.000214 1560.000000 0.001280 0.001540 0.008955 +8879 1 0.000233 1560.000000 -0.001725 0.001781 0.002954 +8880 1 0.000234 1560.000000 -0.002005 -0.000203 0.005969 +8881 1 0.000230 1560.000000 -0.000196 -0.000622 0.000473 +8882 1 0.000195 1560.000000 -0.000947 0.003534 0.000356 +8883 1 0.000224 1560.000000 0.000718 0.001371 0.000256 +8884 1 0.000250 1560.000000 0.001366 0.003462 0.002348 +8885 1 0.000229 1560.000000 -0.001669 0.002891 0.008252 +8886 1 0.000211 1560.000000 -0.003611 -0.000049 0.008662 +8887 1 0.000204 1560.000000 0.003516 -0.000720 0.005888 +8888 1 0.000258 1560.000000 0.001799 0.000410 0.002444 +8889 1 0.000285 1560.000000 0.002587 0.001993 0.005518 +8890 1 0.000250 1560.000000 -0.001791 0.000695 0.004139 +8891 1 0.000216 1560.000000 -0.002178 -0.001658 0.004997 +8892 1 0.000281 1560.000000 0.001919 -0.000279 0.002431 +8893 1 0.000271 1560.000000 -0.003713 0.000513 0.005683 +8894 1 0.000253 1560.000000 0.002853 0.002490 0.007949 +8895 1 0.000219 1560.000000 -0.003015 0.000795 0.008008 +8896 1 0.000256 1560.000000 0.001404 -0.002004 0.002315 +8897 1 0.000269 1560.000000 -0.001981 -0.002285 0.002510 +8898 1 0.000218 1560.000000 0.000074 0.002146 0.002290 +8899 1 0.000204 1560.000000 0.002005 -0.000579 0.003175 +8900 1 0.000207 1560.000000 -0.003309 -0.001821 0.008766 +8901 1 0.000276 1560.000000 -0.001124 -0.000298 0.002524 +8902 1 0.000234 1560.000000 0.001652 -0.001188 0.003197 +8903 1 0.000222 1560.000000 -0.000681 -0.003624 0.009480 +8904 1 0.000233 1560.000000 -0.000126 0.002637 0.003196 +8905 1 0.000247 1560.000000 0.001310 -0.000694 0.004299 +8906 1 0.000267 1560.000000 -0.000571 0.002468 0.004063 +8907 1 0.000262 1560.000000 -0.000897 0.003051 0.004897 +8908 1 0.000196 1560.000000 -0.002114 0.001919 0.003321 +8909 1 0.000205 1560.000000 0.002119 -0.000085 0.007504 +8910 1 0.000225 1560.000000 0.001608 -0.001670 0.003174 +8911 1 0.000202 1560.000000 0.001196 -0.000921 0.001285 +8912 1 0.000193 1560.000000 0.000708 -0.002314 0.009377 +8913 1 0.000283 1560.000000 0.001076 0.001208 0.002728 +8914 1 0.000251 1560.000000 0.000029 0.003342 0.004202 +8915 1 0.000273 1560.000000 -0.002247 -0.002099 0.000808 +8916 1 0.000236 1560.000000 -0.000376 -0.000913 0.004006 +8917 1 0.000244 1560.000000 -0.001857 0.001234 0.004553 +8918 1 0.000200 1560.000000 0.000567 -0.002894 0.006093 +8919 1 0.000255 1560.000000 0.003562 0.001070 0.001987 +8920 1 0.000230 1560.000000 -0.000405 -0.003223 0.006676 +8921 1 0.000194 1560.000000 0.002160 -0.002538 0.008857 +8922 1 0.000210 1560.000000 0.001999 0.000923 0.009058 +8923 1 0.000204 1560.000000 0.000637 -0.000443 0.006157 +8924 1 0.000238 1560.000000 -0.002576 0.000744 0.009355 +8925 1 0.000200 1560.000000 0.000611 -0.000242 0.005715 +8926 1 0.000199 1560.000000 0.001724 -0.002237 0.006872 +8927 1 0.000201 1560.000000 0.003447 0.001393 0.002113 +8928 1 0.000235 1560.000000 -0.000082 -0.001628 0.008766 +8929 1 0.000243 1560.000000 0.002208 0.001025 0.004110 +8930 1 0.000203 1560.000000 -0.002487 -0.000509 0.000435 +8931 1 0.000215 1560.000000 -0.001054 0.003449 0.001931 +8932 1 0.000264 1560.000000 0.001714 0.002075 0.000856 +8933 1 0.000231 1560.000000 0.001519 -0.002144 0.003489 +8934 1 0.000233 1560.000000 -0.002835 -0.000841 0.001127 +8935 1 0.000213 1560.000000 0.003609 0.000816 0.001435 +8936 1 0.000237 1560.000000 0.001636 0.002010 0.003072 +8937 1 0.000230 1560.000000 0.000233 -0.002228 0.003682 +8938 1 0.000233 1560.000000 -0.000899 0.000118 0.009517 +8939 1 0.000236 1560.000000 -0.001610 -0.002223 0.001678 +8940 1 0.000256 1560.000000 -0.001159 0.000813 0.000364 +8941 1 0.000264 1560.000000 0.001400 0.002426 0.002439 +8942 1 0.000203 1560.000000 -0.003181 0.001046 0.002116 +8943 1 0.000205 1560.000000 0.001632 -0.002816 0.009507 +8944 1 0.000216 1560.000000 -0.003346 -0.001042 0.003815 +8945 1 0.000216 1560.000000 -0.002244 0.002530 0.007067 +8946 1 0.000233 1560.000000 -0.000752 -0.001055 0.006372 +8947 1 0.000221 1560.000000 -0.000316 -0.002484 0.006742 +8948 1 0.000259 1560.000000 -0.000030 0.001969 0.000395 +8949 1 0.000206 1560.000000 0.000589 0.002634 0.005755 +8950 1 0.000244 1560.000000 0.002565 -0.002719 0.005964 +8951 1 0.000275 1560.000000 -0.000313 -0.001419 0.001521 +8952 1 0.000195 1560.000000 0.000159 0.001193 0.006947 +8953 1 0.000229 1560.000000 -0.002041 -0.002699 0.009344 +8954 1 0.000283 1560.000000 -0.001104 -0.002632 0.003353 +8955 1 0.000210 1560.000000 -0.001165 0.000187 0.004555 +8956 1 0.000232 1560.000000 0.001047 0.002052 0.008713 +8957 1 0.000233 1560.000000 -0.000510 -0.003810 0.006938 +8958 1 0.000242 1560.000000 -0.001492 0.002073 0.001823 +8959 1 0.000259 1560.000000 0.003048 0.001810 0.005818 +8960 1 0.000280 1560.000000 0.001567 -0.003460 0.002160 +8961 1 0.000227 1560.000000 -0.002167 -0.000860 0.007594 +8962 1 0.000201 1560.000000 0.001939 0.003243 0.001166 +8963 1 0.000231 1560.000000 0.003198 0.001435 0.005760 +8964 1 0.000255 1560.000000 0.001236 -0.000337 0.007465 +8965 1 0.000197 1560.000000 -0.002411 -0.000839 0.009139 +8966 1 0.000193 1560.000000 0.001266 -0.001736 0.002322 +8967 1 0.000197 1560.000000 0.000195 0.003388 0.008702 +8968 1 0.000215 1560.000000 0.001956 0.000877 0.005308 +8969 1 0.000253 1560.000000 -0.002500 -0.000446 0.005106 +8970 1 0.000250 1560.000000 0.003530 -0.001218 0.004298 +8971 1 0.000230 1560.000000 0.002152 0.000917 0.005613 +8972 1 0.000237 1560.000000 -0.000971 0.000843 0.003433 +8973 1 0.000238 1560.000000 -0.002681 -0.001081 0.009264 +8974 1 0.000200 1560.000000 -0.003235 0.000811 0.009021 +8975 1 0.000225 1560.000000 0.000503 -0.000334 0.006881 +8976 1 0.000285 1560.000000 -0.000527 -0.001278 0.006495 +8977 1 0.000239 1560.000000 -0.000098 0.003634 0.006800 +8978 1 0.000194 1560.000000 -0.001083 0.002914 0.008867 +8979 1 0.000201 1560.000000 -0.001335 0.003260 0.004584 +8980 1 0.000268 1560.000000 0.001509 -0.003401 0.001515 +8981 1 0.000232 1560.000000 0.000251 -0.001831 0.006002 +8982 1 0.000233 1560.000000 -0.002573 -0.000495 0.006292 +8983 1 0.000208 1560.000000 0.000141 0.000188 0.009614 +8984 1 0.000227 1560.000000 0.003633 -0.000647 0.003819 +8985 1 0.000222 1560.000000 -0.001572 0.003069 0.001907 +8986 1 0.000259 1560.000000 0.000215 0.003400 0.004862 +8987 1 0.000250 1560.000000 0.003672 0.001133 0.009725 +8988 1 0.000274 1560.000000 0.002961 -0.000683 0.009665 +8989 1 0.000214 1560.000000 0.002662 -0.001348 0.007574 +8990 1 0.000219 1560.000000 0.002138 -0.002939 0.002412 +8991 1 0.000225 1560.000000 0.001884 -0.001375 0.008449 +8992 1 0.000280 1560.000000 -0.000840 -0.001973 0.007170 +8993 1 0.000204 1560.000000 -0.002410 -0.002254 0.007094 +8994 1 0.000218 1560.000000 0.002356 0.002000 0.001960 +8995 1 0.000228 1560.000000 0.000839 0.000967 0.001733 +8996 1 0.000228 1560.000000 -0.000444 0.000354 0.001505 +8997 1 0.000194 1560.000000 -0.001063 0.000355 0.000408 +8998 1 0.000206 1560.000000 -0.002964 0.001687 0.005516 +8999 1 0.000243 1560.000000 0.001982 0.000965 0.002125 +9000 1 0.000261 1560.000000 0.002039 0.002507 0.008274 +9001 1 0.000199 1560.000000 -0.002359 0.002348 0.006718 +9002 1 0.000212 1560.000000 0.000554 0.003023 0.002166 +9003 1 0.000244 1560.000000 0.002548 -0.000012 0.003402 +9004 1 0.000214 1560.000000 0.001432 0.001720 0.004026 +9005 1 0.000197 1560.000000 0.001489 0.000527 0.001132 +9006 1 0.000232 1560.000000 0.001678 -0.001695 0.004375 +9007 1 0.000266 1560.000000 0.001891 -0.002607 0.009262 +9008 1 0.000249 1560.000000 -0.000538 -0.001371 0.004209 +9009 1 0.000224 1560.000000 0.001930 -0.003330 0.004005 +9010 1 0.000239 1560.000000 0.000834 0.001401 0.006456 +9011 1 0.000193 1560.000000 -0.000190 -0.001682 0.006477 +9012 1 0.000218 1560.000000 0.000894 0.002617 0.008859 +9013 1 0.000195 1560.000000 0.000489 -0.002924 0.004385 +9014 1 0.000241 1560.000000 -0.000025 0.003828 0.005615 +9015 1 0.000202 1560.000000 -0.002576 0.000442 0.001209 +9016 1 0.000236 1560.000000 -0.000421 -0.003305 0.005211 +9017 1 0.000239 1560.000000 -0.003549 -0.001240 0.004274 +9018 1 0.000226 1560.000000 -0.000876 -0.000358 0.008906 +9019 1 0.000282 1560.000000 -0.000584 -0.003387 0.000768 +9020 1 0.000213 1560.000000 -0.000967 -0.002125 0.008508 +9021 1 0.000195 1560.000000 0.000414 0.000194 0.007826 +9022 1 0.000251 1560.000000 0.001558 0.003078 0.008059 +9023 1 0.000254 1560.000000 -0.001108 -0.003628 0.006578 +9024 1 0.000265 1560.000000 -0.001837 0.002238 0.001704 +9025 1 0.000197 1560.000000 0.002115 -0.001593 0.004109 +9026 1 0.000214 1560.000000 0.003024 0.001336 0.004660 +9027 1 0.000252 1560.000000 0.000146 -0.003387 0.002637 +9028 1 0.000201 1560.000000 -0.001075 0.003472 0.008652 +9029 1 0.000279 1560.000000 0.001239 0.003503 0.005394 +9030 1 0.000276 1560.000000 -0.000742 -0.001365 0.009373 +9031 1 0.000212 1560.000000 -0.000219 -0.001075 0.008891 +9032 1 0.000230 1560.000000 -0.000569 0.003214 0.007390 +9033 1 0.000199 1560.000000 0.003144 -0.000190 0.003123 +9034 1 0.000208 1560.000000 -0.000684 -0.003788 0.001176 +9035 1 0.000193 1560.000000 -0.000194 0.002659 0.004382 +9036 1 0.000208 1560.000000 -0.001513 -0.003424 0.004105 +9037 1 0.000220 1560.000000 0.001757 0.000964 0.003391 +9038 1 0.000198 1560.000000 0.000416 -0.003403 0.004575 +9039 1 0.000242 1560.000000 -0.000524 0.000323 0.009371 +9040 1 0.000266 1560.000000 0.002815 -0.002433 0.001298 +9041 1 0.000193 1560.000000 -0.001994 -0.001918 0.005449 +9042 1 0.000195 1560.000000 -0.002490 -0.002067 0.007776 +9043 1 0.000284 1560.000000 0.000694 0.001503 0.003629 +9044 1 0.000268 1560.000000 -0.000339 -0.002803 0.006000 +9045 1 0.000194 1560.000000 0.003479 -0.001425 0.008451 +9046 1 0.000235 1560.000000 -0.002734 -0.001560 0.001602 +9047 1 0.000200 1560.000000 0.002410 -0.001258 0.001622 +9048 1 0.000269 1560.000000 -0.001354 -0.000003 0.005712 +9049 1 0.000238 1560.000000 -0.000978 0.000472 0.009721 +9050 1 0.000245 1560.000000 0.003016 -0.001299 0.009739 +9051 1 0.000244 1560.000000 0.001730 0.002631 0.001560 +9052 1 0.000253 1560.000000 -0.002367 -0.000691 0.007938 +9053 1 0.000218 1560.000000 -0.002221 0.000304 0.009231 +9054 1 0.000237 1560.000000 0.000821 0.001991 0.006218 +9055 1 0.000238 1560.000000 0.002559 0.000858 0.001242 +9056 1 0.000239 1560.000000 0.002881 0.002479 0.000433 +9057 1 0.000241 1560.000000 0.000200 0.001562 0.006596 +9058 1 0.000229 1560.000000 0.001307 -0.000590 0.009585 +9059 1 0.000196 1560.000000 -0.001710 -0.002644 0.008143 +9060 1 0.000211 1560.000000 -0.002910 -0.001607 0.000847 +9061 1 0.000246 1560.000000 0.002558 -0.002768 0.009561 +9062 1 0.000253 1560.000000 0.002794 0.000852 0.009222 +9063 1 0.000226 1560.000000 0.000350 0.001249 0.002596 +9064 1 0.000209 1560.000000 -0.001217 0.002237 0.000479 +9065 1 0.000222 1560.000000 -0.003182 0.001069 0.005820 +9066 1 0.000266 1560.000000 -0.000268 -0.003186 0.000543 +9067 1 0.000235 1560.000000 -0.002333 0.002240 0.007997 +9068 1 0.000223 1560.000000 0.002873 0.000183 0.005247 +9069 1 0.000237 1560.000000 -0.001812 -0.001211 0.008989 +9070 1 0.000205 1560.000000 0.000871 -0.000712 0.004024 +9071 1 0.000250 1560.000000 -0.002911 0.002327 0.003065 +9072 1 0.000261 1560.000000 0.003457 0.000880 0.003098 +9073 1 0.000245 1560.000000 0.000771 -0.003115 0.006759 +9074 1 0.000265 1560.000000 0.000852 -0.001483 0.002726 +9075 1 0.000285 1560.000000 -0.003161 0.002042 0.008703 +9076 1 0.000247 1560.000000 0.000396 -0.003806 0.000370 +9077 1 0.000231 1560.000000 -0.000196 -0.003025 0.009535 +9078 1 0.000249 1560.000000 -0.000461 -0.002452 0.000672 +9079 1 0.000195 1560.000000 -0.002190 -0.002622 0.001201 +9080 1 0.000210 1560.000000 -0.000253 -0.002136 0.009036 +9081 1 0.000238 1560.000000 0.001844 0.001918 0.004744 +9082 1 0.000218 1560.000000 -0.000756 -0.000845 0.004897 +9083 1 0.000230 1560.000000 -0.000819 0.001074 0.003548 +9084 1 0.000243 1560.000000 -0.001876 -0.003005 0.001505 +9085 1 0.000228 1560.000000 -0.000447 0.001344 0.001098 +9086 1 0.000200 1560.000000 -0.000400 0.000643 0.008815 +9087 1 0.000209 1560.000000 0.000166 -0.000044 0.006211 +9088 1 0.000236 1560.000000 0.001264 0.003338 0.004587 +9089 1 0.000263 1560.000000 0.002937 0.001558 0.001244 +9090 1 0.000256 1560.000000 -0.002578 -0.000281 0.009098 +9091 1 0.000248 1560.000000 0.002427 0.001203 0.003938 +9092 1 0.000202 1560.000000 -0.003257 0.001710 0.005153 +9093 1 0.000229 1560.000000 -0.001026 0.001235 0.001263 +9094 1 0.000241 1560.000000 0.002010 -0.002719 0.007279 +9095 1 0.000237 1560.000000 -0.000268 0.001993 0.005952 +9096 1 0.000236 1560.000000 -0.001797 0.000528 0.009005 +9097 1 0.000205 1560.000000 -0.001351 0.003492 0.008201 +9098 1 0.000216 1560.000000 0.000332 -0.003402 0.004035 +9099 1 0.000197 1560.000000 -0.000342 -0.001884 0.002022 +9100 1 0.000258 1560.000000 -0.000871 -0.000434 0.008226 +9101 1 0.000284 1560.000000 0.000496 0.001162 0.004305 +9102 1 0.000201 1560.000000 0.002718 -0.000007 0.007805 +9103 1 0.000265 1560.000000 -0.000599 -0.003637 0.008034 +9104 1 0.000280 1560.000000 -0.001606 -0.001292 0.002271 +9105 1 0.000284 1560.000000 -0.001447 0.002644 0.002818 +9106 1 0.000262 1560.000000 0.000860 -0.001573 0.001848 +9107 1 0.000199 1560.000000 -0.002869 0.001279 0.008315 +9108 1 0.000229 1560.000000 -0.001114 -0.001902 0.001796 +9109 1 0.000256 1560.000000 0.003740 0.000570 0.003950 +9110 1 0.000229 1560.000000 0.000113 -0.002754 0.001575 +9111 1 0.000221 1560.000000 0.002695 -0.001263 0.000124 +9112 1 0.000285 1560.000000 0.002657 -0.002643 0.008541 +9113 1 0.000278 1560.000000 0.001963 -0.000180 0.007743 +9114 1 0.000207 1560.000000 0.000031 0.002036 0.004961 +9115 1 0.000212 1560.000000 -0.002819 -0.000957 0.001437 +9116 1 0.000217 1560.000000 -0.001633 -0.002592 0.005627 +9117 1 0.000217 1560.000000 -0.000685 -0.002100 0.000884 +9118 1 0.000212 1560.000000 0.000063 -0.002380 0.005958 +9119 1 0.000235 1560.000000 0.000867 0.003226 0.007652 +9120 1 0.000201 1560.000000 0.000252 -0.003292 0.000887 +9121 1 0.000264 1560.000000 -0.000153 0.001603 0.005716 +9122 1 0.000193 1560.000000 -0.001728 -0.001013 0.000178 +9123 1 0.000273 1560.000000 0.001564 0.001865 0.007192 +9124 1 0.000192 1560.000000 0.001214 -0.003368 0.005352 +9125 1 0.000259 1560.000000 0.002885 -0.002023 0.004381 +9126 1 0.000195 1560.000000 -0.002400 0.002110 0.008759 +9127 1 0.000208 1560.000000 -0.002168 -0.000773 0.008514 +9128 1 0.000256 1560.000000 0.000759 -0.001989 0.009448 +9129 1 0.000213 1560.000000 -0.002486 0.002792 0.003885 +9130 1 0.000195 1560.000000 -0.001337 0.000335 0.009776 +9131 1 0.000215 1560.000000 0.000669 -0.000161 0.008190 +9132 1 0.000214 1560.000000 0.000341 -0.003157 0.007757 +9133 1 0.000203 1560.000000 -0.000174 -0.000896 0.008130 +9134 1 0.000218 1560.000000 0.000919 0.002470 0.003280 +9135 1 0.000253 1560.000000 -0.001152 0.002504 0.004268 +9136 1 0.000211 1560.000000 0.000666 0.000094 0.007158 +9137 1 0.000288 1560.000000 -0.001763 -0.000435 0.001067 +9138 1 0.000246 1560.000000 0.001145 0.001248 0.006657 +9139 1 0.000273 1560.000000 -0.001857 -0.001429 0.003674 +9140 1 0.000273 1560.000000 -0.001118 -0.000282 0.003527 +9141 1 0.000220 1560.000000 -0.001618 0.001730 0.001444 +9142 1 0.000205 1560.000000 -0.003725 0.000674 0.009152 +9143 1 0.000226 1560.000000 -0.001406 -0.000684 0.003357 +9144 1 0.000223 1560.000000 -0.000014 -0.001069 0.006637 +9145 1 0.000286 1560.000000 0.002730 0.001267 0.002375 +9146 1 0.000222 1560.000000 0.001228 0.000509 0.003718 +9147 1 0.000192 1560.000000 0.000325 -0.002201 0.001652 +9148 1 0.000199 1560.000000 0.002122 0.000579 0.008652 +9149 1 0.000217 1560.000000 -0.000569 -0.000326 0.004730 +9150 1 0.000237 1560.000000 0.000802 0.000782 0.004981 +9151 1 0.000241 1560.000000 0.001868 -0.002296 0.008550 +9152 1 0.000193 1560.000000 0.002080 0.001781 0.008797 +9153 1 0.000221 1560.000000 0.002356 0.001875 0.007150 +9154 1 0.000223 1560.000000 -0.002245 0.000850 0.002496 +9155 1 0.000266 1560.000000 0.002958 0.000069 0.003698 +9156 1 0.000288 1560.000000 0.001367 -0.001933 0.008258 +9157 1 0.000235 1560.000000 -0.002380 -0.002580 0.008276 +9158 1 0.000203 1560.000000 -0.000669 0.003256 0.004622 +9159 1 0.000274 1560.000000 0.000236 0.003792 0.007709 +9160 1 0.000271 1560.000000 0.002109 0.000453 0.003241 +9161 1 0.000249 1560.000000 0.002509 0.000740 0.000482 +9162 1 0.000204 1560.000000 0.002950 0.001566 0.001782 +9163 1 0.000202 1560.000000 -0.000019 0.000272 0.000835 +9164 1 0.000217 1560.000000 -0.000343 0.000960 0.004004 +9165 1 0.000219 1560.000000 0.001375 0.001685 0.001443 +9166 1 0.000206 1560.000000 -0.003179 -0.001986 0.006146 +9167 1 0.000212 1560.000000 -0.003287 -0.000341 0.000179 +9168 1 0.000230 1560.000000 -0.001096 -0.003658 0.002889 +9169 1 0.000208 1560.000000 0.000629 -0.000465 0.001154 +9170 1 0.000225 1560.000000 0.003627 0.001230 0.008211 +9171 1 0.000220 1560.000000 -0.002821 0.001567 0.004654 +9172 1 0.000192 1560.000000 0.000679 0.000606 0.000142 +9173 1 0.000202 1560.000000 0.001874 0.000232 0.002013 +9174 1 0.000238 1560.000000 -0.003143 0.000623 0.005707 +9175 1 0.000248 1560.000000 -0.000396 -0.002189 0.006425 +9176 1 0.000235 1560.000000 -0.002125 0.002095 0.001279 +9177 1 0.000195 1560.000000 0.002057 -0.000564 0.009287 +9178 1 0.000204 1560.000000 0.001285 0.002827 0.007234 +9179 1 0.000221 1560.000000 0.000079 0.001671 0.007049 +9180 1 0.000246 1560.000000 -0.001741 0.003439 0.001701 +9181 1 0.000252 1560.000000 -0.003211 -0.001034 0.002521 +9182 1 0.000266 1560.000000 -0.001064 0.003080 0.006341 +9183 1 0.000276 1560.000000 -0.001461 -0.000511 0.001850 +9184 1 0.000257 1560.000000 -0.002632 -0.002298 0.002283 +9185 1 0.000208 1560.000000 -0.000498 0.001781 0.002917 +9186 1 0.000211 1560.000000 -0.003311 0.000870 0.000879 +9187 1 0.000263 1560.000000 -0.002886 0.002235 0.000791 +9188 1 0.000213 1560.000000 -0.001902 0.001691 0.000645 +9189 1 0.000235 1560.000000 -0.003032 -0.001823 0.005417 +9190 1 0.000219 1560.000000 -0.000748 -0.003339 0.003215 +9191 1 0.000256 1560.000000 0.001149 -0.000508 0.001987 +9192 1 0.000206 1560.000000 0.000267 0.000946 0.000712 +9193 1 0.000273 1560.000000 -0.001208 0.000147 0.000603 +9194 1 0.000199 1560.000000 0.002967 -0.000197 0.004733 +9195 1 0.000196 1560.000000 0.001039 -0.000714 0.001986 +9196 1 0.000204 1560.000000 0.000083 -0.002418 0.008505 +9197 1 0.000198 1560.000000 -0.002499 -0.002283 0.001584 +9198 1 0.000278 1560.000000 0.000964 -0.002218 0.009226 +9199 1 0.000257 1560.000000 -0.001001 -0.003135 0.005177 +9200 1 0.000207 1560.000000 -0.001967 -0.001052 0.000277 +9201 1 0.000197 1560.000000 -0.000018 0.001889 0.000823 +9202 1 0.000223 1560.000000 0.002687 -0.000771 0.000989 +9203 1 0.000238 1560.000000 0.002100 0.001759 0.002160 +9204 1 0.000223 1560.000000 -0.002877 -0.001420 0.008639 +9205 1 0.000217 1560.000000 0.001647 0.001244 0.006920 +9206 1 0.000266 1560.000000 0.000440 0.001526 0.000234 +9207 1 0.000212 1560.000000 0.002470 0.002681 0.002508 +9208 1 0.000269 1560.000000 -0.000289 -0.002481 0.003217 +9209 1 0.000206 1560.000000 -0.001234 -0.000840 0.007417 +9210 1 0.000221 1560.000000 -0.002330 -0.000506 0.008456 +9211 1 0.000197 1560.000000 0.000588 -0.001740 0.007404 +9212 1 0.000197 1560.000000 0.001898 -0.001202 0.008197 +9213 1 0.000198 1560.000000 -0.001441 -0.000658 0.009354 +9214 1 0.000256 1560.000000 -0.001616 0.003064 0.003881 +9215 1 0.000244 1560.000000 -0.001490 0.000201 0.005486 +9216 1 0.000278 1560.000000 0.000641 0.002877 0.000377 +9217 1 0.000243 1560.000000 0.003020 0.001625 0.002112 +9218 1 0.000212 1560.000000 0.001136 -0.001352 0.001868 +9219 1 0.000197 1560.000000 -0.002380 0.000532 0.004255 +9220 1 0.000227 1560.000000 -0.001059 -0.000254 0.008706 +9221 1 0.000230 1560.000000 0.003604 0.001183 0.007083 +9222 1 0.000198 1560.000000 0.003340 0.000594 0.006785 +9223 1 0.000226 1560.000000 0.003527 0.001107 0.002873 +9224 1 0.000258 1560.000000 -0.002591 -0.000159 0.007385 +9225 1 0.000260 1560.000000 0.002709 0.001868 0.001802 +9226 1 0.000215 1560.000000 -0.001687 0.002293 0.005101 +9227 1 0.000201 1560.000000 -0.000619 -0.002586 0.008277 +9228 1 0.000192 1560.000000 -0.000920 -0.001931 0.002436 +9229 1 0.000226 1560.000000 -0.003711 0.000196 0.007933 +9230 1 0.000227 1560.000000 -0.001479 -0.002949 0.009785 +9231 1 0.000216 1560.000000 0.000543 -0.002075 0.002409 +9232 1 0.000198 1560.000000 0.000794 -0.000992 0.005314 +9233 1 0.000255 1560.000000 0.003424 -0.001565 0.003091 +9234 1 0.000217 1560.000000 -0.000739 0.000741 0.008876 +9235 1 0.000203 1560.000000 -0.000980 0.000800 0.002022 +9236 1 0.000263 1560.000000 0.000445 -0.002747 0.008366 +9237 1 0.000271 1560.000000 0.002960 0.002172 0.008433 +9238 1 0.000228 1560.000000 0.000066 0.000320 0.000609 +9239 1 0.000265 1560.000000 0.001093 0.000518 0.002147 +9240 1 0.000253 1560.000000 -0.000283 0.002527 0.006762 +9241 1 0.000253 1560.000000 0.002491 -0.002028 0.004955 +9242 1 0.000255 1560.000000 -0.002070 0.002284 0.004603 +9243 1 0.000220 1560.000000 0.001317 -0.003150 0.005895 +9244 1 0.000193 1560.000000 0.000664 -0.000203 0.001730 +9245 1 0.000252 1560.000000 0.002963 -0.001520 0.003497 +9246 1 0.000198 1560.000000 -0.001599 0.002515 0.000481 +9247 1 0.000193 1560.000000 -0.002291 -0.002479 0.007682 +9248 1 0.000205 1560.000000 0.001169 -0.002194 0.000460 +9249 1 0.000256 1560.000000 -0.001653 -0.002810 0.008409 +9250 1 0.000268 1560.000000 0.002942 -0.001809 0.003010 +9251 1 0.000198 1560.000000 0.001002 -0.003699 0.008317 +9252 1 0.000216 1560.000000 -0.003495 -0.000818 0.008061 +9253 1 0.000246 1560.000000 -0.001031 -0.001580 0.007155 +9254 1 0.000260 1560.000000 -0.001726 -0.000709 0.008767 +9255 1 0.000227 1560.000000 0.002275 0.001960 0.004250 +9256 1 0.000271 1560.000000 0.001906 -0.003129 0.009746 +9257 1 0.000286 1560.000000 0.000863 -0.003152 0.008955 +9258 1 0.000202 1560.000000 -0.003218 0.000541 0.009612 +9259 1 0.000227 1560.000000 0.000049 0.000794 0.000136 +9260 1 0.000218 1560.000000 0.000665 0.003601 0.004621 +9261 1 0.000210 1560.000000 0.001507 0.002909 0.009228 +9262 1 0.000287 1560.000000 0.001446 -0.002612 0.007306 +9263 1 0.000233 1560.000000 -0.002254 0.001942 0.009244 +9264 1 0.000203 1560.000000 0.001696 0.000872 0.009356 +9265 1 0.000287 1560.000000 0.003483 0.000038 0.009026 +9266 1 0.000260 1560.000000 0.003099 0.000365 0.007790 +9267 1 0.000195 1560.000000 0.000465 0.003111 0.001402 +9268 1 0.000241 1560.000000 -0.000678 -0.000270 0.009586 +9269 1 0.000230 1560.000000 0.002785 0.001102 0.005207 +9270 1 0.000263 1560.000000 0.002339 -0.002258 0.007379 +9271 1 0.000218 1560.000000 0.003452 -0.000319 0.009025 +9272 1 0.000233 1560.000000 -0.003640 0.000811 0.008567 +9273 1 0.000251 1560.000000 0.000618 0.003679 0.005422 +9274 1 0.000218 1560.000000 0.000664 0.001983 0.002285 +9275 1 0.000247 1560.000000 0.001498 -0.000307 0.008555 +9276 1 0.000193 1560.000000 0.002539 -0.000895 0.008281 +9277 1 0.000247 1560.000000 0.001074 -0.002504 0.002687 +9278 1 0.000205 1560.000000 -0.003473 0.000656 0.002002 +9279 1 0.000194 1560.000000 0.002984 -0.001145 0.004756 +9280 1 0.000233 1560.000000 0.001111 -0.002103 0.004347 +9281 1 0.000267 1560.000000 0.002132 -0.001028 0.002755 +9282 1 0.000275 1560.000000 0.001512 0.003419 0.007826 +9283 1 0.000198 1560.000000 -0.002020 -0.002633 0.004455 +9284 1 0.000201 1560.000000 0.000057 0.001634 0.005450 +9285 1 0.000226 1560.000000 -0.002479 0.002886 0.004245 +9286 1 0.000262 1560.000000 -0.000451 0.002323 0.005561 +9287 1 0.000193 1560.000000 -0.000103 0.001480 0.007282 +9288 1 0.000229 1560.000000 -0.000965 0.001675 0.006824 +9289 1 0.000211 1560.000000 0.001582 0.000788 0.006285 +9290 1 0.000230 1560.000000 -0.002720 -0.001999 0.001015 +9291 1 0.000269 1560.000000 0.002035 -0.001560 0.006502 +9292 1 0.000280 1560.000000 0.000116 0.003113 0.006510 +9293 1 0.000282 1560.000000 0.001014 0.000141 0.008535 +9294 1 0.000196 1560.000000 0.000649 0.003076 0.008909 +9295 1 0.000216 1560.000000 -0.001518 0.003174 0.008355 +9296 1 0.000283 1560.000000 -0.000977 0.003374 0.003946 +9297 1 0.000211 1560.000000 -0.001047 0.001424 0.003704 +9298 1 0.000262 1560.000000 -0.000838 0.003692 0.009008 +9299 1 0.000214 1560.000000 -0.002167 0.001459 0.003654 +9300 1 0.000249 1560.000000 0.001628 -0.001783 0.009707 +9301 1 0.000279 1560.000000 0.002358 0.001919 0.005325 +9302 1 0.000258 1560.000000 0.000598 0.002144 0.009799 +9303 1 0.000200 1560.000000 0.002752 0.001368 0.003257 +9304 1 0.000247 1560.000000 0.003610 -0.000703 0.004190 +9305 1 0.000230 1560.000000 0.000358 -0.003833 0.003844 +9306 1 0.000212 1560.000000 -0.003531 0.000831 0.003265 +9307 1 0.000254 1560.000000 -0.001276 0.000135 0.007664 +9308 1 0.000276 1560.000000 -0.002536 0.001033 0.006729 +9309 1 0.000243 1560.000000 -0.000486 -0.000716 0.003767 +9310 1 0.000202 1560.000000 -0.001537 -0.003450 0.007845 +9311 1 0.000196 1560.000000 0.001963 0.002998 0.000483 +9312 1 0.000250 1560.000000 0.001307 0.002948 0.006394 +9313 1 0.000246 1560.000000 0.000448 -0.002410 0.001968 +9314 1 0.000218 1560.000000 0.001475 -0.001962 0.007979 +9315 1 0.000242 1560.000000 -0.001609 -0.001160 0.003032 +9316 1 0.000227 1560.000000 -0.002300 -0.000516 0.008857 +9317 1 0.000247 1560.000000 0.001103 0.002953 0.008269 +9318 1 0.000278 1560.000000 0.002703 -0.001764 0.003222 +9319 1 0.000250 1560.000000 -0.002027 0.000534 0.007259 +9320 1 0.000223 1560.000000 -0.000479 -0.001101 0.001606 +9321 1 0.000199 1560.000000 -0.000105 0.003158 0.003665 +9322 1 0.000211 1560.000000 0.001538 0.003474 0.001242 +9323 1 0.000198 1560.000000 -0.001194 -0.002236 0.000979 +9324 1 0.000245 1560.000000 -0.001410 0.000456 0.006476 +9325 1 0.000211 1560.000000 -0.001079 -0.001178 0.008559 +9326 1 0.000238 1560.000000 0.002731 0.000680 0.000139 +9327 1 0.000201 1560.000000 0.002704 0.002433 0.005081 +9328 1 0.000223 1560.000000 0.001391 -0.000496 0.004749 +9329 1 0.000235 1560.000000 0.000177 0.003036 0.001681 +9330 1 0.000266 1560.000000 0.001600 -0.001057 0.004088 +9331 1 0.000193 1560.000000 -0.003146 -0.001470 0.008082 +9332 1 0.000222 1560.000000 -0.003251 -0.001861 0.002942 +9333 1 0.000250 1560.000000 0.003290 -0.000857 0.005165 +9334 1 0.000254 1560.000000 -0.002765 -0.002676 0.006585 +9335 1 0.000198 1560.000000 -0.003220 0.000477 0.006864 +9336 1 0.000208 1560.000000 -0.000366 0.001839 0.007697 +9337 1 0.000218 1560.000000 -0.001471 -0.002342 0.007606 +9338 1 0.000273 1560.000000 -0.002170 0.001213 0.006441 +9339 1 0.000230 1560.000000 0.000268 0.003730 0.008451 +9340 1 0.000203 1560.000000 0.000197 -0.000561 0.000914 +9341 1 0.000217 1560.000000 -0.001135 0.002678 0.005828 +9342 1 0.000197 1560.000000 0.002368 -0.000774 0.006891 +9343 1 0.000196 1560.000000 -0.000373 -0.003040 0.008883 +9344 1 0.000193 1560.000000 -0.001172 -0.001826 0.000138 +9345 1 0.000201 1560.000000 -0.000267 0.002961 0.007712 +9346 1 0.000225 1560.000000 -0.003323 0.001291 0.003297 +9347 1 0.000216 1560.000000 -0.001207 -0.002846 0.001409 +9348 1 0.000260 1560.000000 0.000486 0.003422 0.000388 +9349 1 0.000229 1560.000000 -0.000312 0.003819 0.005424 +9350 1 0.000280 1560.000000 -0.001122 -0.003546 0.002496 +9351 1 0.000279 1560.000000 -0.003833 -0.000220 0.005759 +9352 1 0.000277 1560.000000 0.002489 -0.002526 0.008139 +9353 1 0.000224 1560.000000 0.002600 0.002653 0.006613 +9354 1 0.000193 1560.000000 0.002366 -0.001325 0.008706 +9355 1 0.000227 1560.000000 -0.000536 0.000865 0.004151 +9356 1 0.000204 1560.000000 0.000765 -0.002978 0.007952 +9357 1 0.000193 1560.000000 -0.002879 -0.000898 0.006758 +9358 1 0.000251 1560.000000 0.000354 0.002858 0.001600 +9359 1 0.000234 1560.000000 -0.003106 0.001441 0.000923 +9360 1 0.000288 1560.000000 0.001657 0.001409 0.003479 +9361 1 0.000204 1560.000000 0.000023 -0.002725 0.004019 +9362 1 0.000195 1560.000000 -0.000071 0.001717 0.008797 +9363 1 0.000270 1560.000000 0.002189 0.001596 0.004276 +9364 1 0.000215 1560.000000 -0.002956 -0.001220 0.002530 +9365 1 0.000265 1560.000000 -0.000528 -0.002834 0.008729 +9366 1 0.000257 1560.000000 0.001251 0.002859 0.000397 +9367 1 0.000199 1560.000000 0.000809 0.001223 0.004903 +9368 1 0.000250 1560.000000 0.000392 -0.002519 0.009787 +9369 1 0.000279 1560.000000 0.002148 0.000673 0.000723 +9370 1 0.000208 1560.000000 -0.000313 0.002429 0.002671 +9371 1 0.000235 1560.000000 -0.003645 -0.000544 0.008068 +9372 1 0.000204 1560.000000 -0.000567 0.002651 0.004467 +9373 1 0.000202 1560.000000 -0.000841 0.003273 0.007090 +9374 1 0.000219 1560.000000 -0.000261 -0.002181 0.000269 +9375 1 0.000240 1560.000000 -0.000293 0.002328 0.008254 +9376 1 0.000225 1560.000000 0.000727 0.000328 0.009818 +9377 1 0.000256 1560.000000 0.002958 -0.001603 0.009405 +9378 1 0.000239 1560.000000 0.001731 -0.001414 0.002333 +9379 1 0.000269 1560.000000 -0.000163 -0.001691 0.009163 +9380 1 0.000222 1560.000000 0.002560 -0.000051 0.009763 +9381 1 0.000250 1560.000000 -0.000166 0.003737 0.000233 +9382 1 0.000239 1560.000000 -0.003162 -0.000033 0.008777 +9383 1 0.000200 1560.000000 0.001238 0.001706 0.004268 +9384 1 0.000261 1560.000000 -0.000307 -0.002005 0.001193 +9385 1 0.000241 1560.000000 -0.002656 -0.001034 0.001077 +9386 1 0.000213 1560.000000 -0.003389 -0.001673 0.000645 +9387 1 0.000267 1560.000000 0.002752 0.001626 0.000725 +9388 1 0.000250 1560.000000 0.003196 0.001213 0.002597 +9389 1 0.000218 1560.000000 -0.001343 -0.002955 0.008513 +9390 1 0.000211 1560.000000 0.000985 -0.003361 0.004377 +9391 1 0.000248 1560.000000 -0.000404 0.000866 0.005360 +9392 1 0.000196 1560.000000 -0.001399 -0.001617 0.006618 +9393 1 0.000260 1560.000000 -0.002323 0.002037 0.007317 +9394 1 0.000244 1560.000000 0.000622 0.002170 0.006334 +9395 1 0.000246 1560.000000 -0.001267 -0.002178 0.007578 +9396 1 0.000228 1560.000000 0.002650 0.000628 0.004505 +9397 1 0.000242 1560.000000 -0.000675 -0.002963 0.001762 +9398 1 0.000234 1560.000000 0.000230 -0.001627 0.008396 +9399 1 0.000218 1560.000000 0.002312 0.001411 0.008276 +9400 1 0.000224 1560.000000 -0.003762 -0.000372 0.002847 +9401 1 0.000215 1560.000000 0.002768 0.000719 0.005423 +9402 1 0.000219 1560.000000 -0.001146 0.000931 0.003613 +9403 1 0.000193 1560.000000 0.000070 0.002121 0.002545 +9404 1 0.000264 1560.000000 0.002340 0.001676 0.004518 +9405 1 0.000229 1560.000000 -0.000980 0.001843 0.008142 +9406 1 0.000224 1560.000000 -0.002079 -0.001727 0.006538 +9407 1 0.000287 1560.000000 0.000904 0.001199 0.008834 +9408 1 0.000257 1560.000000 -0.002587 0.002588 0.006275 +9409 1 0.000250 1560.000000 -0.002511 0.002866 0.002470 +9410 1 0.000263 1560.000000 0.002495 -0.002410 0.009252 +9411 1 0.000193 1560.000000 0.002036 0.000641 0.001203 +9412 1 0.000272 1560.000000 -0.003642 0.000086 0.002936 +9413 1 0.000203 1560.000000 0.000458 0.001135 0.007981 +9414 1 0.000204 1560.000000 -0.001280 0.001987 0.005828 +9415 1 0.000223 1560.000000 -0.002700 -0.002299 0.000829 +9416 1 0.000229 1560.000000 -0.000286 -0.000282 0.007637 +9417 1 0.000230 1560.000000 -0.002856 0.002573 0.003118 +9418 1 0.000241 1560.000000 -0.001497 -0.002966 0.003372 +9419 1 0.000261 1560.000000 0.000016 -0.003346 0.009244 +9420 1 0.000214 1560.000000 -0.000259 -0.001356 0.000163 +9421 1 0.000229 1560.000000 -0.000437 -0.002456 0.007850 +9422 1 0.000264 1560.000000 0.000448 -0.000534 0.001681 +9423 1 0.000203 1560.000000 -0.000606 -0.000669 0.003174 +9424 1 0.000213 1560.000000 0.003698 -0.000460 0.002267 +9425 1 0.000287 1560.000000 -0.000392 0.001499 0.009747 +9426 1 0.000216 1560.000000 0.000891 -0.001927 0.004678 +9427 1 0.000212 1560.000000 -0.000928 -0.000932 0.003145 +9428 1 0.000200 1560.000000 -0.000965 0.000890 0.002890 +9429 1 0.000223 1560.000000 0.001319 -0.001251 0.005651 +9430 1 0.000261 1560.000000 -0.000230 -0.001828 0.006896 +9431 1 0.000239 1560.000000 0.003577 0.000085 0.002088 +9432 1 0.000231 1560.000000 0.000004 -0.000761 0.000497 +9433 1 0.000279 1560.000000 -0.001250 0.001177 0.008325 +9434 1 0.000248 1560.000000 -0.001448 0.002929 0.001144 +9435 1 0.000217 1560.000000 0.000024 -0.000218 0.000803 +9436 1 0.000201 1560.000000 -0.002895 -0.001397 0.005702 +9437 1 0.000220 1560.000000 0.000300 -0.001158 0.008642 +9438 1 0.000219 1560.000000 -0.003608 0.001289 0.001938 +9439 1 0.000204 1560.000000 0.002760 -0.000279 0.002996 +9440 1 0.000237 1560.000000 0.002804 0.001016 0.008369 +9441 1 0.000245 1560.000000 0.001783 -0.001921 0.004528 +9442 1 0.000234 1560.000000 -0.003727 -0.000896 0.001133 +9443 1 0.000257 1560.000000 -0.000612 0.001338 0.008175 +9444 1 0.000222 1560.000000 0.001462 -0.001707 0.007794 +9445 1 0.000237 1560.000000 -0.001856 -0.002430 0.003522 +9446 1 0.000260 1560.000000 -0.000082 0.003419 0.009712 +9447 1 0.000264 1560.000000 0.000105 0.000667 0.004399 +9448 1 0.000285 1560.000000 -0.002829 -0.000094 0.009850 +9449 1 0.000235 1560.000000 -0.000106 -0.001850 0.003654 +9450 1 0.000226 1560.000000 0.000339 -0.000112 0.003024 +9451 1 0.000254 1560.000000 0.000135 -0.002448 0.004539 +9452 1 0.000207 1560.000000 -0.002746 -0.000321 0.003575 +9453 1 0.000219 1560.000000 -0.000792 -0.002022 0.005704 +9454 1 0.000263 1560.000000 -0.001697 -0.000515 0.009634 +9455 1 0.000248 1560.000000 -0.003441 -0.000871 0.005200 +9456 1 0.000248 1560.000000 0.001736 0.000526 0.006521 +9457 1 0.000282 1560.000000 -0.001971 0.000224 0.001508 +9458 1 0.000206 1560.000000 -0.001314 0.003316 0.000159 +9459 1 0.000236 1560.000000 -0.000718 0.002153 0.005745 +9460 1 0.000240 1560.000000 0.003062 -0.002251 0.000860 +9461 1 0.000265 1560.000000 -0.002432 0.002893 0.009349 +9462 1 0.000264 1560.000000 -0.001660 -0.002857 0.001364 +9463 1 0.000195 1560.000000 0.002528 -0.002292 0.007207 +9464 1 0.000241 1560.000000 -0.002544 -0.002802 0.008929 +9465 1 0.000208 1560.000000 0.001982 -0.001120 0.006755 +9466 1 0.000200 1560.000000 -0.000005 -0.001817 0.000746 +9467 1 0.000218 1560.000000 -0.000769 -0.001807 0.004339 +9468 1 0.000278 1560.000000 0.002742 -0.001629 0.009097 +9469 1 0.000205 1560.000000 0.000749 -0.002598 0.006394 +9470 1 0.000243 1560.000000 -0.000812 0.001468 0.002417 +9471 1 0.000234 1560.000000 0.000515 0.003166 0.000151 +9472 1 0.000229 1560.000000 0.001819 0.001633 0.004154 +9473 1 0.000202 1560.000000 0.001405 0.001711 0.005448 +9474 1 0.000210 1560.000000 0.000149 0.003094 0.000568 +9475 1 0.000228 1560.000000 -0.002002 -0.002891 0.001205 +9476 1 0.000232 1560.000000 -0.003430 0.001712 0.003972 +9477 1 0.000224 1560.000000 0.002725 0.002568 0.005655 +9478 1 0.000215 1560.000000 0.002096 0.000547 0.002011 +9479 1 0.000219 1560.000000 -0.000362 -0.000540 0.002857 +9480 1 0.000227 1560.000000 -0.002331 0.001115 0.003591 +9481 1 0.000206 1560.000000 0.001154 -0.001723 0.007185 +9482 1 0.000242 1560.000000 -0.000466 0.001678 0.003158 +9483 1 0.000233 1560.000000 0.003200 -0.001485 0.003996 +9484 1 0.000198 1560.000000 -0.000082 0.002733 0.003833 +9485 1 0.000207 1560.000000 0.001379 0.000996 0.004997 +9486 1 0.000260 1560.000000 0.001006 -0.003588 0.000426 +9487 1 0.000210 1560.000000 0.001009 0.000671 0.005186 +9488 1 0.000224 1560.000000 -0.000525 0.000614 0.000944 +9489 1 0.000196 1560.000000 0.003547 -0.000727 0.009301 +9490 1 0.000193 1560.000000 0.000208 -0.000207 0.003750 +9491 1 0.000287 1560.000000 0.003149 -0.001238 0.003352 +9492 1 0.000213 1560.000000 -0.000859 0.000767 0.007743 +9493 1 0.000208 1560.000000 0.000562 -0.002434 0.001533 +9494 1 0.000217 1560.000000 0.001653 -0.002637 0.002505 +9495 1 0.000196 1560.000000 -0.002043 -0.000271 0.007223 +9496 1 0.000212 1560.000000 -0.002022 0.002841 0.003372 +9497 1 0.000206 1560.000000 0.001421 0.002599 0.009059 +9498 1 0.000224 1560.000000 0.002051 -0.002718 0.002065 +9499 1 0.000250 1560.000000 0.000858 0.003670 0.000772 +9500 1 0.000266 1560.000000 -0.003613 -0.000844 0.006594 +9501 1 0.000279 1560.000000 -0.001737 -0.001625 0.008687 +9502 1 0.000261 1560.000000 0.002077 0.002642 0.009202 +9503 1 0.000241 1560.000000 -0.002023 -0.003161 0.004628 +9504 1 0.000226 1560.000000 0.001254 -0.002072 0.000820 +9505 1 0.000261 1560.000000 -0.001975 -0.001588 0.001584 +9506 1 0.000194 1560.000000 0.000235 -0.002195 0.007385 +9507 1 0.000226 1560.000000 -0.001024 0.002715 0.007991 +9508 1 0.000261 1560.000000 0.001278 0.000845 0.001180 +9509 1 0.000264 1560.000000 0.002721 0.002664 0.002382 +9510 1 0.000233 1560.000000 0.000407 -0.003542 0.003240 +9511 1 0.000236 1560.000000 0.001535 0.002837 0.009569 +9512 1 0.000281 1560.000000 -0.001476 0.001134 0.000245 +9513 1 0.000202 1560.000000 0.002578 0.002512 0.003954 +9514 1 0.000217 1560.000000 0.000112 0.001847 0.006553 +9515 1 0.000279 1560.000000 0.000371 -0.001513 0.002315 +9516 1 0.000281 1560.000000 -0.003681 -0.000922 0.002955 +9517 1 0.000270 1560.000000 -0.001121 -0.002144 0.003408 +9518 1 0.000233 1560.000000 -0.003682 0.000679 0.002260 +9519 1 0.000277 1560.000000 0.000523 -0.002884 0.003346 +9520 1 0.000225 1560.000000 0.000256 -0.002130 0.008409 +9521 1 0.000216 1560.000000 0.001544 -0.001341 0.007204 +9522 1 0.000200 1560.000000 -0.000879 0.002380 0.002869 +9523 1 0.000280 1560.000000 -0.002879 -0.000304 0.005208 +9524 1 0.000217 1560.000000 -0.003617 -0.000168 0.001293 +9525 1 0.000195 1560.000000 0.001632 -0.002934 0.008195 +9526 1 0.000212 1560.000000 -0.001897 -0.000546 0.004022 +9527 1 0.000253 1560.000000 -0.001007 0.002711 0.003159 +9528 1 0.000228 1560.000000 0.003144 -0.002071 0.005555 +9529 1 0.000216 1560.000000 -0.003515 -0.001043 0.004024 +9530 1 0.000246 1560.000000 -0.001861 0.001249 0.003710 +9531 1 0.000234 1560.000000 0.000045 -0.001987 0.007597 +9532 1 0.000235 1560.000000 -0.000518 -0.002311 0.006896 +9533 1 0.000218 1560.000000 -0.001438 -0.000648 0.008088 +9534 1 0.000215 1560.000000 -0.001419 0.000097 0.004151 +9535 1 0.000194 1560.000000 -0.001766 -0.002616 0.002647 +9536 1 0.000244 1560.000000 -0.002225 0.002467 0.000993 +9537 1 0.000225 1560.000000 0.001142 -0.000267 0.005645 +9538 1 0.000215 1560.000000 0.000672 -0.000836 0.009810 +9539 1 0.000227 1560.000000 -0.003640 -0.000460 0.003721 +9540 1 0.000213 1560.000000 -0.001158 0.001520 0.004035 +9541 1 0.000215 1560.000000 0.002171 0.000188 0.007859 +9542 1 0.000244 1560.000000 -0.000001 0.002223 0.001974 +9543 1 0.000232 1560.000000 0.002492 -0.000357 0.005226 +9544 1 0.000234 1560.000000 -0.000953 -0.001626 0.004713 +9545 1 0.000201 1560.000000 0.001207 -0.002983 0.007744 +9546 1 0.000251 1560.000000 -0.002326 0.000271 0.003454 +9547 1 0.000232 1560.000000 0.002959 -0.002365 0.006563 +9548 1 0.000257 1560.000000 0.001049 0.001973 0.003456 +9549 1 0.000193 1560.000000 0.001760 0.003317 0.002271 +9550 1 0.000213 1560.000000 -0.001254 0.001610 0.007586 +9551 1 0.000242 1560.000000 0.003145 0.000631 0.000252 +9552 1 0.000243 1560.000000 0.000238 0.002136 0.005861 +9553 1 0.000197 1560.000000 -0.000951 0.001701 0.007246 +9554 1 0.000227 1560.000000 -0.001510 0.002394 0.002850 +9555 1 0.000228 1560.000000 -0.003443 0.001019 0.002057 +9556 1 0.000276 1560.000000 0.002228 0.001405 0.001484 +9557 1 0.000194 1560.000000 -0.001421 0.000184 0.008675 +9558 1 0.000281 1560.000000 0.002667 -0.001363 0.003609 +9559 1 0.000229 1560.000000 0.000229 0.003154 0.008280 +9560 1 0.000277 1560.000000 0.000658 -0.002602 0.005907 +9561 1 0.000226 1560.000000 -0.002192 -0.001950 0.001227 +9562 1 0.000267 1560.000000 0.001502 -0.000565 0.002697 +9563 1 0.000223 1560.000000 0.002827 -0.000477 0.008599 +9564 1 0.000253 1560.000000 -0.000749 0.000843 0.007040 +9565 1 0.000245 1560.000000 0.003157 0.000683 0.001755 +9566 1 0.000256 1560.000000 0.001783 0.000075 0.006255 +9567 1 0.000259 1560.000000 -0.000684 0.002580 0.004760 +9568 1 0.000199 1560.000000 -0.002703 0.002122 0.000959 +9569 1 0.000278 1560.000000 0.000884 0.002067 0.008410 +9570 1 0.000246 1560.000000 -0.000181 -0.000028 0.006700 +9571 1 0.000195 1560.000000 0.000286 -0.000399 0.006167 +9572 1 0.000205 1560.000000 -0.002943 -0.001873 0.001234 +9573 1 0.000197 1560.000000 -0.001613 -0.002009 0.002122 +9574 1 0.000199 1560.000000 0.003128 -0.000485 0.006401 +9575 1 0.000208 1560.000000 -0.001494 -0.001786 0.001415 +9576 1 0.000210 1560.000000 -0.003127 0.001208 0.004747 +9577 1 0.000199 1560.000000 -0.002060 0.002312 0.000134 +9578 1 0.000278 1560.000000 0.003181 0.002114 0.005729 +9579 1 0.000195 1560.000000 -0.000874 0.001320 0.002792 +9580 1 0.000222 1560.000000 0.000066 -0.002800 0.007591 +9581 1 0.000208 1560.000000 0.001201 0.001164 0.002953 +9582 1 0.000200 1560.000000 0.000145 -0.000917 0.002878 +9583 1 0.000216 1560.000000 0.000152 -0.001211 0.005831 +9584 1 0.000269 1560.000000 0.001121 0.002186 0.007575 +9585 1 0.000202 1560.000000 0.001164 -0.001259 0.008207 +9586 1 0.000226 1560.000000 -0.002095 -0.001209 0.008124 +9587 1 0.000232 1560.000000 0.002562 -0.002183 0.000818 +9588 1 0.000196 1560.000000 -0.003803 0.000628 0.009654 +9589 1 0.000256 1560.000000 -0.000422 -0.000289 0.003465 +9590 1 0.000197 1560.000000 -0.001929 -0.000820 0.007681 +9591 1 0.000266 1560.000000 -0.000412 -0.000402 0.004213 +9592 1 0.000247 1560.000000 0.000315 -0.001940 0.008035 +9593 1 0.000270 1560.000000 0.000385 -0.003102 0.003192 +9594 1 0.000246 1560.000000 0.001116 -0.001401 0.004179 +9595 1 0.000266 1560.000000 0.000051 0.001311 0.005973 +9596 1 0.000230 1560.000000 0.001010 0.001270 0.005111 +9597 1 0.000253 1560.000000 0.001500 -0.003087 0.008432 +9598 1 0.000279 1560.000000 -0.002278 0.002113 0.005072 +9599 1 0.000200 1560.000000 0.000241 0.001401 0.004885 +9600 1 0.000213 1560.000000 -0.001339 -0.000696 0.002390 +9601 1 0.000214 1560.000000 -0.002454 -0.000890 0.000204 +9602 1 0.000207 1560.000000 -0.001742 -0.000451 0.005358 +9603 1 0.000197 1560.000000 -0.001834 -0.001686 0.008918 +9604 1 0.000248 1560.000000 -0.003622 0.001036 0.008753 +9605 1 0.000207 1560.000000 -0.001883 0.002729 0.005166 +9606 1 0.000249 1560.000000 -0.000021 0.003112 0.002531 +9607 1 0.000269 1560.000000 -0.001921 0.002485 0.005788 +9608 1 0.000260 1560.000000 0.002245 -0.001244 0.004122 +9609 1 0.000217 1560.000000 0.002830 0.000081 0.005813 +9610 1 0.000233 1560.000000 -0.000459 0.002081 0.009324 +9611 1 0.000284 1560.000000 0.003223 -0.001621 0.005429 +9612 1 0.000253 1560.000000 0.001377 -0.002138 0.001204 +9613 1 0.000237 1560.000000 0.001920 0.000995 0.006447 +9614 1 0.000215 1560.000000 -0.002406 0.002337 0.006460 +9615 1 0.000220 1560.000000 0.000065 0.001786 0.001409 +9616 1 0.000286 1560.000000 -0.000884 0.002047 0.000919 +9617 1 0.000245 1560.000000 0.001075 0.001022 0.000726 +9618 1 0.000206 1560.000000 0.000366 0.003487 0.006472 +9619 1 0.000251 1560.000000 0.000468 0.000285 0.009057 +9620 1 0.000281 1560.000000 0.000087 0.001767 0.009518 +9621 1 0.000220 1560.000000 -0.001517 -0.000042 0.000503 +9622 1 0.000231 1560.000000 0.002210 -0.000674 0.002446 +9623 1 0.000237 1560.000000 -0.000263 0.003406 0.006449 +9624 1 0.000196 1560.000000 -0.000022 0.002000 0.008820 +9625 1 0.000222 1560.000000 -0.002982 0.001073 0.006029 +9626 1 0.000195 1560.000000 -0.000025 0.001633 0.006154 +9627 1 0.000254 1560.000000 -0.000427 0.003107 0.007824 +9628 1 0.000246 1560.000000 0.003662 -0.000114 0.004234 +9629 1 0.000269 1560.000000 -0.003099 0.002157 0.006453 +9630 1 0.000207 1560.000000 0.002029 0.000578 0.009219 +9631 1 0.000255 1560.000000 0.001391 -0.002758 0.001182 +9632 1 0.000198 1560.000000 0.002135 0.002126 0.007783 +9633 1 0.000218 1560.000000 0.002801 -0.002063 0.001030 +9634 1 0.000208 1560.000000 -0.002684 0.000941 0.000677 +9635 1 0.000253 1560.000000 0.002139 0.000467 0.004084 +9636 1 0.000197 1560.000000 0.001450 0.002474 0.000205 +9637 1 0.000194 1560.000000 0.002290 0.000009 0.007381 +9638 1 0.000233 1560.000000 -0.001418 -0.002425 0.000531 +9639 1 0.000222 1560.000000 0.000386 0.002885 0.004965 +9640 1 0.000226 1560.000000 0.001687 -0.002286 0.001001 +9641 1 0.000216 1560.000000 -0.001744 -0.001700 0.004735 +9642 1 0.000194 1560.000000 -0.000198 0.000591 0.002897 +9643 1 0.000213 1560.000000 0.000977 0.002361 0.005336 +9644 1 0.000283 1560.000000 -0.002256 -0.002838 0.004671 +9645 1 0.000210 1560.000000 -0.002519 0.002122 0.004483 +9646 1 0.000206 1560.000000 -0.002165 0.001994 0.001969 +9647 1 0.000193 1560.000000 -0.002781 -0.002544 0.008371 +9648 1 0.000247 1560.000000 0.001781 -0.002611 0.008722 +9649 1 0.000208 1560.000000 -0.002551 -0.001715 0.000773 +9650 1 0.000275 1560.000000 -0.002175 -0.003035 0.007056 +9651 1 0.000205 1560.000000 0.000586 -0.000949 0.003600 +9652 1 0.000229 1560.000000 0.000386 -0.001902 0.000494 +9653 1 0.000198 1560.000000 0.002206 0.002862 0.008102 +9654 1 0.000200 1560.000000 0.001059 0.003067 0.009595 +9655 1 0.000247 1560.000000 0.000777 -0.001794 0.004321 +9656 1 0.000265 1560.000000 0.002218 -0.001318 0.000917 +9657 1 0.000197 1560.000000 0.000102 0.002221 0.003343 +9658 1 0.000237 1560.000000 0.000739 0.003473 0.006491 +9659 1 0.000286 1560.000000 0.001836 -0.001647 0.001083 +9660 1 0.000192 1560.000000 -0.002785 -0.000617 0.002471 +9661 1 0.000248 1560.000000 -0.001830 0.000913 0.007683 +9662 1 0.000283 1560.000000 0.001849 0.000090 0.001583 +9663 1 0.000212 1560.000000 -0.000010 -0.002386 0.005656 +9664 1 0.000246 1560.000000 0.000715 0.001086 0.006155 +9665 1 0.000249 1560.000000 -0.002809 -0.002465 0.002172 +9666 1 0.000198 1560.000000 -0.000818 -0.003680 0.002512 +9667 1 0.000198 1560.000000 -0.000585 -0.000735 0.001949 +9668 1 0.000288 1560.000000 -0.003173 0.000257 0.009383 +9669 1 0.000229 1560.000000 0.001311 0.001853 0.004560 +9670 1 0.000232 1560.000000 0.001981 0.001570 0.000814 +9671 1 0.000264 1560.000000 -0.002363 0.001638 0.001731 +9672 1 0.000242 1560.000000 -0.002200 0.001525 0.008333 +9673 1 0.000227 1560.000000 -0.001016 0.001712 0.003643 +9674 1 0.000203 1560.000000 -0.000127 0.001485 0.001253 +9675 1 0.000201 1560.000000 -0.002379 -0.002274 0.000157 +9676 1 0.000194 1560.000000 0.003060 0.001091 0.002879 +9677 1 0.000211 1560.000000 -0.001788 0.001165 0.006883 +9678 1 0.000276 1560.000000 0.001643 0.002125 0.008300 +9679 1 0.000268 1560.000000 0.000649 0.002092 0.001612 +9680 1 0.000247 1560.000000 0.002457 0.002267 0.003690 +9681 1 0.000287 1560.000000 0.003152 -0.000148 0.004014 +9682 1 0.000285 1560.000000 0.001048 0.001680 0.004672 +9683 1 0.000205 1560.000000 -0.000476 0.000255 0.004008 +9684 1 0.000213 1560.000000 0.000577 -0.002334 0.008931 +9685 1 0.000246 1560.000000 -0.002794 -0.002055 0.009514 +9686 1 0.000217 1560.000000 0.000287 -0.003249 0.003887 +9687 1 0.000250 1560.000000 0.001274 0.002359 0.003267 +9688 1 0.000279 1560.000000 -0.003561 0.001267 0.009800 +9689 1 0.000192 1560.000000 -0.000350 0.000256 0.003777 +9690 1 0.000237 1560.000000 0.000287 0.000502 0.002165 +9691 1 0.000201 1560.000000 0.000190 -0.001754 0.003614 +9692 1 0.000218 1560.000000 -0.001261 -0.000395 0.004502 +9693 1 0.000198 1560.000000 0.001619 -0.001332 0.001751 +9694 1 0.000213 1560.000000 0.000554 0.000446 0.000148 +9695 1 0.000286 1560.000000 -0.002619 -0.002006 0.001268 +9696 1 0.000246 1560.000000 0.002832 0.001284 0.006137 +9697 1 0.000255 1560.000000 -0.001362 -0.003165 0.005523 +9698 1 0.000202 1560.000000 0.001089 -0.003054 0.001098 +9699 1 0.000234 1560.000000 -0.002296 -0.002291 0.006681 +9700 1 0.000256 1560.000000 -0.001177 0.000665 0.005931 +9701 1 0.000215 1560.000000 0.002800 0.001759 0.008529 +9702 1 0.000221 1560.000000 0.000510 -0.000022 0.009329 +9703 1 0.000199 1560.000000 0.002456 0.001928 0.009069 +9704 1 0.000206 1560.000000 -0.000258 -0.003049 0.001165 +9705 1 0.000241 1560.000000 0.001408 0.001447 0.000455 +9706 1 0.000197 1560.000000 -0.000166 0.002632 0.000490 +9707 1 0.000224 1560.000000 -0.001229 -0.000632 0.002763 +9708 1 0.000281 1560.000000 0.003374 0.001568 0.003290 +9709 1 0.000210 1560.000000 0.002236 -0.002817 0.005649 +9710 1 0.000288 1560.000000 0.003295 0.000844 0.008192 +9711 1 0.000230 1560.000000 0.001190 0.000456 0.006880 +9712 1 0.000281 1560.000000 0.000596 0.003535 0.004853 +9713 1 0.000277 1560.000000 0.002629 -0.002253 0.000493 +9714 1 0.000234 1560.000000 -0.002902 0.000424 0.005124 +9715 1 0.000236 1560.000000 0.000913 0.003002 0.005427 +9716 1 0.000241 1560.000000 0.000797 0.002659 0.006308 +9717 1 0.000258 1560.000000 0.000680 -0.000181 0.008863 +9718 1 0.000213 1560.000000 -0.002369 -0.000934 0.002086 +9719 1 0.000205 1560.000000 0.000185 -0.001285 0.005217 +9720 1 0.000202 1560.000000 0.000882 -0.001572 0.007175 +9721 1 0.000207 1560.000000 -0.001253 0.001883 0.004136 +9722 1 0.000232 1560.000000 -0.000743 -0.002663 0.008737 +9723 1 0.000281 1560.000000 -0.002066 -0.001224 0.003329 +9724 1 0.000260 1560.000000 0.001665 -0.001977 0.008302 +9725 1 0.000243 1560.000000 -0.001147 -0.002670 0.004125 +9726 1 0.000238 1560.000000 -0.002382 -0.002252 0.002868 +9727 1 0.000238 1560.000000 0.001438 0.003490 0.005600 +9728 1 0.000194 1560.000000 0.000548 0.000062 0.009100 +9729 1 0.000232 1560.000000 -0.000681 -0.002434 0.003374 +9730 1 0.000287 1560.000000 0.003152 0.000326 0.004576 +9731 1 0.000214 1560.000000 0.000698 -0.001735 0.003470 +9732 1 0.000195 1560.000000 -0.001390 -0.003445 0.005141 +9733 1 0.000199 1560.000000 -0.002317 0.000247 0.002447 +9734 1 0.000203 1560.000000 0.001853 0.001984 0.000168 +9735 1 0.000263 1560.000000 0.003389 0.001082 0.007229 +9736 1 0.000276 1560.000000 0.001034 -0.002839 0.009571 +9737 1 0.000219 1560.000000 -0.002745 -0.002382 0.007473 +9738 1 0.000244 1560.000000 0.002071 -0.002664 0.009737 +9739 1 0.000261 1560.000000 0.000281 -0.002828 0.005477 +9740 1 0.000206 1560.000000 -0.000350 0.000362 0.004712 +9741 1 0.000258 1560.000000 -0.000123 0.002786 0.005239 +9742 1 0.000228 1560.000000 0.003317 -0.000705 0.002050 +9743 1 0.000286 1560.000000 0.002305 0.000645 0.008186 +9744 1 0.000213 1560.000000 0.003298 -0.000365 0.004918 +9745 1 0.000198 1560.000000 0.001131 0.002472 0.006959 +9746 1 0.000257 1560.000000 -0.002495 0.000235 0.007120 +9747 1 0.000275 1560.000000 0.002536 0.002721 0.005815 +9748 1 0.000233 1560.000000 0.002706 -0.001140 0.000475 +9749 1 0.000250 1560.000000 0.000709 0.000162 0.003241 +9750 1 0.000215 1560.000000 -0.003334 0.001175 0.008216 +9751 1 0.000236 1560.000000 0.002114 0.000012 0.000995 +9752 1 0.000214 1560.000000 0.002603 0.002295 0.000185 +9753 1 0.000261 1560.000000 0.003169 0.001519 0.003869 +9754 1 0.000222 1560.000000 0.000352 -0.000680 0.009068 +9755 1 0.000239 1560.000000 0.002639 0.002035 0.007552 +9756 1 0.000197 1560.000000 0.002063 -0.002077 0.002956 +9757 1 0.000232 1560.000000 -0.002654 -0.001258 0.007430 +9758 1 0.000264 1560.000000 -0.001259 -0.003080 0.001097 +9759 1 0.000260 1560.000000 0.001884 -0.000748 0.007313 +9760 1 0.000243 1560.000000 -0.002284 0.003045 0.000328 +9761 1 0.000196 1560.000000 -0.000996 0.003494 0.004372 +9762 1 0.000205 1560.000000 0.002644 0.000155 0.006571 +9763 1 0.000216 1560.000000 -0.002567 0.001208 0.001550 +9764 1 0.000259 1560.000000 -0.001036 0.001090 0.006160 +9765 1 0.000266 1560.000000 -0.000153 -0.002232 0.002628 +9766 1 0.000244 1560.000000 0.000806 0.003756 0.006665 +9767 1 0.000233 1560.000000 0.003249 -0.001727 0.006743 +9768 1 0.000204 1560.000000 0.000905 0.002217 0.006035 +9769 1 0.000196 1560.000000 -0.001940 0.002137 0.005778 +9770 1 0.000280 1560.000000 0.001634 0.002483 0.004197 +9771 1 0.000209 1560.000000 0.000927 -0.002248 0.005185 +9772 1 0.000209 1560.000000 -0.003535 -0.000599 0.003099 +9773 1 0.000217 1560.000000 -0.000559 -0.001336 0.004972 +9774 1 0.000233 1560.000000 -0.001319 0.000348 0.004619 +9775 1 0.000217 1560.000000 -0.001506 -0.003329 0.002724 +9776 1 0.000217 1560.000000 -0.001625 0.002657 0.005222 +9777 1 0.000224 1560.000000 0.001404 0.000469 0.004014 +9778 1 0.000252 1560.000000 -0.002904 0.000843 0.004481 +9779 1 0.000196 1560.000000 -0.001925 0.001045 0.007511 +9780 1 0.000236 1560.000000 -0.002158 0.001310 0.000475 +9781 1 0.000214 1560.000000 0.000833 0.002339 0.004426 +9782 1 0.000271 1560.000000 0.002003 -0.003073 0.006703 +9783 1 0.000216 1560.000000 -0.002042 0.001394 0.004565 +9784 1 0.000227 1560.000000 -0.003355 0.000878 0.004398 +9785 1 0.000227 1560.000000 -0.002427 0.000780 0.007442 +9786 1 0.000195 1560.000000 -0.000860 -0.002491 0.001078 +9787 1 0.000278 1560.000000 -0.001320 0.003425 0.003386 +9788 1 0.000246 1560.000000 0.000456 -0.002605 0.007205 +9789 1 0.000262 1560.000000 -0.001933 -0.000207 0.008674 +9790 1 0.000244 1560.000000 -0.000691 -0.001407 0.006206 +9791 1 0.000197 1560.000000 -0.003803 -0.000236 0.008965 +9792 1 0.000243 1560.000000 -0.002924 0.000473 0.003298 +9793 1 0.000213 1560.000000 -0.000226 -0.001590 0.001282 +9794 1 0.000219 1560.000000 0.000148 -0.000802 0.007434 +9795 1 0.000217 1560.000000 0.001986 0.002327 0.001483 +9796 1 0.000196 1560.000000 0.000531 -0.000271 0.008608 +9797 1 0.000255 1560.000000 0.001912 0.001732 0.004930 +9798 1 0.000272 1560.000000 -0.001015 -0.003301 0.007453 +9799 1 0.000224 1560.000000 0.000158 0.000271 0.001817 +9800 1 0.000263 1560.000000 -0.002145 0.002597 0.003291 +9801 1 0.000196 1560.000000 -0.001049 0.001733 0.001604 +9802 1 0.000204 1560.000000 0.000789 -0.003100 0.006535 +9803 1 0.000204 1560.000000 -0.001673 0.001056 0.003220 +9804 1 0.000263 1560.000000 0.001827 -0.003234 0.007991 +9805 1 0.000203 1560.000000 0.002241 0.001667 0.003359 +9806 1 0.000246 1560.000000 0.001232 -0.001594 0.009679 +9807 1 0.000244 1560.000000 -0.001145 0.003213 0.002689 +9808 1 0.000261 1560.000000 0.003622 -0.000469 0.006179 +9809 1 0.000215 1560.000000 -0.001232 -0.000818 0.009054 +9810 1 0.000204 1560.000000 -0.000159 0.003845 0.006767 +9811 1 0.000213 1560.000000 -0.002057 -0.000725 0.003278 +9812 1 0.000220 1560.000000 -0.000093 -0.001975 0.000215 +9813 1 0.000223 1560.000000 0.002897 0.001740 0.005288 +9814 1 0.000231 1560.000000 -0.000214 0.002301 0.001238 +9815 1 0.000209 1560.000000 0.000139 0.000954 0.003313 +9816 1 0.000192 1560.000000 0.003071 -0.002018 0.006742 +9817 1 0.000268 1560.000000 0.000622 -0.000699 0.005419 +9818 1 0.000193 1560.000000 0.000453 0.000847 0.000580 +9819 1 0.000196 1560.000000 0.000148 -0.001584 0.001516 +9820 1 0.000201 1560.000000 0.000846 0.002018 0.006800 +9821 1 0.000210 1560.000000 0.002007 -0.001526 0.007869 +9822 1 0.000250 1560.000000 0.001741 -0.001478 0.000164 +9823 1 0.000223 1560.000000 -0.000032 -0.003538 0.004595 +9824 1 0.000195 1560.000000 -0.000580 -0.003556 0.001454 +9825 1 0.000247 1560.000000 0.000316 0.000449 0.005496 +9826 1 0.000212 1560.000000 -0.002432 0.002653 0.007531 +9827 1 0.000275 1560.000000 -0.001026 0.002199 0.002984 +9828 1 0.000210 1560.000000 0.002759 -0.002255 0.008885 +9829 1 0.000267 1560.000000 -0.003616 -0.000473 0.005751 +9830 1 0.000266 1560.000000 0.001029 0.000725 0.001190 +9831 1 0.000218 1560.000000 0.001236 0.001273 0.001095 +9832 1 0.000207 1560.000000 -0.002279 -0.000992 0.001679 +9833 1 0.000229 1560.000000 -0.002696 0.001257 0.003306 +9834 1 0.000261 1560.000000 -0.002054 0.000234 0.001889 +9835 1 0.000194 1560.000000 0.001785 0.001274 0.000676 +9836 1 0.000245 1560.000000 0.001319 0.001280 0.004738 +9837 1 0.000205 1560.000000 0.001670 0.002518 0.008110 +9838 1 0.000254 1560.000000 0.003438 -0.000777 0.003763 +9839 1 0.000197 1560.000000 -0.001553 0.001898 0.008559 +9840 1 0.000202 1560.000000 -0.000934 0.003124 0.005771 +9841 1 0.000208 1560.000000 -0.002565 -0.000038 0.008452 +9842 1 0.000204 1560.000000 0.001539 -0.002221 0.008121 +9843 1 0.000228 1560.000000 0.002297 0.000639 0.007499 +9844 1 0.000243 1560.000000 -0.001186 -0.002122 0.006608 +9845 1 0.000239 1560.000000 -0.000341 -0.001342 0.004039 +9846 1 0.000210 1560.000000 -0.001590 -0.000579 0.005160 +9847 1 0.000210 1560.000000 -0.003327 -0.000133 0.007613 +9848 1 0.000236 1560.000000 0.000310 -0.001342 0.004974 +9849 1 0.000212 1560.000000 0.002592 0.001012 0.004745 +9850 1 0.000250 1560.000000 -0.003102 0.001098 0.002422 +9851 1 0.000284 1560.000000 0.000913 -0.003053 0.009233 +9852 1 0.000211 1560.000000 0.002100 0.002308 0.003211 +9853 1 0.000220 1560.000000 -0.001712 0.001224 0.001287 +9854 1 0.000262 1560.000000 -0.002008 -0.003257 0.007957 +9855 1 0.000257 1560.000000 -0.002411 0.002560 0.000787 +9856 1 0.000249 1560.000000 0.003114 0.001800 0.003643 +9857 1 0.000219 1560.000000 -0.002182 0.003174 0.005717 +9858 1 0.000273 1560.000000 -0.001667 0.000516 0.008363 +9859 1 0.000260 1560.000000 -0.001102 0.002425 0.001946 +9860 1 0.000273 1560.000000 -0.003570 0.001183 0.002307 +9861 1 0.000198 1560.000000 0.003035 -0.001499 0.008094 +9862 1 0.000204 1560.000000 0.000210 -0.001162 0.008114 +9863 1 0.000200 1560.000000 -0.001791 -0.003188 0.003228 +9864 1 0.000267 1560.000000 0.001307 0.002098 0.004470 +9865 1 0.000198 1560.000000 0.000327 -0.002268 0.005739 +9866 1 0.000217 1560.000000 -0.002831 -0.002364 0.005596 +9867 1 0.000208 1560.000000 -0.000435 -0.002564 0.007044 +9868 1 0.000238 1560.000000 -0.000854 0.001146 0.001866 +9869 1 0.000198 1560.000000 -0.000623 -0.001902 0.009134 +9870 1 0.000220 1560.000000 -0.000368 0.000397 0.007811 +9871 1 0.000229 1560.000000 0.001691 -0.003431 0.004670 +9872 1 0.000239 1560.000000 0.000872 -0.000288 0.001070 +9873 1 0.000194 1560.000000 -0.000563 0.000697 0.004819 +9874 1 0.000271 1560.000000 0.001957 0.001434 0.009670 +9875 1 0.000257 1560.000000 0.002961 0.002171 0.002686 +9876 1 0.000220 1560.000000 -0.001238 0.001636 0.008200 +9877 1 0.000227 1560.000000 0.001394 0.002882 0.003104 +9878 1 0.000279 1560.000000 -0.000725 0.001330 0.000141 +9879 1 0.000267 1560.000000 0.001459 -0.000470 0.005853 +9880 1 0.000209 1560.000000 0.001558 -0.000685 0.008068 +9881 1 0.000197 1560.000000 -0.001502 -0.002394 0.006281 +9882 1 0.000288 1560.000000 -0.000397 0.003513 0.008918 +9883 1 0.000193 1560.000000 -0.003021 -0.001518 0.007713 +9884 1 0.000264 1560.000000 0.000756 0.002894 0.003631 +9885 1 0.000252 1560.000000 -0.001610 0.003077 0.001352 +9886 1 0.000196 1560.000000 -0.000759 -0.001662 0.008459 +9887 1 0.000272 1560.000000 0.003003 0.000565 0.004608 +9888 1 0.000275 1560.000000 0.003271 -0.000249 0.001634 +9889 1 0.000246 1560.000000 -0.002412 0.002329 0.006048 +9890 1 0.000272 1560.000000 0.003197 0.001699 0.004364 +9891 1 0.000205 1560.000000 0.000204 -0.003383 0.005427 +9892 1 0.000242 1560.000000 0.002780 0.001729 0.006011 +9893 1 0.000219 1560.000000 0.002766 0.002119 0.001786 +9894 1 0.000217 1560.000000 -0.001763 -0.000116 0.000911 +9895 1 0.000254 1560.000000 -0.000102 0.003673 0.009255 +9896 1 0.000247 1560.000000 -0.003173 -0.000017 0.009215 +9897 1 0.000268 1560.000000 -0.002305 0.001472 0.004118 +9898 1 0.000220 1560.000000 -0.002771 0.001389 0.002163 +9899 1 0.000204 1560.000000 0.001416 -0.002082 0.006067 +9900 1 0.000221 1560.000000 0.002934 -0.000790 0.007157 +9901 1 0.000210 1560.000000 0.001417 -0.001872 0.008896 +9902 1 0.000268 1560.000000 0.003493 -0.001607 0.000226 +9903 1 0.000252 1560.000000 0.000796 0.003016 0.005159 +9904 1 0.000218 1560.000000 -0.002885 0.001746 0.006122 +9905 1 0.000197 1560.000000 -0.000366 0.001447 0.006154 +9906 1 0.000281 1560.000000 0.001235 -0.000045 0.006770 +9907 1 0.000201 1560.000000 0.002301 0.002888 0.000842 +9908 1 0.000207 1560.000000 0.000736 -0.000536 0.002639 +9909 1 0.000193 1560.000000 -0.003417 -0.001322 0.001137 +9910 1 0.000202 1560.000000 0.000394 0.003825 0.001188 +9911 1 0.000238 1560.000000 -0.000745 0.000592 0.006666 +9912 1 0.000245 1560.000000 0.001277 -0.001948 0.005249 +9913 1 0.000279 1560.000000 0.003608 0.000380 0.004459 +9914 1 0.000197 1560.000000 0.002242 0.003053 0.004656 +9915 1 0.000214 1560.000000 0.000511 -0.001097 0.000461 +9916 1 0.000283 1560.000000 -0.001140 0.003659 0.001285 +9917 1 0.000233 1560.000000 0.002782 -0.001275 0.008304 +9918 1 0.000222 1560.000000 0.000559 0.001710 0.000799 +9919 1 0.000280 1560.000000 0.002728 0.002062 0.009177 +9920 1 0.000211 1560.000000 0.001321 0.001976 0.003298 +9921 1 0.000248 1560.000000 0.000877 0.001553 0.004055 +9922 1 0.000237 1560.000000 -0.000644 0.002137 0.006229 +9923 1 0.000261 1560.000000 -0.002839 -0.000316 0.006297 +9924 1 0.000198 1560.000000 0.002756 0.002434 0.008481 +9925 1 0.000201 1560.000000 0.000887 0.003733 0.001855 +9926 1 0.000282 1560.000000 0.003274 0.000694 0.008480 +9927 1 0.000197 1560.000000 -0.002553 -0.002862 0.003235 +9928 1 0.000233 1560.000000 0.001589 0.000734 0.005299 +9929 1 0.000213 1560.000000 0.001287 -0.000252 0.006536 +9930 1 0.000272 1560.000000 -0.002849 -0.001524 0.003086 +9931 1 0.000199 1560.000000 0.002156 -0.000523 0.000361 +9932 1 0.000194 1560.000000 0.000194 0.003292 0.002715 +9933 1 0.000226 1560.000000 -0.001779 -0.001783 0.006201 +9934 1 0.000198 1560.000000 0.002444 0.002342 0.003957 +9935 1 0.000204 1560.000000 -0.002760 -0.000215 0.008677 +9936 1 0.000260 1560.000000 0.001088 -0.003681 0.007408 +9937 1 0.000203 1560.000000 0.001926 -0.000282 0.009134 +9938 1 0.000197 1560.000000 -0.002006 -0.001965 0.007085 +9939 1 0.000197 1560.000000 0.002974 -0.002194 0.008580 +9940 1 0.000252 1560.000000 0.001510 -0.002925 0.007277 +9941 1 0.000276 1560.000000 -0.001830 -0.000475 0.002870 +9942 1 0.000203 1560.000000 0.001032 0.001476 0.008315 +9943 1 0.000195 1560.000000 -0.001143 0.003021 0.004712 +9944 1 0.000231 1560.000000 -0.000998 -0.001335 0.001500 +9945 1 0.000209 1560.000000 0.002403 0.002267 0.000440 +9946 1 0.000242 1560.000000 0.000846 -0.002111 0.002409 +9947 1 0.000248 1560.000000 0.003765 -0.000244 0.000231 +9948 1 0.000209 1560.000000 0.001084 0.000504 0.009717 +9949 1 0.000207 1560.000000 -0.003749 0.000631 0.008440 +9950 1 0.000242 1560.000000 -0.000385 0.003676 0.007183 +9951 1 0.000215 1560.000000 -0.000220 -0.002389 0.007394 +9952 1 0.000229 1560.000000 -0.000566 0.003035 0.009390 +9953 1 0.000221 1560.000000 -0.001526 -0.000375 0.008033 +9954 1 0.000216 1560.000000 0.002453 -0.001797 0.006563 +9955 1 0.000263 1560.000000 -0.000538 0.003466 0.001222 +9956 1 0.000286 1560.000000 -0.000720 0.002935 0.007435 +9957 1 0.000236 1560.000000 -0.000230 0.001201 0.008731 +9958 1 0.000248 1560.000000 0.001178 -0.000066 0.002888 +9959 1 0.000268 1560.000000 0.001193 0.000448 0.009219 +9960 1 0.000198 1560.000000 -0.002331 0.001411 0.001587 +9961 1 0.000210 1560.000000 0.001824 0.000071 0.000319 +9962 1 0.000283 1560.000000 -0.003847 0.000014 0.003463 +9963 1 0.000234 1560.000000 0.000491 -0.003330 0.008076 +9964 1 0.000217 1560.000000 0.002061 0.002317 0.003510 +9965 1 0.000198 1560.000000 0.002780 -0.001744 0.003700 +9966 1 0.000231 1560.000000 0.003640 0.000849 0.006947 +9967 1 0.000206 1560.000000 -0.000086 0.002690 0.004692 +9968 1 0.000247 1560.000000 -0.001850 -0.002964 0.006949 +9969 1 0.000257 1560.000000 0.002296 0.002952 0.000569 +9970 1 0.000216 1560.000000 -0.000780 -0.002223 0.005124 +9971 1 0.000256 1560.000000 -0.000264 -0.003699 0.001982 +9972 1 0.000272 1560.000000 0.002174 0.000766 0.002612 +9973 1 0.000244 1560.000000 -0.001293 0.002100 0.009529 +9974 1 0.000276 1560.000000 -0.000972 -0.003627 0.005113 +9975 1 0.000267 1560.000000 0.003057 0.000583 0.006947 +9976 1 0.000195 1560.000000 -0.001457 -0.002157 0.005628 +9977 1 0.000200 1560.000000 0.000851 0.001607 0.008576 +9978 1 0.000258 1560.000000 -0.002442 -0.001556 0.008172 +9979 1 0.000203 1560.000000 -0.001057 -0.001164 0.003583 +9980 1 0.000218 1560.000000 0.001603 0.000923 0.000207 +9981 1 0.000276 1560.000000 0.000376 0.001006 0.007258 +9982 1 0.000233 1560.000000 -0.003151 -0.002188 0.000373 +9983 1 0.000199 1560.000000 0.003443 -0.001591 0.000982 +9984 1 0.000242 1560.000000 0.000047 0.003691 0.007460 +9985 1 0.000270 1560.000000 -0.001402 -0.001349 0.003072 +9986 1 0.000208 1560.000000 0.003854 -0.000057 0.009612 +9987 1 0.000209 1560.000000 -0.001753 0.001619 0.002410 +9988 1 0.000254 1560.000000 0.001317 -0.000808 0.004011 +9989 1 0.000214 1560.000000 -0.001577 -0.002720 0.008816 +9990 1 0.000213 1560.000000 -0.003306 -0.001451 0.008647 +9991 1 0.000270 1560.000000 -0.000991 -0.003240 0.008943 +9992 1 0.000200 1560.000000 -0.001166 0.001648 0.009420 +9993 1 0.000224 1560.000000 0.000627 0.002170 0.006845 +9994 1 0.000236 1560.000000 -0.001836 -0.001384 0.000625 +9995 1 0.000209 1560.000000 -0.003468 0.000635 0.008397 +9996 1 0.000237 1560.000000 0.000553 0.002743 0.002775 +9997 1 0.000280 1560.000000 0.001562 0.001989 0.008657 +9998 1 0.000247 1560.000000 -0.001598 0.000087 0.007204 +9999 1 0.000249 1560.000000 0.000978 0.003027 0.003716 +10000 1 0.000204 1560.000000 0.000818 0.000782 0.000110 +10001 1 0.000203 1560.000000 -0.000518 -0.001917 0.008064 +10002 1 0.000220 1560.000000 0.001032 -0.000359 0.001786 +10003 1 0.000251 1560.000000 -0.003821 0.000374 0.002485 +10004 1 0.000217 1560.000000 0.002795 -0.002037 0.002826 +10005 1 0.000223 1560.000000 0.000035 0.003162 0.008859 +10006 1 0.000240 1560.000000 0.003045 0.000968 0.003086 +10007 1 0.000195 1560.000000 -0.003140 0.000029 0.007727 +10008 1 0.000275 1560.000000 -0.003107 -0.000010 0.005766 +10009 1 0.000207 1560.000000 0.002938 0.001518 0.007853 +10010 1 0.000236 1560.000000 0.000237 0.001686 0.009162 +10011 1 0.000277 1560.000000 0.002692 0.001590 0.006817 +10012 1 0.000212 1560.000000 0.000463 0.000999 0.005579 +10013 1 0.000213 1560.000000 0.001187 -0.000922 0.002830 +10014 1 0.000194 1560.000000 -0.002756 0.001212 0.001293 +10015 1 0.000281 1560.000000 -0.001285 -0.000342 0.007205 +10016 1 0.000273 1560.000000 0.000832 0.001696 0.002330 +10017 1 0.000199 1560.000000 -0.000180 -0.001945 0.009297 +10018 1 0.000210 1560.000000 0.001012 -0.002613 0.007827 +10019 1 0.000197 1560.000000 -0.001198 -0.002232 0.004731 +10020 1 0.000194 1560.000000 -0.001978 0.002597 0.003670 +10021 1 0.000212 1560.000000 -0.001352 0.002101 0.002279 +10022 1 0.000196 1560.000000 0.001281 -0.002607 0.008027 +10023 1 0.000227 1560.000000 -0.000219 0.003492 0.002831 +10024 1 0.000275 1560.000000 0.003449 -0.001286 0.001677 +10025 1 0.000193 1560.000000 0.003086 0.000806 0.007988 +10026 1 0.000253 1560.000000 -0.000526 -0.003532 0.005589 +10027 1 0.000212 1560.000000 0.000210 -0.002136 0.001224 +10028 1 0.000279 1560.000000 -0.001730 0.001512 0.000253 +10029 1 0.000222 1560.000000 -0.001945 -0.000212 0.002487 +10030 1 0.000270 1560.000000 0.003117 -0.000360 0.008326 +10031 1 0.000257 1560.000000 0.001311 0.002597 0.000489 +10032 1 0.000212 1560.000000 0.001996 -0.002771 0.008231 +10033 1 0.000193 1560.000000 0.002121 0.001084 0.003825 +10034 1 0.000207 1560.000000 0.003170 -0.001778 0.000976 +10035 1 0.000200 1560.000000 -0.000385 0.001206 0.003392 +10036 1 0.000250 1560.000000 -0.001970 -0.002371 0.002166 +10037 1 0.000202 1560.000000 -0.001253 -0.003060 0.003512 +10038 1 0.000208 1560.000000 0.002168 -0.002341 0.004975 +10039 1 0.000253 1560.000000 -0.002555 0.001400 0.001058 +10040 1 0.000219 1560.000000 -0.001708 0.000354 0.009806 +10041 1 0.000227 1560.000000 -0.001405 0.003273 0.008175 +10042 1 0.000203 1560.000000 -0.001749 0.001372 0.003272 +10043 1 0.000266 1560.000000 -0.002049 0.003196 0.001231 +10044 1 0.000228 1560.000000 -0.000172 -0.001394 0.006826 +10045 1 0.000224 1560.000000 0.000801 0.000412 0.005313 +10046 1 0.000264 1560.000000 -0.000921 -0.001510 0.005821 +10047 1 0.000209 1560.000000 0.000619 0.000486 0.004254 +10048 1 0.000207 1560.000000 0.000263 0.003653 0.008226 +10049 1 0.000266 1560.000000 0.000089 0.002089 0.006944 +10050 1 0.000211 1560.000000 0.001672 -0.000158 0.003438 +10051 1 0.000241 1560.000000 -0.003243 0.000482 0.006009 +10052 1 0.000195 1560.000000 -0.001737 0.001741 0.005982 +10053 1 0.000210 1560.000000 -0.002658 -0.002791 0.008620 +10054 1 0.000234 1560.000000 0.002355 0.000463 0.003653 +10055 1 0.000236 1560.000000 0.000397 -0.003777 0.004478 +10056 1 0.000192 1560.000000 -0.000289 -0.003824 0.006853 +10057 1 0.000240 1560.000000 0.002653 0.000843 0.005650 +10058 1 0.000281 1560.000000 -0.000231 0.003674 0.008463 +10059 1 0.000193 1560.000000 -0.001531 0.001362 0.003950 +10060 1 0.000265 1560.000000 0.002925 0.002402 0.001129 +10061 1 0.000194 1560.000000 -0.001920 -0.000053 0.009034 +10062 1 0.000273 1560.000000 -0.002623 -0.002707 0.005263 +10063 1 0.000194 1560.000000 -0.000638 0.002686 0.008708 +10064 1 0.000229 1560.000000 0.002049 -0.000359 0.009819 +10065 1 0.000243 1560.000000 -0.001374 -0.001420 0.007164 +10066 1 0.000262 1560.000000 -0.002235 0.002199 0.002301 +10067 1 0.000223 1560.000000 -0.000091 0.002012 0.004412 +10068 1 0.000287 1560.000000 -0.001459 -0.000220 0.003681 +10069 1 0.000280 1560.000000 0.001064 -0.000518 0.004845 +10070 1 0.000274 1560.000000 0.002185 0.000341 0.009447 +10071 1 0.000242 1560.000000 0.000793 -0.003295 0.003942 +10072 1 0.000224 1560.000000 -0.002680 -0.001132 0.004153 +10073 1 0.000214 1560.000000 0.000066 0.001832 0.007822 +10074 1 0.000207 1560.000000 0.000355 -0.003447 0.002504 +10075 1 0.000267 1560.000000 0.001243 0.003495 0.009820 +10076 1 0.000229 1560.000000 -0.001877 0.000708 0.002200 +10077 1 0.000252 1560.000000 0.000844 0.000234 0.000302 +10078 1 0.000259 1560.000000 0.000563 -0.002591 0.000423 +10079 1 0.000241 1560.000000 -0.003083 -0.000463 0.004302 +10080 1 0.000286 1560.000000 0.000884 -0.003342 0.001394 +10081 1 0.000223 1560.000000 -0.000547 0.002623 0.006628 +10082 1 0.000195 1560.000000 -0.002514 0.000953 0.003785 +10083 1 0.000286 1560.000000 -0.001835 0.003086 0.006377 +10084 1 0.000278 1560.000000 0.001500 -0.003048 0.006275 +10085 1 0.000287 1560.000000 0.001418 0.001492 0.000833 +10086 1 0.000280 1560.000000 0.000858 0.003180 0.001518 +10087 1 0.000196 1560.000000 -0.003728 0.000321 0.001549 +10088 1 0.000206 1560.000000 -0.001041 0.000387 0.005766 +10089 1 0.000215 1560.000000 0.003161 0.001481 0.002416 +10090 1 0.000192 1560.000000 -0.002008 -0.000227 0.006946 +10091 1 0.000244 1560.000000 0.001289 -0.000540 0.006148 +10092 1 0.000202 1560.000000 0.000431 0.003613 0.002441 +10093 1 0.000264 1560.000000 0.001533 0.000157 0.007628 +10094 1 0.000232 1560.000000 0.002330 -0.001940 0.000581 +10095 1 0.000194 1560.000000 -0.001785 0.000921 0.003467 +10096 1 0.000262 1560.000000 -0.000431 0.002954 0.003313 +10097 1 0.000240 1560.000000 0.002714 -0.000542 0.004030 +10098 1 0.000239 1560.000000 0.002458 0.000682 0.003859 +10099 1 0.000215 1560.000000 -0.001200 0.003323 0.005278 +10100 1 0.000254 1560.000000 0.001025 -0.000823 0.006427 +10101 1 0.000237 1560.000000 0.001925 -0.001181 0.004112 +10102 1 0.000225 1560.000000 0.002194 -0.003108 0.005741 +10103 1 0.000278 1560.000000 0.001619 -0.003465 0.008096 +10104 1 0.000205 1560.000000 -0.003039 -0.002107 0.004700 +10105 1 0.000196 1560.000000 -0.002673 0.000500 0.009157 +10106 1 0.000224 1560.000000 0.000433 -0.000143 0.004836 +10107 1 0.000208 1560.000000 0.002732 0.000133 0.001783 +10108 1 0.000269 1560.000000 -0.002535 -0.002191 0.005007 +10109 1 0.000225 1560.000000 -0.001694 -0.003170 0.007567 +10110 1 0.000211 1560.000000 0.001315 -0.003622 0.005147 +10111 1 0.000245 1560.000000 -0.003060 0.000343 0.008125 +10112 1 0.000240 1560.000000 -0.000978 -0.001019 0.004956 +10113 1 0.000233 1560.000000 0.001503 -0.002706 0.001419 +10114 1 0.000207 1560.000000 0.000097 0.003780 0.009012 +10115 1 0.000206 1560.000000 -0.001228 0.002615 0.004882 +10116 1 0.000223 1560.000000 0.000957 0.001316 0.002968 +10117 1 0.000274 1560.000000 0.000109 -0.001843 0.002891 +10118 1 0.000197 1560.000000 -0.001984 -0.000158 0.003271 +10119 1 0.000200 1560.000000 0.001161 -0.001780 0.003923 +10120 1 0.000211 1560.000000 0.001156 -0.002952 0.000570 +10121 1 0.000201 1560.000000 0.001300 -0.002850 0.006081 +10122 1 0.000232 1560.000000 0.002369 -0.002807 0.000669 +10123 1 0.000271 1560.000000 -0.003091 -0.001365 0.004153 +10124 1 0.000232 1560.000000 -0.001962 0.003205 0.003091 +10125 1 0.000262 1560.000000 -0.001129 0.002988 0.009678 +10126 1 0.000212 1560.000000 -0.003128 0.000832 0.005121 +10127 1 0.000225 1560.000000 -0.001847 0.002649 0.002680 +10128 1 0.000263 1560.000000 -0.001484 0.000187 0.008012 +10129 1 0.000264 1560.000000 0.001416 0.002537 0.007994 +10130 1 0.000234 1560.000000 -0.003527 -0.000092 0.006238 +10131 1 0.000210 1560.000000 0.001564 0.001501 0.006006 +10132 1 0.000205 1560.000000 0.003542 -0.000954 0.004843 +10133 1 0.000283 1560.000000 -0.000535 -0.002085 0.005508 +10134 1 0.000194 1560.000000 0.000127 -0.001807 0.008452 +10135 1 0.000198 1560.000000 -0.000128 -0.003517 0.001227 +10136 1 0.000229 1560.000000 -0.002821 0.002138 0.001174 +10137 1 0.000222 1560.000000 -0.002099 0.000116 0.009596 +10138 1 0.000265 1560.000000 0.001082 0.001029 0.001109 +10139 1 0.000251 1560.000000 -0.001415 0.001517 0.008402 +10140 1 0.000252 1560.000000 -0.001542 0.000366 0.007043 +10141 1 0.000212 1560.000000 0.003042 -0.001486 0.005257 +10142 1 0.000193 1560.000000 0.002925 0.000710 0.001152 +10143 1 0.000236 1560.000000 -0.001377 0.001390 0.002275 +10144 1 0.000218 1560.000000 -0.001115 -0.002902 0.007615 +10145 1 0.000255 1560.000000 0.000254 0.000867 0.002755 +10146 1 0.000232 1560.000000 0.001535 -0.000991 0.009801 +10147 1 0.000258 1560.000000 0.001653 0.001625 0.006642 +10148 1 0.000219 1560.000000 0.001335 -0.003471 0.004827 +10149 1 0.000223 1560.000000 -0.001757 0.001533 0.006816 +10150 1 0.000236 1560.000000 -0.001474 -0.001932 0.000612 +10151 1 0.000235 1560.000000 0.000171 -0.002629 0.007827 +10152 1 0.000232 1560.000000 0.001913 0.001231 0.006262 +10153 1 0.000208 1560.000000 -0.000196 -0.002798 0.007800 +10154 1 0.000238 1560.000000 0.000292 -0.002810 0.006937 +10155 1 0.000209 1560.000000 0.000738 0.000712 0.009172 +10156 1 0.000200 1560.000000 -0.001441 0.003064 0.004181 +10157 1 0.000237 1560.000000 -0.002847 0.002162 0.006490 +10158 1 0.000192 1560.000000 0.000172 0.000867 0.009088 +10159 1 0.000243 1560.000000 -0.002848 0.000104 0.008029 +10160 1 0.000282 1560.000000 -0.000487 0.003798 0.008710 +10161 1 0.000246 1560.000000 0.001835 0.000955 0.004159 +10162 1 0.000260 1560.000000 -0.003131 0.001894 0.002080 +10163 1 0.000196 1560.000000 0.001115 -0.001740 0.004781 +10164 1 0.000212 1560.000000 0.002615 -0.002301 0.004573 +10165 1 0.000256 1560.000000 0.000936 -0.002246 0.001078 +10166 1 0.000216 1560.000000 -0.000619 -0.001577 0.007327 +10167 1 0.000274 1560.000000 -0.001851 -0.003070 0.005337 +10168 1 0.000263 1560.000000 0.003260 0.002047 0.007437 +10169 1 0.000235 1560.000000 0.000493 -0.002481 0.009300 +10170 1 0.000222 1560.000000 0.001997 -0.002250 0.003338 +10171 1 0.000269 1560.000000 0.001690 0.001295 0.007960 +10172 1 0.000232 1560.000000 0.001293 -0.002654 0.001579 +10173 1 0.000196 1560.000000 0.001700 0.000390 0.006241 +10174 1 0.000228 1560.000000 -0.003533 0.001044 0.007938 +10175 1 0.000217 1560.000000 0.002968 0.000328 0.008750 +10176 1 0.000216 1560.000000 -0.001200 -0.002714 0.004789 +10177 1 0.000241 1560.000000 0.002411 -0.002562 0.009549 +10178 1 0.000221 1560.000000 0.000689 -0.003204 0.004232 +10179 1 0.000224 1560.000000 -0.002667 0.002147 0.003717 +10180 1 0.000262 1560.000000 -0.000757 0.000326 0.005369 +10181 1 0.000206 1560.000000 -0.001847 0.002970 0.008071 +10182 1 0.000248 1560.000000 -0.001002 -0.003451 0.003605 +10183 1 0.000231 1560.000000 0.001686 -0.002518 0.005249 +10184 1 0.000218 1560.000000 -0.001365 0.002434 0.007203 +10185 1 0.000212 1560.000000 0.003279 0.000964 0.000760 +10186 1 0.000196 1560.000000 0.002589 -0.002633 0.004831 +10187 1 0.000288 1560.000000 -0.001913 0.002939 0.000414 +10188 1 0.000200 1560.000000 0.002957 0.002054 0.005270 +10189 1 0.000203 1560.000000 -0.002739 0.002122 0.003315 +10190 1 0.000219 1560.000000 0.003190 0.002116 0.005442 +10191 1 0.000208 1560.000000 -0.002776 -0.000356 0.001750 +10192 1 0.000265 1560.000000 -0.001094 -0.003638 0.004103 +10193 1 0.000225 1560.000000 0.000061 -0.003525 0.005997 +10194 1 0.000218 1560.000000 0.001830 0.000726 0.007518 +10195 1 0.000200 1560.000000 -0.002580 -0.002154 0.006952 +10196 1 0.000213 1560.000000 -0.001084 -0.000685 0.009779 +10197 1 0.000202 1560.000000 0.000671 0.000419 0.003680 +10198 1 0.000254 1560.000000 -0.003521 -0.000140 0.003827 +10199 1 0.000209 1560.000000 -0.002862 -0.000446 0.002255 +10200 1 0.000231 1560.000000 -0.000585 0.002556 0.005274 +10201 1 0.000286 1560.000000 -0.000098 0.003718 0.009534 +10202 1 0.000203 1560.000000 0.002444 0.000225 0.006606 +10203 1 0.000213 1560.000000 -0.001356 0.000455 0.002523 +10204 1 0.000278 1560.000000 -0.000634 -0.002094 0.002136 +10205 1 0.000230 1560.000000 -0.000300 -0.000210 0.003742 +10206 1 0.000263 1560.000000 0.001267 0.003532 0.008384 +10207 1 0.000241 1560.000000 -0.003787 -0.000134 0.006058 +10208 1 0.000199 1560.000000 0.003472 0.000211 0.008820 +10209 1 0.000256 1560.000000 -0.002401 -0.002907 0.002864 +10210 1 0.000235 1560.000000 -0.002598 0.002667 0.004746 +10211 1 0.000251 1560.000000 -0.002334 -0.001983 0.008838 +10212 1 0.000214 1560.000000 -0.002873 0.001597 0.003895 +10213 1 0.000221 1560.000000 0.000678 0.001170 0.006400 +10214 1 0.000246 1560.000000 -0.002790 0.001892 0.000202 +10215 1 0.000192 1560.000000 0.002477 0.002088 0.006932 +10216 1 0.000211 1560.000000 0.001757 -0.001347 0.009388 +10217 1 0.000250 1560.000000 0.001439 -0.003320 0.009686 +10218 1 0.000280 1560.000000 -0.000025 -0.003232 0.003840 +10219 1 0.000223 1560.000000 -0.002150 0.002117 0.007089 +10220 1 0.000237 1560.000000 0.000138 -0.001777 0.007277 +10221 1 0.000237 1560.000000 0.002031 -0.001638 0.006927 +10222 1 0.000242 1560.000000 0.002235 0.002168 0.007193 +10223 1 0.000203 1560.000000 0.003652 0.000737 0.009151 +10224 1 0.000205 1560.000000 -0.003195 0.000582 0.008255 +10225 1 0.000226 1560.000000 -0.002638 0.002458 0.004491 +10226 1 0.000227 1560.000000 0.000305 0.003323 0.004628 +10227 1 0.000238 1560.000000 -0.002314 -0.000177 0.006724 +10228 1 0.000246 1560.000000 -0.002994 0.000932 0.008593 +10229 1 0.000231 1560.000000 0.001590 -0.001728 0.008288 +10230 1 0.000197 1560.000000 0.002206 0.002637 0.006730 +10231 1 0.000227 1560.000000 0.002873 -0.000571 0.007104 +10232 1 0.000209 1560.000000 0.000351 -0.001874 0.001085 +10233 1 0.000198 1560.000000 -0.001390 0.002696 0.003737 +10234 1 0.000207 1560.000000 0.000680 0.001494 0.008258 +10235 1 0.000266 1560.000000 -0.000757 -0.002823 0.007495 +10236 1 0.000226 1560.000000 -0.002126 0.000116 0.000714 +10237 1 0.000194 1560.000000 -0.001496 0.002234 0.000981 +10238 1 0.000243 1560.000000 0.000387 -0.000317 0.003658 +10239 1 0.000264 1560.000000 0.002249 0.001370 0.002301 +10240 1 0.000193 1560.000000 0.003146 0.002013 0.004059 +10241 1 0.000206 1560.000000 0.002389 -0.001240 0.002885 +10242 1 0.000206 1560.000000 -0.001087 -0.000595 0.008726 +10243 1 0.000246 1560.000000 0.000659 -0.003227 0.000320 +10244 1 0.000235 1560.000000 0.002110 0.000270 0.006680 +10245 1 0.000220 1560.000000 0.000670 -0.000920 0.006641 +10246 1 0.000213 1560.000000 0.000888 0.002950 0.009400 +10247 1 0.000213 1560.000000 0.000854 0.001915 0.007639 +10248 1 0.000226 1560.000000 -0.001138 -0.003034 0.006573 +10249 1 0.000209 1560.000000 -0.000698 -0.003684 0.007095 +10250 1 0.000207 1560.000000 0.001163 -0.001020 0.009072 +10251 1 0.000258 1560.000000 -0.001583 -0.002677 0.009536 +10252 1 0.000284 1560.000000 0.001230 0.002513 0.008233 +10253 1 0.000269 1560.000000 -0.003011 -0.000854 0.007494 +10254 1 0.000219 1560.000000 -0.000511 -0.000961 0.002891 +10255 1 0.000272 1560.000000 0.001303 -0.001984 0.004847 +10256 1 0.000272 1560.000000 0.003090 -0.001790 0.000152 +10257 1 0.000220 1560.000000 -0.003379 0.000888 0.009393 +10258 1 0.000216 1560.000000 -0.001184 -0.002752 0.006490 +10259 1 0.000238 1560.000000 -0.002467 0.000094 0.007966 +10260 1 0.000230 1560.000000 -0.003517 -0.000358 0.002278 +10261 1 0.000236 1560.000000 0.000762 -0.002650 0.004063 +10262 1 0.000196 1560.000000 -0.003372 0.000173 0.003867 +10263 1 0.000255 1560.000000 -0.001073 -0.000221 0.000932 +10264 1 0.000271 1560.000000 0.000520 0.003337 0.002457 +10265 1 0.000196 1560.000000 0.001784 -0.001454 0.007698 +10266 1 0.000226 1560.000000 0.000598 -0.001214 0.003794 +10267 1 0.000259 1560.000000 0.001891 -0.003094 0.008550 +10268 1 0.000219 1560.000000 0.000800 -0.003351 0.008156 +10269 1 0.000235 1560.000000 -0.000109 0.000719 0.001821 +10270 1 0.000235 1560.000000 0.003551 0.000375 0.000164 +10271 1 0.000260 1560.000000 0.002603 -0.001057 0.002101 +10272 1 0.000225 1560.000000 0.003012 0.000447 0.008178 +10273 1 0.000232 1560.000000 0.000184 -0.000875 0.003667 +10274 1 0.000279 1560.000000 -0.001893 0.001898 0.009795 +10275 1 0.000252 1560.000000 0.001170 0.000926 0.003663 +10276 1 0.000273 1560.000000 0.002994 0.001814 0.007580 +10277 1 0.000239 1560.000000 -0.003217 -0.000977 0.000829 +10278 1 0.000257 1560.000000 0.002355 -0.000936 0.004495 +10279 1 0.000225 1560.000000 -0.001558 0.000132 0.000964 +10280 1 0.000222 1560.000000 -0.000104 -0.003057 0.008114 +10281 1 0.000219 1560.000000 -0.001927 0.000326 0.006358 +10282 1 0.000246 1560.000000 -0.003140 0.002210 0.005049 +10283 1 0.000229 1560.000000 0.002122 0.002804 0.004980 +10284 1 0.000268 1560.000000 -0.002878 0.001022 0.000810 +10285 1 0.000193 1560.000000 0.002632 -0.000988 0.003877 +10286 1 0.000250 1560.000000 0.001195 0.002811 0.009731 +10287 1 0.000238 1560.000000 0.001184 0.000705 0.002968 +10288 1 0.000196 1560.000000 0.001633 0.002496 0.002107 +10289 1 0.000283 1560.000000 -0.001232 0.000736 0.007416 +10290 1 0.000247 1560.000000 -0.001485 0.003170 0.001574 +10291 1 0.000247 1560.000000 -0.000468 0.001254 0.000606 +10292 1 0.000194 1560.000000 -0.002071 0.000992 0.006413 +10293 1 0.000201 1560.000000 -0.000499 0.000672 0.007078 +10294 1 0.000243 1560.000000 -0.001651 -0.000981 0.009409 +10295 1 0.000200 1560.000000 -0.001981 -0.002175 0.000185 +10296 1 0.000208 1560.000000 0.003194 -0.001436 0.005757 +10297 1 0.000236 1560.000000 0.002241 -0.000671 0.009129 +10298 1 0.000198 1560.000000 0.002290 -0.000621 0.002785 +10299 1 0.000227 1560.000000 0.002420 -0.002571 0.006145 +10300 1 0.000226 1560.000000 0.000930 0.001493 0.005271 +10301 1 0.000225 1560.000000 0.003190 0.002112 0.002326 +10302 1 0.000211 1560.000000 -0.000128 0.000776 0.007704 +10303 1 0.000238 1560.000000 0.000644 0.002104 0.007572 +10304 1 0.000203 1560.000000 0.002330 -0.001406 0.007563 +10305 1 0.000237 1560.000000 -0.002738 0.001093 0.005318 +10306 1 0.000223 1560.000000 -0.000956 0.001145 0.008139 +10307 1 0.000233 1560.000000 -0.000622 -0.000440 0.001838 +10308 1 0.000218 1560.000000 -0.000385 0.001643 0.004979 +10309 1 0.000195 1560.000000 -0.002490 -0.000315 0.009688 +10310 1 0.000261 1560.000000 0.001672 -0.000107 0.002430 +10311 1 0.000260 1560.000000 0.001259 0.000731 0.006278 +10312 1 0.000276 1560.000000 -0.003036 0.000762 0.000747 +10313 1 0.000272 1560.000000 0.001509 0.001057 0.004693 +10314 1 0.000228 1560.000000 -0.002701 0.002735 0.002940 +10315 1 0.000234 1560.000000 0.003757 0.000490 0.008774 +10316 1 0.000272 1560.000000 -0.002432 0.002096 0.004059 +10317 1 0.000204 1560.000000 -0.002101 -0.001359 0.004144 +10318 1 0.000228 1560.000000 -0.002965 0.000736 0.008768 +10319 1 0.000217 1560.000000 0.002159 -0.000592 0.001921 +10320 1 0.000220 1560.000000 0.000610 -0.002670 0.006231 +10321 1 0.000252 1560.000000 0.002282 -0.002378 0.005439 +10322 1 0.000230 1560.000000 -0.000341 -0.000986 0.007979 +10323 1 0.000258 1560.000000 0.001354 -0.000938 0.004812 +10324 1 0.000201 1560.000000 -0.000639 0.001035 0.009158 +10325 1 0.000212 1560.000000 -0.001123 0.003651 0.004793 +10326 1 0.000273 1560.000000 -0.001834 0.000444 0.003369 +10327 1 0.000196 1560.000000 0.002154 0.001334 0.008919 +10328 1 0.000211 1560.000000 -0.001931 0.002874 0.008332 +10329 1 0.000263 1560.000000 -0.000888 -0.003124 0.007667 +10330 1 0.000233 1560.000000 0.001477 -0.000332 0.000885 +10331 1 0.000216 1560.000000 -0.003121 -0.000975 0.008120 +10332 1 0.000214 1560.000000 0.001032 0.003238 0.005805 +10333 1 0.000217 1560.000000 0.000750 -0.003018 0.004347 +10334 1 0.000205 1560.000000 0.002961 -0.000968 0.009217 +10335 1 0.000198 1560.000000 -0.002111 0.001221 0.008644 +10336 1 0.000227 1560.000000 0.001971 0.001030 0.003599 +10337 1 0.000205 1560.000000 0.001913 -0.000648 0.006959 +10338 1 0.000260 1560.000000 0.000344 -0.003826 0.002529 +10339 1 0.000219 1560.000000 0.000793 0.002509 0.008268 +10340 1 0.000209 1560.000000 -0.001879 0.003236 0.005354 +10341 1 0.000215 1560.000000 0.002773 0.000887 0.006147 +10342 1 0.000241 1560.000000 0.001737 0.000069 0.004447 +10343 1 0.000195 1560.000000 0.002179 0.000890 0.007450 +10344 1 0.000257 1560.000000 -0.002446 0.002831 0.006988 +10345 1 0.000249 1560.000000 0.003545 0.000164 0.000531 +10346 1 0.000220 1560.000000 -0.000350 0.000399 0.006690 +10347 1 0.000285 1560.000000 0.000732 -0.002801 0.000948 +10348 1 0.000281 1560.000000 0.000807 0.002201 0.000142 +10349 1 0.000266 1560.000000 -0.003718 -0.000716 0.004768 +10350 1 0.000199 1560.000000 0.002182 -0.000617 0.001283 +10351 1 0.000241 1560.000000 -0.000343 0.002840 0.003536 +10352 1 0.000218 1560.000000 0.000365 -0.001231 0.001656 +10353 1 0.000279 1560.000000 -0.001412 -0.002752 0.003226 +10354 1 0.000249 1560.000000 -0.003047 -0.001688 0.001478 +10355 1 0.000271 1560.000000 -0.003154 0.000150 0.001416 +10356 1 0.000233 1560.000000 0.000921 0.001958 0.001633 +10357 1 0.000246 1560.000000 -0.002479 0.001445 0.005977 +10358 1 0.000193 1560.000000 -0.001036 -0.003252 0.008486 +10359 1 0.000286 1560.000000 -0.000642 -0.003208 0.008457 +10360 1 0.000196 1560.000000 -0.003060 0.000369 0.002241 +10361 1 0.000213 1560.000000 0.002103 -0.000662 0.009764 +10362 1 0.000195 1560.000000 -0.000019 0.000229 0.005978 +10363 1 0.000234 1560.000000 -0.002143 -0.002071 0.008150 +10364 1 0.000282 1560.000000 -0.002772 -0.002623 0.001751 +10365 1 0.000192 1560.000000 0.000232 0.002420 0.000254 +10366 1 0.000280 1560.000000 -0.002370 -0.002704 0.005506 +10367 1 0.000230 1560.000000 -0.001446 0.002421 0.008792 +10368 1 0.000230 1560.000000 -0.002506 -0.002224 0.005753 +10369 1 0.000222 1560.000000 -0.000124 -0.001675 0.002843 +10370 1 0.000260 1560.000000 -0.000143 -0.001926 0.002172 +10371 1 0.000210 1560.000000 0.002222 -0.001649 0.003615 +10372 1 0.000268 1560.000000 -0.000040 0.003779 0.008667 +10373 1 0.000250 1560.000000 -0.003757 -0.000528 0.004945 +10374 1 0.000246 1560.000000 -0.000531 -0.002708 0.007421 +10375 1 0.000193 1560.000000 -0.000155 -0.001049 0.007768 +10376 1 0.000198 1560.000000 0.002332 0.001841 0.007509 +10377 1 0.000207 1560.000000 -0.002333 -0.001267 0.005676 +10378 1 0.000213 1560.000000 -0.000643 -0.001012 0.005688 +10379 1 0.000272 1560.000000 0.001541 0.002633 0.003949 +10380 1 0.000201 1560.000000 0.003226 0.001916 0.009596 +10381 1 0.000213 1560.000000 -0.000254 0.003274 0.000200 +10382 1 0.000203 1560.000000 -0.000163 -0.000709 0.007165 +10383 1 0.000237 1560.000000 0.000372 0.002383 0.001548 +10384 1 0.000193 1560.000000 0.000887 -0.001493 0.009591 +10385 1 0.000198 1560.000000 -0.002004 -0.000859 0.006226 +10386 1 0.000195 1560.000000 -0.000462 0.001278 0.001469 +10387 1 0.000240 1560.000000 0.002573 0.001595 0.007637 +10388 1 0.000209 1560.000000 0.002188 0.000361 0.007552 +10389 1 0.000273 1560.000000 -0.003071 0.001916 0.003602 +10390 1 0.000237 1560.000000 -0.001094 0.000316 0.004747 +10391 1 0.000208 1560.000000 0.000556 0.001259 0.004916 +10392 1 0.000255 1560.000000 -0.003288 -0.001899 0.009360 +10393 1 0.000267 1560.000000 0.002574 0.002583 0.008587 +10394 1 0.000257 1560.000000 -0.001993 0.000798 0.009704 +10395 1 0.000271 1560.000000 -0.000290 0.001940 0.008839 +10396 1 0.000202 1560.000000 -0.003665 0.000078 0.005022 +10397 1 0.000205 1560.000000 -0.003372 -0.000192 0.003602 +10398 1 0.000195 1560.000000 0.001400 0.003318 0.001404 +10399 1 0.000234 1560.000000 -0.001074 0.002847 0.003885 +10400 1 0.000238 1560.000000 0.000948 -0.002861 0.000353 +10401 1 0.000253 1560.000000 -0.002503 0.000661 0.002173 +10402 1 0.000248 1560.000000 0.003090 0.000013 0.007392 +10403 1 0.000266 1560.000000 0.000921 0.001195 0.000584 +10404 1 0.000202 1560.000000 -0.000362 0.001305 0.002082 +10405 1 0.000263 1560.000000 -0.000199 -0.002602 0.001443 +10406 1 0.000241 1560.000000 -0.001598 -0.003249 0.009714 +10407 1 0.000273 1560.000000 -0.000972 -0.003675 0.008897 +10408 1 0.000197 1560.000000 -0.001328 0.002223 0.008817 +10409 1 0.000208 1560.000000 0.001325 0.002110 0.006586 +10410 1 0.000235 1560.000000 0.001497 -0.001579 0.006980 +10411 1 0.000233 1560.000000 -0.002477 0.000489 0.006912 +10412 1 0.000229 1560.000000 -0.003108 0.001974 0.000457 +10413 1 0.000197 1560.000000 0.000014 0.000692 0.004615 +10414 1 0.000263 1560.000000 -0.002512 0.002204 0.008303 +10415 1 0.000192 1560.000000 0.000215 -0.002948 0.004680 +10416 1 0.000221 1560.000000 -0.001686 0.001551 0.004547 +10417 1 0.000216 1560.000000 -0.000958 -0.002391 0.006546 +10418 1 0.000237 1560.000000 0.002530 0.002600 0.001709 +10419 1 0.000226 1560.000000 0.000466 -0.001580 0.000662 +10420 1 0.000247 1560.000000 -0.002446 -0.000540 0.003211 +10421 1 0.000250 1560.000000 -0.002752 0.000323 0.000411 +10422 1 0.000232 1560.000000 0.001097 0.001303 0.005628 +10423 1 0.000211 1560.000000 0.003658 -0.000860 0.003661 +10424 1 0.000200 1560.000000 -0.000659 0.001637 0.000259 +10425 1 0.000203 1560.000000 -0.000047 -0.002708 0.002979 +10426 1 0.000212 1560.000000 0.001196 -0.001199 0.006202 +10427 1 0.000205 1560.000000 -0.000656 0.003235 0.005580 +10428 1 0.000194 1560.000000 -0.001289 0.000160 0.004802 +10429 1 0.000202 1560.000000 0.000297 0.001995 0.000904 +10430 1 0.000255 1560.000000 0.003286 -0.001966 0.001503 +10431 1 0.000221 1560.000000 0.003560 0.000560 0.003711 +10432 1 0.000198 1560.000000 -0.000416 -0.003545 0.002751 +10433 1 0.000228 1560.000000 0.001799 -0.000368 0.007007 +10434 1 0.000225 1560.000000 -0.000530 -0.002955 0.001208 +10435 1 0.000199 1560.000000 0.002298 0.001877 0.001738 +10436 1 0.000275 1560.000000 -0.003830 -0.000275 0.005155 +10437 1 0.000208 1560.000000 -0.001888 0.000813 0.008846 +10438 1 0.000270 1560.000000 0.000612 -0.003246 0.005336 +10439 1 0.000244 1560.000000 0.001515 0.002642 0.008644 +10440 1 0.000216 1560.000000 -0.000806 0.003239 0.002797 +10441 1 0.000234 1560.000000 0.000598 -0.002950 0.001681 +10442 1 0.000284 1560.000000 0.002047 0.002496 0.007625 +10443 1 0.000262 1560.000000 0.000090 0.002792 0.000189 +10444 1 0.000234 1560.000000 -0.001633 -0.000325 0.009157 +10445 1 0.000284 1560.000000 0.000887 0.002327 0.005711 +10446 1 0.000267 1560.000000 -0.001052 0.001492 0.000952 +10447 1 0.000201 1560.000000 0.002083 0.001362 0.004500 +10448 1 0.000198 1560.000000 -0.000485 -0.001455 0.008811 +10449 1 0.000281 1560.000000 -0.000547 0.003311 0.004007 +10450 1 0.000247 1560.000000 0.001526 0.003085 0.001165 +10451 1 0.000216 1560.000000 0.001039 -0.001729 0.000505 +10452 1 0.000253 1560.000000 0.000685 -0.002116 0.006238 +10453 1 0.000263 1560.000000 0.003766 -0.000715 0.002449 +10454 1 0.000193 1560.000000 0.002095 -0.002300 0.008384 +10455 1 0.000266 1560.000000 -0.002410 0.000746 0.005418 +10456 1 0.000238 1560.000000 -0.000674 0.001696 0.001182 +10457 1 0.000193 1560.000000 -0.001091 -0.002884 0.007925 +10458 1 0.000204 1560.000000 0.002416 -0.000150 0.008465 +10459 1 0.000248 1560.000000 -0.003608 0.001286 0.001299 +10460 1 0.000218 1560.000000 -0.002648 0.001019 0.001216 +10461 1 0.000211 1560.000000 -0.003537 -0.000318 0.000914 +10462 1 0.000208 1560.000000 0.000506 0.003257 0.006606 +10463 1 0.000275 1560.000000 0.003718 -0.000426 0.001504 +10464 1 0.000245 1560.000000 -0.003773 0.000522 0.005303 +10465 1 0.000224 1560.000000 -0.001518 -0.002772 0.007994 +10466 1 0.000202 1560.000000 -0.003379 0.000324 0.001093 +10467 1 0.000269 1560.000000 0.001351 0.000941 0.005965 +10468 1 0.000199 1560.000000 -0.003542 -0.000809 0.009672 +10469 1 0.000231 1560.000000 0.001334 0.000122 0.007128 +10470 1 0.000195 1560.000000 -0.002521 0.000039 0.001938 +10471 1 0.000195 1560.000000 -0.002759 -0.001297 0.001798 +10472 1 0.000200 1560.000000 0.001117 0.001993 0.003095 +10473 1 0.000269 1560.000000 0.002360 -0.001274 0.005825 +10474 1 0.000250 1560.000000 -0.002204 0.002033 0.007908 +10475 1 0.000212 1560.000000 -0.002255 0.001868 0.009010 +10476 1 0.000258 1560.000000 0.002717 0.000233 0.004799 +10477 1 0.000276 1560.000000 -0.002688 -0.002596 0.000245 +10478 1 0.000270 1560.000000 -0.002379 -0.000686 0.006118 +10479 1 0.000255 1560.000000 0.002663 0.000158 0.005383 +10480 1 0.000259 1560.000000 0.003133 -0.000032 0.004903 +10481 1 0.000211 1560.000000 -0.003263 -0.000845 0.008340 +10482 1 0.000230 1560.000000 -0.000404 0.000956 0.002714 +10483 1 0.000213 1560.000000 0.003677 -0.000409 0.007253 +10484 1 0.000279 1560.000000 -0.002796 0.002608 0.004271 +10485 1 0.000206 1560.000000 0.000091 0.000580 0.006179 +10486 1 0.000256 1560.000000 -0.003619 -0.000002 0.009647 +10487 1 0.000230 1560.000000 0.002753 0.001487 0.005675 +10488 1 0.000201 1560.000000 -0.000176 0.003306 0.005997 +10489 1 0.000196 1560.000000 -0.001612 0.001918 0.006945 +10490 1 0.000237 1560.000000 0.001591 -0.001553 0.007534 +10491 1 0.000219 1560.000000 -0.001771 0.002068 0.003250 +10492 1 0.000266 1560.000000 0.000462 -0.002503 0.006908 +10493 1 0.000285 1560.000000 0.000946 0.003210 0.004962 +10494 1 0.000219 1560.000000 0.000397 -0.002543 0.005995 +10495 1 0.000194 1560.000000 0.001708 -0.001355 0.000608 +10496 1 0.000236 1560.000000 -0.000153 0.001707 0.006947 +10497 1 0.000241 1560.000000 0.002766 -0.000385 0.004229 +10498 1 0.000225 1560.000000 0.000700 0.000969 0.000970 +10499 1 0.000268 1560.000000 0.001212 -0.001201 0.009255 +10500 1 0.000244 1560.000000 -0.000942 0.001995 0.003640 +10501 1 0.000274 1560.000000 0.000754 0.000481 0.005071 +10502 1 0.000256 1560.000000 0.000203 0.002415 0.007260 +10503 1 0.000216 1560.000000 -0.002600 0.002280 0.005213 +10504 1 0.000195 1560.000000 -0.000649 -0.002436 0.004186 +10505 1 0.000194 1560.000000 -0.000321 0.002038 0.005012 +10506 1 0.000219 1560.000000 0.000660 -0.002362 0.008720 +10507 1 0.000214 1560.000000 0.002793 0.001669 0.009246 +10508 1 0.000281 1560.000000 0.000134 -0.001961 0.004195 +10509 1 0.000202 1560.000000 0.002672 0.002187 0.005244 +10510 1 0.000197 1560.000000 0.003062 -0.000112 0.002068 +10511 1 0.000221 1560.000000 0.001064 0.000911 0.003981 +10512 1 0.000222 1560.000000 0.002732 -0.001659 0.004979 +10513 1 0.000238 1560.000000 0.000278 0.003690 0.007253 +10514 1 0.000209 1560.000000 -0.001581 0.002679 0.005709 +10515 1 0.000244 1560.000000 0.001481 0.003159 0.008318 +10516 1 0.000205 1560.000000 0.001679 0.000020 0.005313 +10517 1 0.000216 1560.000000 -0.003374 0.000733 0.004129 +10518 1 0.000203 1560.000000 0.001471 0.000183 0.006858 +10519 1 0.000197 1560.000000 0.000455 -0.000627 0.004864 +10520 1 0.000234 1560.000000 0.002632 0.000748 0.000881 +10521 1 0.000193 1560.000000 -0.000088 -0.002638 0.008042 +10522 1 0.000218 1560.000000 0.001680 -0.001103 0.004733 +10523 1 0.000247 1560.000000 -0.002534 0.002074 0.009773 +10524 1 0.000216 1560.000000 0.002417 0.001657 0.008195 +10525 1 0.000213 1560.000000 0.000592 -0.001083 0.004990 +10526 1 0.000195 1560.000000 0.000318 -0.000585 0.003143 +10527 1 0.000210 1560.000000 -0.000505 0.001052 0.005511 +10528 1 0.000262 1560.000000 -0.002391 0.001811 0.005716 +10529 1 0.000233 1560.000000 -0.003307 -0.001620 0.006290 +10530 1 0.000249 1560.000000 0.001199 0.002463 0.006014 +10531 1 0.000279 1560.000000 -0.003442 0.001249 0.003830 +10532 1 0.000228 1560.000000 0.000445 -0.002693 0.004849 +10533 1 0.000260 1560.000000 -0.002715 0.002112 0.000480 +10534 1 0.000218 1560.000000 -0.000529 0.002039 0.007853 +10535 1 0.000241 1560.000000 -0.000411 0.000958 0.008284 +10536 1 0.000198 1560.000000 0.001091 -0.001953 0.002139 +10537 1 0.000200 1560.000000 -0.000672 0.000231 0.000794 +10538 1 0.000240 1560.000000 0.001271 0.000950 0.008187 +10539 1 0.000221 1560.000000 -0.000746 0.002222 0.008937 +10540 1 0.000197 1560.000000 -0.003069 -0.001497 0.004632 +10541 1 0.000284 1560.000000 0.002173 0.001581 0.004718 +10542 1 0.000241 1560.000000 -0.002970 0.001363 0.000485 +10543 1 0.000251 1560.000000 0.002543 0.001972 0.006172 +10544 1 0.000240 1560.000000 -0.001230 -0.002373 0.007320 +10545 1 0.000235 1560.000000 -0.000843 -0.000596 0.000179 +10546 1 0.000238 1560.000000 0.001040 0.001810 0.009785 +10547 1 0.000194 1560.000000 0.003755 0.000343 0.004120 +10548 1 0.000206 1560.000000 0.000888 0.003592 0.004603 +10549 1 0.000241 1560.000000 -0.000185 0.001032 0.006411 +10550 1 0.000287 1560.000000 0.003573 0.001373 0.000235 +10551 1 0.000202 1560.000000 0.000956 -0.001049 0.002423 +10552 1 0.000204 1560.000000 -0.001566 -0.002085 0.004293 +10553 1 0.000199 1560.000000 0.001123 -0.001355 0.005522 +10554 1 0.000197 1560.000000 0.003207 0.000468 0.005779 +10555 1 0.000221 1560.000000 -0.000878 0.000339 0.006356 +10556 1 0.000217 1560.000000 0.000378 0.003264 0.007709 +10557 1 0.000281 1560.000000 0.001477 0.003475 0.009622 +10558 1 0.000271 1560.000000 -0.001232 0.001780 0.004370 +10559 1 0.000214 1560.000000 -0.000443 -0.000124 0.002449 +10560 1 0.000193 1560.000000 -0.000579 -0.001290 0.001671 +10561 1 0.000276 1560.000000 -0.001908 -0.002745 0.000240 +10562 1 0.000264 1560.000000 -0.002191 -0.001769 0.004761 +10563 1 0.000217 1560.000000 -0.000121 0.002918 0.001839 +10564 1 0.000273 1560.000000 -0.001612 0.000182 0.004683 +10565 1 0.000234 1560.000000 -0.002043 0.000528 0.008450 +10566 1 0.000224 1560.000000 -0.002104 0.002670 0.008877 +10567 1 0.000210 1560.000000 0.002393 -0.000539 0.001768 +10568 1 0.000280 1560.000000 0.002313 0.000444 0.001082 +10569 1 0.000284 1560.000000 0.000702 -0.003519 0.002230 +10570 1 0.000253 1560.000000 -0.001173 -0.001797 0.009786 +10571 1 0.000248 1560.000000 0.002056 -0.000354 0.008540 +10572 1 0.000254 1560.000000 0.000886 -0.002660 0.006178 +10573 1 0.000226 1560.000000 0.002795 -0.001493 0.004440 +10574 1 0.000198 1560.000000 0.002509 0.000073 0.008748 +10575 1 0.000255 1560.000000 -0.000973 0.000552 0.001833 +10576 1 0.000199 1560.000000 -0.000925 -0.000568 0.004753 +10577 1 0.000247 1560.000000 0.000848 0.000727 0.005733 +10578 1 0.000255 1560.000000 0.002145 -0.002835 0.003887 +10579 1 0.000248 1560.000000 -0.003222 -0.001190 0.005254 +10580 1 0.000218 1560.000000 0.000156 0.001782 0.001641 +10581 1 0.000197 1560.000000 0.000928 0.002265 0.002363 +10582 1 0.000246 1560.000000 -0.003306 0.000912 0.006244 +10583 1 0.000268 1560.000000 -0.003458 0.001411 0.008200 +10584 1 0.000237 1560.000000 0.001701 -0.000113 0.000887 +10585 1 0.000281 1560.000000 -0.002372 -0.001766 0.000155 +10586 1 0.000242 1560.000000 -0.001205 -0.003361 0.000857 +10587 1 0.000252 1560.000000 0.002765 0.001128 0.008116 +10588 1 0.000235 1560.000000 -0.001802 -0.002678 0.004586 +10589 1 0.000286 1560.000000 0.000264 0.002647 0.009438 +10590 1 0.000206 1560.000000 0.003338 0.000409 0.001874 +10591 1 0.000204 1560.000000 0.000099 -0.003769 0.003599 +10592 1 0.000203 1560.000000 -0.000142 0.001366 0.000729 +10593 1 0.000200 1560.000000 -0.000977 -0.002557 0.008477 +10594 1 0.000209 1560.000000 0.003182 0.002078 0.001282 +10595 1 0.000212 1560.000000 0.000984 -0.000704 0.002847 +10596 1 0.000250 1560.000000 0.000334 -0.003801 0.000865 +10597 1 0.000228 1560.000000 -0.001069 0.001162 0.007435 +10598 1 0.000287 1560.000000 0.002701 -0.000525 0.005020 +10599 1 0.000244 1560.000000 0.000110 0.001070 0.001708 +10600 1 0.000196 1560.000000 -0.001113 0.001200 0.004718 +10601 1 0.000203 1560.000000 0.002140 -0.000835 0.004757 +10602 1 0.000243 1560.000000 0.002802 -0.001415 0.005273 +10603 1 0.000198 1560.000000 -0.001002 0.002632 0.001943 +10604 1 0.000230 1560.000000 0.001087 0.000125 0.006626 +10605 1 0.000195 1560.000000 -0.001774 -0.002415 0.003857 +10606 1 0.000249 1560.000000 0.002884 -0.002148 0.006725 +10607 1 0.000266 1560.000000 0.001583 0.002948 0.000646 +10608 1 0.000217 1560.000000 -0.000368 -0.002509 0.008860 +10609 1 0.000248 1560.000000 -0.001386 0.003572 0.007612 +10610 1 0.000196 1560.000000 0.001081 -0.000767 0.008655 +10611 1 0.000203 1560.000000 0.001625 -0.001158 0.005129 +10612 1 0.000208 1560.000000 0.001068 0.001515 0.005919 +10613 1 0.000218 1560.000000 -0.003047 -0.000518 0.008179 +10614 1 0.000193 1560.000000 -0.001184 -0.001598 0.005811 +10615 1 0.000237 1560.000000 -0.001878 -0.001805 0.009363 +10616 1 0.000227 1560.000000 0.001847 -0.002586 0.002339 +10617 1 0.000238 1560.000000 -0.000064 -0.001817 0.005986 +10618 1 0.000197 1560.000000 -0.002821 -0.001071 0.002900 +10619 1 0.000206 1560.000000 0.000433 0.002375 0.006698 +10620 1 0.000258 1560.000000 0.003378 -0.000651 0.007369 +10621 1 0.000238 1560.000000 0.000894 -0.002055 0.006892 +10622 1 0.000256 1560.000000 -0.001467 0.000795 0.002638 +10623 1 0.000261 1560.000000 -0.000698 0.002007 0.008195 +10624 1 0.000197 1560.000000 0.001885 -0.000506 0.000219 +10625 1 0.000229 1560.000000 0.003443 -0.001376 0.007590 +10626 1 0.000195 1560.000000 0.001977 0.001035 0.005998 +10627 1 0.000224 1560.000000 0.003833 0.000208 0.001273 +10628 1 0.000249 1560.000000 -0.002603 -0.002601 0.007208 +10629 1 0.000194 1560.000000 0.002211 -0.000304 0.005677 +10630 1 0.000197 1560.000000 -0.002464 0.000008 0.000500 +10631 1 0.000232 1560.000000 -0.002352 -0.001657 0.001064 +10632 1 0.000247 1560.000000 -0.001821 -0.001950 0.008563 +10633 1 0.000230 1560.000000 0.000075 -0.001455 0.006203 +10634 1 0.000213 1560.000000 -0.001362 -0.000347 0.002440 +10635 1 0.000207 1560.000000 -0.000095 0.000319 0.003155 +10636 1 0.000247 1560.000000 0.000521 -0.002821 0.002680 +10637 1 0.000214 1560.000000 -0.001268 -0.003055 0.007948 +10638 1 0.000231 1560.000000 0.000549 -0.003768 0.002672 +10639 1 0.000261 1560.000000 -0.000765 -0.000917 0.007091 +10640 1 0.000224 1560.000000 -0.000329 0.000643 0.000167 +10641 1 0.000223 1560.000000 0.000840 -0.001626 0.003169 +10642 1 0.000198 1560.000000 -0.002345 -0.000113 0.009237 +10643 1 0.000229 1560.000000 0.001555 -0.001919 0.007228 +10644 1 0.000196 1560.000000 0.000981 -0.002639 0.003015 +10645 1 0.000223 1560.000000 0.001505 0.000372 0.004853 +10646 1 0.000210 1560.000000 -0.001011 0.002988 0.007995 +10647 1 0.000201 1560.000000 0.000289 -0.003181 0.008027 +10648 1 0.000209 1560.000000 -0.001743 -0.000760 0.009034 +10649 1 0.000196 1560.000000 0.003151 0.000883 0.003956 +10650 1 0.000223 1560.000000 0.001911 0.002801 0.002545 +10651 1 0.000228 1560.000000 -0.000942 -0.000368 0.003725 +10652 1 0.000236 1560.000000 -0.000303 0.003747 0.006468 +10653 1 0.000266 1560.000000 0.003087 0.000653 0.005463 +10654 1 0.000232 1560.000000 0.003051 0.001082 0.006681 +10655 1 0.000209 1560.000000 -0.001047 -0.001767 0.003177 +10656 1 0.000277 1560.000000 0.003077 0.000450 0.002947 +10657 1 0.000259 1560.000000 0.002425 0.002212 0.007683 +10658 1 0.000236 1560.000000 -0.000580 0.003305 0.005180 +10659 1 0.000199 1560.000000 0.001820 -0.001511 0.005865 +10660 1 0.000280 1560.000000 0.002985 0.002201 0.001475 +10661 1 0.000223 1560.000000 0.000195 -0.001157 0.003451 +10662 1 0.000213 1560.000000 0.001432 -0.002920 0.003072 +10663 1 0.000225 1560.000000 0.002069 0.000330 0.009672 +10664 1 0.000229 1560.000000 0.001854 -0.001189 0.006960 +10665 1 0.000213 1560.000000 0.002515 -0.002913 0.001189 +10666 1 0.000281 1560.000000 0.002632 -0.000552 0.004401 +10667 1 0.000220 1560.000000 0.003187 0.002066 0.006216 +10668 1 0.000241 1560.000000 -0.001529 0.001409 0.005563 +10669 1 0.000201 1560.000000 0.002686 -0.000168 0.001879 +10670 1 0.000207 1560.000000 0.002078 0.002038 0.004014 +10671 1 0.000226 1560.000000 0.001429 -0.000230 0.001652 +10672 1 0.000241 1560.000000 -0.001478 0.000290 0.005875 +10673 1 0.000194 1560.000000 -0.000118 0.003096 0.005330 +10674 1 0.000221 1560.000000 0.001219 -0.003243 0.000306 +10675 1 0.000208 1560.000000 -0.001994 -0.001190 0.008813 +10676 1 0.000219 1560.000000 0.003411 0.001452 0.008903 +10677 1 0.000276 1560.000000 -0.002136 -0.000703 0.006633 +10678 1 0.000196 1560.000000 -0.000742 0.002116 0.001892 +10679 1 0.000244 1560.000000 0.001500 0.000066 0.009523 +10680 1 0.000219 1560.000000 0.001089 0.000493 0.008042 +10681 1 0.000285 1560.000000 0.003337 0.001152 0.005099 +10682 1 0.000203 1560.000000 0.003640 0.001139 0.008969 +10683 1 0.000202 1560.000000 0.000126 0.002142 0.005162 +10684 1 0.000245 1560.000000 0.000449 0.003045 0.000877 +10685 1 0.000263 1560.000000 0.000293 0.002104 0.002431 +10686 1 0.000265 1560.000000 0.000540 0.001407 0.008910 +10687 1 0.000212 1560.000000 -0.002470 0.001597 0.003148 +10688 1 0.000198 1560.000000 -0.002312 0.001599 0.007738 +10689 1 0.000215 1560.000000 -0.000700 0.003543 0.002689 +10690 1 0.000215 1560.000000 0.003143 -0.001223 0.000129 +10691 1 0.000197 1560.000000 0.003589 -0.001203 0.000817 +10692 1 0.000195 1560.000000 0.000477 0.000574 0.003326 +10693 1 0.000232 1560.000000 0.001296 0.002273 0.002867 +10694 1 0.000201 1560.000000 0.001619 0.002738 0.002131 +10695 1 0.000280 1560.000000 0.002593 0.002277 0.008906 +10696 1 0.000229 1560.000000 -0.001891 -0.001467 0.004864 +10697 1 0.000199 1560.000000 -0.002878 0.002457 0.000863 +10698 1 0.000230 1560.000000 -0.003711 0.000001 0.000482 +10699 1 0.000288 1560.000000 -0.002175 -0.002730 0.002415 +10700 1 0.000201 1560.000000 0.002443 0.002662 0.005423 +10701 1 0.000274 1560.000000 0.001163 -0.003566 0.007989 +10702 1 0.000218 1560.000000 -0.000806 -0.003440 0.008704 +10703 1 0.000234 1560.000000 0.003546 -0.001033 0.002079 +10704 1 0.000248 1560.000000 0.001616 0.002004 0.006396 +10705 1 0.000207 1560.000000 -0.001303 0.000117 0.004411 +10706 1 0.000237 1560.000000 0.000004 -0.003681 0.008306 +10707 1 0.000198 1560.000000 -0.002955 -0.001853 0.003440 +10708 1 0.000220 1560.000000 -0.000027 0.000351 0.001312 +10709 1 0.000234 1560.000000 0.003691 0.000817 0.007937 +10710 1 0.000251 1560.000000 0.000174 -0.003119 0.004830 +10711 1 0.000223 1560.000000 0.000380 0.001289 0.003410 +10712 1 0.000215 1560.000000 -0.003679 -0.001140 0.008606 +10713 1 0.000268 1560.000000 0.002090 -0.002080 0.007930 +10714 1 0.000285 1560.000000 -0.002657 0.000957 0.002643 +10715 1 0.000260 1560.000000 0.001082 0.000460 0.004342 +10716 1 0.000284 1560.000000 0.001167 0.002940 0.007010 +10717 1 0.000210 1560.000000 -0.001500 0.000380 0.001791 +10718 1 0.000258 1560.000000 0.000852 -0.003363 0.005474 +10719 1 0.000229 1560.000000 -0.002839 0.000858 0.002444 +10720 1 0.000255 1560.000000 0.000733 -0.003704 0.005984 +10721 1 0.000209 1560.000000 0.001681 -0.000915 0.005926 +10722 1 0.000200 1560.000000 0.001076 -0.000180 0.008344 +10723 1 0.000193 1560.000000 -0.001380 -0.002327 0.008689 +10724 1 0.000234 1560.000000 -0.002249 0.000348 0.008446 +10725 1 0.000240 1560.000000 0.001216 -0.003578 0.008293 +10726 1 0.000253 1560.000000 0.002351 0.001945 0.005790 +10727 1 0.000206 1560.000000 -0.000844 0.000766 0.001635 +10728 1 0.000193 1560.000000 0.002766 -0.002489 0.003042 +10729 1 0.000249 1560.000000 0.000280 -0.001165 0.004395 +10730 1 0.000207 1560.000000 0.003041 0.000576 0.009685 +10731 1 0.000193 1560.000000 -0.000355 -0.001063 0.003680 +10732 1 0.000210 1560.000000 -0.001809 -0.001896 0.009577 +10733 1 0.000264 1560.000000 0.003411 -0.000181 0.002188 +10734 1 0.000202 1560.000000 -0.002772 -0.001102 0.005552 +10735 1 0.000233 1560.000000 -0.002478 0.001406 0.004874 +10736 1 0.000234 1560.000000 0.002874 -0.001686 0.001981 +10737 1 0.000201 1560.000000 -0.000925 0.001164 0.003098 +10738 1 0.000203 1560.000000 0.001883 0.000857 0.002894 +10739 1 0.000255 1560.000000 0.000726 -0.002990 0.007487 +10740 1 0.000267 1560.000000 0.002428 -0.002350 0.006624 +10741 1 0.000215 1560.000000 -0.002779 0.002269 0.001796 +10742 1 0.000263 1560.000000 0.001123 -0.002662 0.000469 +10743 1 0.000205 1560.000000 -0.003116 0.002198 0.008163 +10744 1 0.000258 1560.000000 -0.002475 -0.001973 0.003063 +10745 1 0.000256 1560.000000 0.001915 0.001129 0.008065 +10746 1 0.000259 1560.000000 -0.002186 -0.000140 0.006264 +10747 1 0.000243 1560.000000 -0.001083 -0.001072 0.008353 +10748 1 0.000201 1560.000000 -0.000479 0.002185 0.002785 +10749 1 0.000193 1560.000000 -0.002380 -0.001568 0.009213 +10750 1 0.000272 1560.000000 -0.002772 0.000308 0.006602 +10751 1 0.000256 1560.000000 -0.001234 -0.001425 0.001458 +10752 1 0.000214 1560.000000 -0.000432 0.002877 0.000660 +10753 1 0.000201 1560.000000 -0.002623 0.001174 0.008681 +10754 1 0.000259 1560.000000 0.002623 0.001753 0.004171 +10755 1 0.000226 1560.000000 0.001677 0.003204 0.004041 +10756 1 0.000245 1560.000000 -0.002076 0.000188 0.001081 +10757 1 0.000249 1560.000000 -0.002931 -0.002362 0.003717 +10758 1 0.000193 1560.000000 0.000355 0.003171 0.000655 +10759 1 0.000212 1560.000000 -0.002340 0.000283 0.001764 +10760 1 0.000193 1560.000000 -0.001416 0.000533 0.001338 +10761 1 0.000284 1560.000000 -0.002712 -0.001524 0.001205 +10762 1 0.000260 1560.000000 -0.001860 -0.002298 0.009013 +10763 1 0.000206 1560.000000 0.002621 0.002706 0.005063 +10764 1 0.000235 1560.000000 0.002493 0.002940 0.002563 +10765 1 0.000263 1560.000000 0.001322 0.002752 0.004266 +10766 1 0.000215 1560.000000 0.002150 0.000966 0.004668 +10767 1 0.000284 1560.000000 -0.002742 -0.002644 0.009367 +10768 1 0.000209 1560.000000 0.000294 -0.000717 0.008676 +10769 1 0.000213 1560.000000 -0.001617 0.000632 0.006756 +10770 1 0.000246 1560.000000 0.002746 0.001504 0.003862 +10771 1 0.000225 1560.000000 0.001005 0.000796 0.001766 +10772 1 0.000286 1560.000000 -0.003220 -0.000207 0.001334 +10773 1 0.000251 1560.000000 -0.000359 0.001531 0.000703 +10774 1 0.000270 1560.000000 -0.000059 -0.003522 0.002204 +10775 1 0.000205 1560.000000 -0.000838 -0.000393 0.002813 +10776 1 0.000209 1560.000000 -0.001936 0.000869 0.008084 +10777 1 0.000233 1560.000000 0.001379 -0.001351 0.002815 +10778 1 0.000239 1560.000000 0.000416 0.002402 0.005341 +10779 1 0.000226 1560.000000 0.001756 -0.002315 0.006148 +10780 1 0.000227 1560.000000 0.002992 -0.002220 0.005713 +10781 1 0.000271 1560.000000 0.001788 -0.002660 0.007763 +10782 1 0.000193 1560.000000 -0.003114 0.001017 0.001824 +10783 1 0.000201 1560.000000 -0.001859 -0.002848 0.006035 +10784 1 0.000252 1560.000000 0.000542 0.000568 0.003859 +10785 1 0.000194 1560.000000 -0.000559 -0.003289 0.004646 +10786 1 0.000204 1560.000000 -0.001214 -0.003337 0.003332 +10787 1 0.000285 1560.000000 -0.002030 0.000206 0.003016 +10788 1 0.000216 1560.000000 0.001615 -0.001720 0.002174 +10789 1 0.000276 1560.000000 -0.000038 0.002462 0.004949 +10790 1 0.000215 1560.000000 0.003353 0.001144 0.004347 +10791 1 0.000244 1560.000000 -0.002111 -0.002257 0.004719 +10792 1 0.000238 1560.000000 0.000971 -0.001795 0.001242 +10793 1 0.000248 1560.000000 0.000231 -0.000512 0.004647 +10794 1 0.000222 1560.000000 0.000567 0.001553 0.008569 +10795 1 0.000207 1560.000000 -0.003636 0.000925 0.006872 +10796 1 0.000283 1560.000000 0.001733 0.003364 0.009852 +10797 1 0.000218 1560.000000 -0.002036 -0.000735 0.007243 +10798 1 0.000234 1560.000000 -0.001570 -0.001382 0.007823 +10799 1 0.000259 1560.000000 -0.002773 0.000130 0.004334 +10800 1 0.000217 1560.000000 0.001075 -0.002370 0.003258 +10801 1 0.000237 1560.000000 0.002120 0.000737 0.006398 +10802 1 0.000210 1560.000000 -0.001426 0.003447 0.003699 +10803 1 0.000198 1560.000000 -0.002786 -0.000209 0.000395 +10804 1 0.000264 1560.000000 -0.000198 0.000484 0.004484 +10805 1 0.000236 1560.000000 -0.000226 -0.003657 0.009214 +10806 1 0.000288 1560.000000 0.001158 -0.002129 0.008204 +10807 1 0.000196 1560.000000 -0.002774 -0.002614 0.007878 +10808 1 0.000217 1560.000000 -0.002528 -0.001144 0.002262 +10809 1 0.000221 1560.000000 -0.001985 -0.000475 0.005364 +10810 1 0.000238 1560.000000 -0.000123 0.003337 0.007684 +10811 1 0.000221 1560.000000 0.000390 -0.002532 0.008047 +10812 1 0.000285 1560.000000 0.001016 -0.003565 0.001218 +10813 1 0.000285 1560.000000 -0.003121 -0.001846 0.006727 +10814 1 0.000233 1560.000000 -0.002947 0.001678 0.006440 +10815 1 0.000225 1560.000000 -0.001270 -0.001451 0.006622 +10816 1 0.000251 1560.000000 0.001991 0.001207 0.006784 +10817 1 0.000236 1560.000000 0.001447 -0.003140 0.009330 +10818 1 0.000230 1560.000000 0.000856 0.003562 0.000152 +10819 1 0.000220 1560.000000 0.002061 -0.001238 0.005973 +10820 1 0.000251 1560.000000 -0.002835 -0.000071 0.005361 +10821 1 0.000206 1560.000000 -0.002156 -0.002888 0.009678 +10822 1 0.000241 1560.000000 -0.003485 -0.000368 0.004679 +10823 1 0.000217 1560.000000 -0.000882 0.003655 0.002030 +10824 1 0.000210 1560.000000 0.001320 -0.000939 0.000635 +10825 1 0.000200 1560.000000 -0.000943 0.002199 0.002694 +10826 1 0.000246 1560.000000 0.000936 0.001057 0.008087 +10827 1 0.000215 1560.000000 -0.000915 0.000148 0.000441 +10828 1 0.000195 1560.000000 -0.001855 0.002174 0.000839 +10829 1 0.000215 1560.000000 0.002593 -0.000484 0.007704 +10830 1 0.000239 1560.000000 -0.003163 0.002083 0.004254 +10831 1 0.000212 1560.000000 0.000298 -0.000430 0.008509 +10832 1 0.000249 1560.000000 -0.002351 0.001761 0.008727 +10833 1 0.000262 1560.000000 -0.001744 0.003068 0.002120 +10834 1 0.000245 1560.000000 -0.000321 -0.002569 0.006203 +10835 1 0.000284 1560.000000 -0.000589 0.003791 0.009103 +10836 1 0.000212 1560.000000 -0.000296 -0.000711 0.009071 +10837 1 0.000228 1560.000000 0.002231 0.002164 0.002573 +10838 1 0.000233 1560.000000 -0.003523 -0.000643 0.009234 +10839 1 0.000245 1560.000000 -0.002600 -0.000512 0.002294 +10840 1 0.000271 1560.000000 -0.001079 0.003686 0.001855 +10841 1 0.000206 1560.000000 -0.002258 -0.000261 0.006059 +10842 1 0.000204 1560.000000 0.001668 -0.001338 0.008531 +10843 1 0.000203 1560.000000 0.001695 0.001253 0.008630 +10844 1 0.000209 1560.000000 0.002868 0.000569 0.000573 +10845 1 0.000241 1560.000000 -0.001580 0.000802 0.003883 +10846 1 0.000198 1560.000000 -0.002811 0.000779 0.003243 +10847 1 0.000228 1560.000000 -0.001650 0.000325 0.001274 +10848 1 0.000275 1560.000000 0.003267 -0.000079 0.002887 +10849 1 0.000204 1560.000000 -0.003766 0.000787 0.000392 +10850 1 0.000205 1560.000000 0.000340 0.003185 0.001966 +10851 1 0.000196 1560.000000 -0.002000 0.003245 0.009735 +10852 1 0.000272 1560.000000 -0.001316 -0.002629 0.007983 +10853 1 0.000212 1560.000000 -0.000020 0.001503 0.006548 +10854 1 0.000204 1560.000000 0.001085 0.001032 0.008828 +10855 1 0.000239 1560.000000 -0.002821 0.000508 0.002111 +10856 1 0.000267 1560.000000 0.000732 -0.002140 0.008590 +10857 1 0.000233 1560.000000 -0.002176 -0.001008 0.006915 +10858 1 0.000267 1560.000000 0.003296 -0.001835 0.008588 +10859 1 0.000277 1560.000000 -0.002565 -0.000294 0.005319 +10860 1 0.000209 1560.000000 0.002201 -0.002764 0.009285 +10861 1 0.000232 1560.000000 0.000697 0.000335 0.007320 +10862 1 0.000251 1560.000000 -0.000358 -0.001343 0.008374 +10863 1 0.000234 1560.000000 0.000883 0.000025 0.004383 +10864 1 0.000211 1560.000000 0.003478 -0.000493 0.005499 +10865 1 0.000226 1560.000000 0.001942 -0.001520 0.009293 +10866 1 0.000239 1560.000000 -0.000855 0.003460 0.007954 +10867 1 0.000236 1560.000000 0.000516 0.001268 0.001549 +10868 1 0.000251 1560.000000 -0.001192 0.002822 0.005389 +10869 1 0.000260 1560.000000 0.000361 -0.002810 0.008857 +10870 1 0.000208 1560.000000 0.003178 -0.001190 0.005803 +10871 1 0.000194 1560.000000 0.000142 -0.002447 0.009423 +10872 1 0.000223 1560.000000 0.000974 -0.001390 0.000132 +10873 1 0.000271 1560.000000 -0.001158 0.002533 0.003337 +10874 1 0.000196 1560.000000 0.001143 -0.000919 0.005690 +10875 1 0.000278 1560.000000 -0.003003 -0.001850 0.007657 +10876 1 0.000194 1560.000000 -0.001680 -0.003157 0.000326 +10877 1 0.000285 1560.000000 0.000246 0.003567 0.003004 +10878 1 0.000199 1560.000000 -0.003502 0.001509 0.002812 +10879 1 0.000265 1560.000000 -0.002714 -0.000890 0.007850 +10880 1 0.000229 1560.000000 -0.001710 0.001934 0.007397 +10881 1 0.000195 1560.000000 -0.002305 -0.002607 0.006862 +10882 1 0.000193 1560.000000 -0.002205 0.000032 0.004229 +10883 1 0.000256 1560.000000 -0.001838 -0.000552 0.002590 +10884 1 0.000193 1560.000000 0.003288 -0.001639 0.003328 +10885 1 0.000256 1560.000000 -0.001850 -0.001917 0.002791 +10886 1 0.000200 1560.000000 -0.000643 0.002155 0.009793 +10887 1 0.000282 1560.000000 0.002817 -0.000509 0.006802 +10888 1 0.000203 1560.000000 0.000957 0.000825 0.009483 +10889 1 0.000278 1560.000000 0.002532 0.000345 0.009839 +10890 1 0.000242 1560.000000 0.002958 0.000004 0.001842 +10891 1 0.000194 1560.000000 0.000055 0.000991 0.009354 +10892 1 0.000263 1560.000000 0.001185 0.003570 0.006807 +10893 1 0.000285 1560.000000 -0.000371 -0.001935 0.000660 +10894 1 0.000287 1560.000000 0.001179 -0.003367 0.002969 +10895 1 0.000262 1560.000000 0.002065 0.000999 0.000966 +10896 1 0.000192 1560.000000 -0.000276 0.000678 0.008457 +10897 1 0.000205 1560.000000 0.000004 0.001248 0.008681 +10898 1 0.000262 1560.000000 0.002576 -0.001824 0.007402 +10899 1 0.000254 1560.000000 0.002417 -0.002845 0.007954 +10900 1 0.000263 1560.000000 -0.002816 0.001998 0.007566 +10901 1 0.000210 1560.000000 -0.001685 0.003342 0.009277 +10902 1 0.000263 1560.000000 0.002452 0.000381 0.005569 +10903 1 0.000286 1560.000000 -0.003083 -0.002299 0.008290 +10904 1 0.000240 1560.000000 0.000498 0.001976 0.000474 +10905 1 0.000210 1560.000000 -0.000113 0.002626 0.007709 +10906 1 0.000198 1560.000000 -0.003824 0.000127 0.005572 +10907 1 0.000253 1560.000000 0.000473 0.000089 0.003336 +10908 1 0.000210 1560.000000 -0.001629 0.002617 0.003442 +10909 1 0.000255 1560.000000 0.000879 -0.002939 0.008152 +10910 1 0.000202 1560.000000 -0.002357 -0.000931 0.003615 +10911 1 0.000210 1560.000000 0.002963 -0.001168 0.000735 +10912 1 0.000212 1560.000000 -0.001172 -0.002297 0.000507 +10913 1 0.000251 1560.000000 -0.001897 -0.002959 0.008818 +10914 1 0.000255 1560.000000 -0.001547 0.001122 0.006501 +10915 1 0.000256 1560.000000 -0.001657 0.003146 0.009047 +10916 1 0.000228 1560.000000 -0.000701 0.003734 0.006555 +10917 1 0.000257 1560.000000 -0.001154 0.001870 0.001158 +10918 1 0.000223 1560.000000 -0.000836 -0.000880 0.005689 +10919 1 0.000261 1560.000000 -0.001495 -0.000160 0.006117 +10920 1 0.000204 1560.000000 0.002771 0.000420 0.007013 +10921 1 0.000198 1560.000000 0.003670 0.000196 0.007135 +10922 1 0.000281 1560.000000 0.000286 -0.002175 0.000464 +10923 1 0.000235 1560.000000 -0.002506 -0.001731 0.004122 +10924 1 0.000267 1560.000000 0.002212 -0.000152 0.006764 +10925 1 0.000237 1560.000000 -0.002898 -0.001374 0.004364 +10926 1 0.000254 1560.000000 0.000217 0.001499 0.006897 +10927 1 0.000239 1560.000000 0.001480 0.001412 0.009310 +10928 1 0.000195 1560.000000 -0.000746 0.002500 0.009244 +10929 1 0.000241 1560.000000 -0.000485 -0.000913 0.000938 +10930 1 0.000220 1560.000000 -0.003522 0.001502 0.009595 +10931 1 0.000225 1560.000000 0.001109 0.001695 0.000773 +10932 1 0.000269 1560.000000 -0.001830 0.001903 0.008785 +10933 1 0.000214 1560.000000 -0.001417 0.001469 0.006097 +10934 1 0.000263 1560.000000 -0.000061 0.002591 0.006481 +10935 1 0.000228 1560.000000 -0.000114 -0.002573 0.009473 +10936 1 0.000193 1560.000000 0.000861 0.001621 0.005570 +10937 1 0.000202 1560.000000 0.001432 0.002364 0.005140 +10938 1 0.000244 1560.000000 -0.001061 0.002418 0.008051 +10939 1 0.000210 1560.000000 0.002613 -0.002544 0.000835 +10940 1 0.000234 1560.000000 0.000168 -0.001635 0.006553 +10941 1 0.000275 1560.000000 0.001130 0.001115 0.001946 +10942 1 0.000223 1560.000000 -0.003065 -0.000648 0.001794 +10943 1 0.000230 1560.000000 0.002626 -0.000839 0.002758 +10944 1 0.000276 1560.000000 -0.003791 -0.000261 0.000904 +10945 1 0.000210 1560.000000 0.000980 0.000761 0.002551 +10946 1 0.000229 1560.000000 0.001897 0.000380 0.005116 +10947 1 0.000227 1560.000000 -0.000385 0.001891 0.002342 +10948 1 0.000215 1560.000000 -0.001211 0.000099 0.009357 +10949 1 0.000232 1560.000000 0.001589 -0.000929 0.009539 +10950 1 0.000220 1560.000000 -0.002252 -0.002085 0.009205 +10951 1 0.000262 1560.000000 0.001907 0.003150 0.006458 +10952 1 0.000209 1560.000000 0.001580 0.002466 0.008392 +10953 1 0.000267 1560.000000 -0.000522 -0.002797 0.002120 +10954 1 0.000271 1560.000000 0.003621 0.001046 0.006716 +10955 1 0.000197 1560.000000 0.002889 -0.001945 0.008353 +10956 1 0.000276 1560.000000 0.001258 -0.002811 0.008339 +10957 1 0.000274 1560.000000 0.001936 -0.002414 0.007306 +10958 1 0.000197 1560.000000 -0.002150 -0.002883 0.006666 +10959 1 0.000208 1560.000000 -0.001741 -0.000367 0.008881 +10960 1 0.000261 1560.000000 -0.002066 0.001405 0.006991 +10961 1 0.000198 1560.000000 -0.002650 -0.001516 0.007260 +10962 1 0.000217 1560.000000 -0.003059 0.000564 0.004572 +10963 1 0.000231 1560.000000 -0.002080 0.000637 0.007779 +10964 1 0.000242 1560.000000 0.002628 -0.000998 0.007143 +10965 1 0.000284 1560.000000 0.003109 -0.001863 0.008291 +10966 1 0.000247 1560.000000 -0.000798 0.000655 0.006380 +10967 1 0.000278 1560.000000 0.001285 0.001582 0.008067 +10968 1 0.000202 1560.000000 -0.002793 0.002478 0.009308 +10969 1 0.000254 1560.000000 0.000169 0.002962 0.007075 +10970 1 0.000226 1560.000000 0.001500 0.002958 0.009796 +10971 1 0.000195 1560.000000 0.001930 -0.000816 0.004043 +10972 1 0.000251 1560.000000 -0.001659 0.003399 0.003994 +10973 1 0.000235 1560.000000 -0.001079 0.001255 0.005715 +10974 1 0.000226 1560.000000 0.001206 -0.000018 0.004891 +10975 1 0.000230 1560.000000 -0.003503 0.001588 0.003041 +10976 1 0.000243 1560.000000 -0.000751 -0.003731 0.005385 +10977 1 0.000277 1560.000000 -0.000103 -0.001880 0.008161 +10978 1 0.000203 1560.000000 0.002645 -0.001340 0.005974 +10979 1 0.000229 1560.000000 0.001700 0.003420 0.003570 +10980 1 0.000198 1560.000000 0.001738 0.002522 0.005365 +10981 1 0.000279 1560.000000 -0.000635 -0.001230 0.004428 +10982 1 0.000257 1560.000000 -0.001727 -0.000984 0.008613 +10983 1 0.000226 1560.000000 0.001942 0.001619 0.009079 +10984 1 0.000201 1560.000000 -0.000354 -0.001015 0.006423 +10985 1 0.000261 1560.000000 -0.001424 0.000621 0.004172 +10986 1 0.000219 1560.000000 -0.003412 0.000135 0.009393 +10987 1 0.000215 1560.000000 0.002513 0.001255 0.003530 +10988 1 0.000245 1560.000000 0.001929 0.002636 0.000380 +10989 1 0.000217 1560.000000 -0.000899 0.000715 0.000370 +10990 1 0.000206 1560.000000 0.000568 -0.000731 0.003369 +10991 1 0.000252 1560.000000 0.002983 0.002013 0.006048 +10992 1 0.000208 1560.000000 0.000945 -0.003458 0.008839 +10993 1 0.000203 1560.000000 -0.003023 0.001286 0.003792 +10994 1 0.000236 1560.000000 -0.003057 -0.001010 0.000369 +10995 1 0.000279 1560.000000 0.000039 -0.001140 0.001755 +10996 1 0.000220 1560.000000 -0.000419 -0.003830 0.000349 +10997 1 0.000254 1560.000000 -0.002976 -0.000263 0.006591 +10998 1 0.000262 1560.000000 0.002261 0.001431 0.003544 +10999 1 0.000207 1560.000000 -0.001258 0.003185 0.005581 +11000 1 0.000234 1560.000000 0.002039 0.002583 0.002506 +11001 1 0.000270 1560.000000 -0.001992 -0.002426 0.009577 +11002 1 0.000221 1560.000000 0.000665 0.001089 0.001896 +11003 1 0.000212 1560.000000 -0.001736 0.002444 0.007380 +11004 1 0.000209 1560.000000 0.000668 0.000271 0.008523 +11005 1 0.000199 1560.000000 -0.001822 -0.000148 0.001257 +11006 1 0.000217 1560.000000 0.000043 -0.002794 0.000665 +11007 1 0.000261 1560.000000 -0.001689 0.000260 0.003886 +11008 1 0.000223 1560.000000 -0.000513 -0.001288 0.001060 +11009 1 0.000283 1560.000000 -0.002449 -0.002537 0.006394 +11010 1 0.000197 1560.000000 -0.000958 -0.001103 0.002175 +11011 1 0.000224 1560.000000 0.003297 0.001178 0.005732 +11012 1 0.000207 1560.000000 0.001699 0.000647 0.000655 +11013 1 0.000218 1560.000000 0.001075 -0.003600 0.009037 +11014 1 0.000237 1560.000000 0.001236 0.001976 0.005095 +11015 1 0.000214 1560.000000 0.000275 0.001698 0.005779 +11016 1 0.000265 1560.000000 0.001513 -0.000107 0.008274 +11017 1 0.000212 1560.000000 0.002421 -0.001336 0.004294 +11018 1 0.000238 1560.000000 0.000458 -0.002750 0.009536 +11019 1 0.000245 1560.000000 -0.000680 -0.003331 0.005623 +11020 1 0.000260 1560.000000 -0.000226 -0.001054 0.005387 +11021 1 0.000210 1560.000000 -0.001561 0.003445 0.006912 +11022 1 0.000231 1560.000000 -0.001361 -0.003263 0.003550 +11023 1 0.000241 1560.000000 -0.002919 -0.002417 0.000166 +11024 1 0.000204 1560.000000 -0.002403 0.000849 0.008240 +11025 1 0.000287 1560.000000 0.001470 0.002872 0.008296 +11026 1 0.000206 1560.000000 -0.001275 0.000053 0.006773 +11027 1 0.000280 1560.000000 -0.001354 0.002611 0.009342 +11028 1 0.000195 1560.000000 -0.003591 0.001201 0.004581 +11029 1 0.000249 1560.000000 -0.003144 -0.000266 0.003265 +11030 1 0.000234 1560.000000 -0.003296 0.000539 0.003361 +11031 1 0.000196 1560.000000 0.000107 0.003267 0.001123 +11032 1 0.000192 1560.000000 -0.001117 -0.001213 0.002272 +11033 1 0.000200 1560.000000 -0.001067 0.001792 0.008628 +11034 1 0.000275 1560.000000 -0.002258 -0.002458 0.002056 +11035 1 0.000215 1560.000000 0.001578 -0.001851 0.006747 +11036 1 0.000207 1560.000000 0.000807 -0.000680 0.000814 +11037 1 0.000257 1560.000000 0.003381 -0.001189 0.000691 +11038 1 0.000268 1560.000000 0.002320 -0.001396 0.006954 +11039 1 0.000209 1560.000000 0.001954 -0.000776 0.006622 +11040 1 0.000244 1560.000000 -0.001243 -0.002241 0.007826 +11041 1 0.000266 1560.000000 0.003352 0.001488 0.004594 +11042 1 0.000236 1560.000000 -0.002785 -0.002376 0.004690 +11043 1 0.000201 1560.000000 -0.001388 0.003041 0.006230 +11044 1 0.000247 1560.000000 0.002740 -0.000424 0.003680 +11045 1 0.000228 1560.000000 -0.003202 -0.000412 0.009524 +11046 1 0.000270 1560.000000 -0.003781 -0.000419 0.006856 +11047 1 0.000210 1560.000000 -0.000780 0.002942 0.009814 +11048 1 0.000243 1560.000000 0.002156 0.002681 0.008441 +11049 1 0.000262 1560.000000 -0.003597 -0.000220 0.003404 +11050 1 0.000250 1560.000000 0.002248 -0.001421 0.006595 +11051 1 0.000202 1560.000000 -0.001825 -0.000328 0.009544 +11052 1 0.000284 1560.000000 -0.001964 0.003124 0.009343 +11053 1 0.000261 1560.000000 -0.000172 -0.003387 0.001477 +11054 1 0.000202 1560.000000 -0.002062 -0.001661 0.006285 +11055 1 0.000285 1560.000000 -0.000234 0.001682 0.002919 +11056 1 0.000208 1560.000000 -0.000807 0.000980 0.003179 +11057 1 0.000247 1560.000000 -0.000416 -0.003654 0.009040 +11058 1 0.000209 1560.000000 -0.001886 -0.002004 0.003039 +11059 1 0.000247 1560.000000 0.002342 -0.000241 0.009633 +11060 1 0.000202 1560.000000 -0.002117 0.001917 0.003619 +11061 1 0.000242 1560.000000 -0.000312 -0.003631 0.009573 +11062 1 0.000257 1560.000000 -0.000609 -0.002274 0.009575 +11063 1 0.000206 1560.000000 -0.002852 0.000569 0.007799 +11064 1 0.000256 1560.000000 -0.002968 0.001038 0.006265 +11065 1 0.000283 1560.000000 0.002228 -0.002872 0.008527 +11066 1 0.000273 1560.000000 0.001012 0.002728 0.002450 +11067 1 0.000260 1560.000000 0.002455 0.001880 0.007962 +11068 1 0.000250 1560.000000 -0.001417 -0.000033 0.009341 +11069 1 0.000247 1560.000000 -0.000383 -0.000344 0.008461 +11070 1 0.000203 1560.000000 0.003675 -0.000794 0.006290 +11071 1 0.000243 1560.000000 -0.002429 0.002322 0.005659 +11072 1 0.000231 1560.000000 0.003063 -0.001192 0.006613 +11073 1 0.000200 1560.000000 0.002140 -0.000331 0.000743 +11074 1 0.000213 1560.000000 -0.002808 0.000840 0.007202 +11075 1 0.000264 1560.000000 0.002878 -0.001693 0.005892 +11076 1 0.000210 1560.000000 -0.000708 0.002363 0.008458 +11077 1 0.000229 1560.000000 0.001436 -0.003018 0.001897 +11078 1 0.000277 1560.000000 -0.000438 -0.003389 0.002957 +11079 1 0.000272 1560.000000 -0.000773 -0.003739 0.003206 +11080 1 0.000196 1560.000000 -0.000456 -0.000400 0.003181 +11081 1 0.000222 1560.000000 -0.003349 -0.000866 0.006101 +11082 1 0.000229 1560.000000 -0.002886 0.001186 0.002110 +11083 1 0.000250 1560.000000 0.000259 0.000825 0.008229 +11084 1 0.000211 1560.000000 0.000064 0.002588 0.006250 +11085 1 0.000270 1560.000000 -0.000556 -0.003106 0.007657 +11086 1 0.000205 1560.000000 -0.001432 -0.000861 0.007159 +11087 1 0.000263 1560.000000 -0.003076 -0.000362 0.002350 +11088 1 0.000196 1560.000000 -0.000797 0.002772 0.004609 +11089 1 0.000227 1560.000000 -0.002644 -0.000384 0.001031 +11090 1 0.000258 1560.000000 -0.002769 -0.000796 0.003530 +11091 1 0.000214 1560.000000 -0.003656 0.000221 0.008469 +11092 1 0.000237 1560.000000 0.001308 0.001556 0.001814 +11093 1 0.000196 1560.000000 -0.001260 -0.001334 0.006112 +11094 1 0.000233 1560.000000 0.001456 -0.002458 0.004227 +11095 1 0.000195 1560.000000 0.000263 0.001568 0.008033 +11096 1 0.000261 1560.000000 0.001105 -0.001250 0.007708 +11097 1 0.000228 1560.000000 0.003613 -0.000234 0.002367 +11098 1 0.000279 1560.000000 -0.000626 0.002688 0.006085 +11099 1 0.000212 1560.000000 -0.001640 -0.001437 0.006505 +11100 1 0.000227 1560.000000 0.000848 -0.001117 0.004475 +11101 1 0.000228 1560.000000 -0.002424 0.000630 0.007625 +11102 1 0.000226 1560.000000 0.000098 -0.002318 0.006635 +11103 1 0.000230 1560.000000 -0.002757 -0.001315 0.004651 +11104 1 0.000269 1560.000000 -0.000036 0.003463 0.002368 +11105 1 0.000208 1560.000000 -0.000300 0.002830 0.008168 +11106 1 0.000199 1560.000000 0.002146 -0.002252 0.008723 +11107 1 0.000245 1560.000000 0.000501 0.002416 0.000883 +11108 1 0.000231 1560.000000 -0.000681 -0.001406 0.005491 +11109 1 0.000209 1560.000000 -0.000825 -0.002370 0.004060 +11110 1 0.000205 1560.000000 0.003181 -0.000764 0.007260 +11111 1 0.000196 1560.000000 -0.001494 -0.001634 0.004661 +11112 1 0.000253 1560.000000 -0.002177 -0.002416 0.005127 +11113 1 0.000250 1560.000000 0.002999 0.000641 0.003766 +11114 1 0.000196 1560.000000 0.000732 0.003608 0.005604 +11115 1 0.000193 1560.000000 -0.003287 0.000634 0.008918 +11116 1 0.000251 1560.000000 0.003099 0.000844 0.008782 +11117 1 0.000219 1560.000000 -0.002442 -0.001426 0.003870 +11118 1 0.000223 1560.000000 -0.002823 0.000125 0.002615 +11119 1 0.000237 1560.000000 -0.003382 -0.001851 0.003800 +11120 1 0.000210 1560.000000 0.000104 0.000736 0.008471 +11121 1 0.000196 1560.000000 0.001832 0.000470 0.003000 +11122 1 0.000217 1560.000000 -0.001212 0.002289 0.006569 +11123 1 0.000198 1560.000000 0.002306 -0.002441 0.005963 +11124 1 0.000238 1560.000000 -0.000900 -0.000392 0.005172 +11125 1 0.000202 1560.000000 -0.001548 -0.003303 0.001747 +11126 1 0.000215 1560.000000 -0.000478 -0.001185 0.000457 +11127 1 0.000214 1560.000000 0.000344 0.000101 0.009802 +11128 1 0.000195 1560.000000 0.002342 -0.002426 0.008779 +11129 1 0.000204 1560.000000 -0.000495 -0.002286 0.002544 +11130 1 0.000256 1560.000000 -0.002050 -0.000671 0.006053 +11131 1 0.000253 1560.000000 -0.003290 0.000523 0.000237 +11132 1 0.000223 1560.000000 0.002530 0.001759 0.003827 +11133 1 0.000230 1560.000000 -0.001163 -0.002468 0.004567 +11134 1 0.000255 1560.000000 0.000651 0.003446 0.003111 +11135 1 0.000270 1560.000000 0.000033 0.001709 0.007550 +11136 1 0.000195 1560.000000 0.003582 -0.000563 0.004665 +11137 1 0.000253 1560.000000 -0.003571 -0.000228 0.007371 +11138 1 0.000264 1560.000000 0.002294 -0.002634 0.003599 +11139 1 0.000227 1560.000000 -0.000067 0.002515 0.001504 +11140 1 0.000235 1560.000000 -0.001901 0.000551 0.009482 +11141 1 0.000211 1560.000000 0.002712 -0.001438 0.009587 +11142 1 0.000214 1560.000000 0.000523 0.001285 0.000405 +11143 1 0.000227 1560.000000 -0.003640 0.001122 0.007181 +11144 1 0.000275 1560.000000 0.001313 0.003040 0.008778 +11145 1 0.000253 1560.000000 -0.001242 0.003090 0.002157 +11146 1 0.000222 1560.000000 0.001420 -0.002399 0.001033 +11147 1 0.000193 1560.000000 0.001120 -0.003371 0.001911 +11148 1 0.000228 1560.000000 -0.000004 0.001695 0.009256 +11149 1 0.000260 1560.000000 -0.000100 -0.002509 0.004736 +11150 1 0.000236 1560.000000 -0.002067 -0.003044 0.008516 +11151 1 0.000218 1560.000000 -0.000027 -0.000892 0.001311 +11152 1 0.000239 1560.000000 -0.001752 0.000297 0.002554 +11153 1 0.000242 1560.000000 -0.001585 -0.000230 0.007395 +11154 1 0.000215 1560.000000 0.001425 -0.001866 0.003994 +11155 1 0.000262 1560.000000 -0.001705 -0.000585 0.000315 +11156 1 0.000265 1560.000000 -0.000701 0.001617 0.006983 +11157 1 0.000247 1560.000000 -0.000474 0.002495 0.002994 +11158 1 0.000229 1560.000000 0.002033 0.002946 0.000276 +11159 1 0.000233 1560.000000 0.002515 -0.001935 0.008246 +11160 1 0.000241 1560.000000 -0.001421 -0.000701 0.006970 +11161 1 0.000237 1560.000000 -0.001822 0.001955 0.007929 +11162 1 0.000264 1560.000000 -0.001182 0.001646 0.002468 +11163 1 0.000264 1560.000000 -0.002583 -0.001307 0.001403 +11164 1 0.000208 1560.000000 0.002907 -0.001540 0.000748 +11165 1 0.000234 1560.000000 0.001853 -0.000277 0.009354 +11166 1 0.000195 1560.000000 0.002093 -0.002318 0.001140 +11167 1 0.000208 1560.000000 -0.000164 0.001304 0.009787 +11168 1 0.000212 1560.000000 -0.001883 0.001602 0.007790 +11169 1 0.000203 1560.000000 -0.001194 -0.000390 0.003272 +11170 1 0.000234 1560.000000 0.002743 -0.001972 0.004099 +11171 1 0.000265 1560.000000 -0.002310 0.001107 0.005233 +11172 1 0.000227 1560.000000 -0.001566 -0.001849 0.008584 +11173 1 0.000209 1560.000000 -0.002247 -0.000365 0.001560 +11174 1 0.000221 1560.000000 -0.003249 -0.001558 0.005074 +11175 1 0.000193 1560.000000 0.002108 -0.000844 0.006825 +11176 1 0.000209 1560.000000 -0.002369 0.002362 0.001462 +11177 1 0.000208 1560.000000 -0.000004 0.002895 0.000711 +11178 1 0.000216 1560.000000 -0.001584 -0.003261 0.005183 +11179 1 0.000258 1560.000000 0.002352 0.002999 0.000252 +11180 1 0.000193 1560.000000 -0.001310 0.001419 0.001866 +11181 1 0.000208 1560.000000 -0.001409 -0.001297 0.008447 +11182 1 0.000197 1560.000000 -0.002554 -0.002769 0.004777 +11183 1 0.000198 1560.000000 -0.001497 -0.001404 0.003679 +11184 1 0.000213 1560.000000 -0.001988 0.001912 0.009160 +11185 1 0.000200 1560.000000 -0.001371 0.001885 0.001649 +11186 1 0.000245 1560.000000 0.002018 0.000942 0.001828 +11187 1 0.000238 1560.000000 0.002612 -0.001350 0.002916 +11188 1 0.000254 1560.000000 -0.001836 0.000547 0.007554 +11189 1 0.000271 1560.000000 -0.000230 0.003037 0.008004 +11190 1 0.000249 1560.000000 -0.000820 0.000281 0.003935 +11191 1 0.000255 1560.000000 -0.002172 0.001213 0.003269 +11192 1 0.000207 1560.000000 0.000509 0.003738 0.008194 +11193 1 0.000244 1560.000000 0.001096 -0.000315 0.000358 +11194 1 0.000245 1560.000000 0.002016 -0.003107 0.003489 +11195 1 0.000252 1560.000000 0.002465 -0.001669 0.003357 +11196 1 0.000254 1560.000000 -0.000789 -0.003189 0.003402 +11197 1 0.000239 1560.000000 -0.000574 0.002379 0.001199 +11198 1 0.000239 1560.000000 -0.001409 -0.002616 0.004506 +11199 1 0.000254 1560.000000 -0.000470 0.001421 0.007174 +11200 1 0.000249 1560.000000 -0.000686 -0.001358 0.008631 +11201 1 0.000193 1560.000000 -0.000106 -0.001446 0.005178 +11202 1 0.000288 1560.000000 0.003036 0.001227 0.007122 +11203 1 0.000205 1560.000000 -0.001269 0.002956 0.001643 +11204 1 0.000205 1560.000000 0.001390 -0.002550 0.009422 +11205 1 0.000236 1560.000000 0.001821 -0.000285 0.008075 +11206 1 0.000194 1560.000000 0.001286 -0.001078 0.008865 +11207 1 0.000270 1560.000000 -0.003688 0.000227 0.000163 +11208 1 0.000195 1560.000000 -0.001762 -0.001103 0.007124 +11209 1 0.000214 1560.000000 -0.003309 -0.000058 0.009492 +11210 1 0.000263 1560.000000 0.001190 -0.000490 0.008568 +11211 1 0.000207 1560.000000 0.001025 0.003093 0.006735 +11212 1 0.000230 1560.000000 0.000811 0.002379 0.009472 +11213 1 0.000244 1560.000000 -0.002032 -0.000663 0.002084 +11214 1 0.000193 1560.000000 -0.002128 0.002393 0.007311 +11215 1 0.000218 1560.000000 0.000588 -0.003668 0.008651 +11216 1 0.000241 1560.000000 -0.001030 -0.001891 0.007930 +11217 1 0.000266 1560.000000 0.003621 -0.001289 0.008319 +11218 1 0.000268 1560.000000 -0.001370 -0.000465 0.008795 +11219 1 0.000252 1560.000000 -0.002645 -0.001664 0.000484 +11220 1 0.000193 1560.000000 0.003008 0.001204 0.001720 +11221 1 0.000218 1560.000000 0.000559 0.002651 0.008599 +11222 1 0.000231 1560.000000 -0.000078 -0.001425 0.000339 +11223 1 0.000244 1560.000000 -0.000880 -0.000038 0.000249 +11224 1 0.000250 1560.000000 0.002915 0.000472 0.005773 +11225 1 0.000227 1560.000000 0.001109 -0.002441 0.004692 +11226 1 0.000261 1560.000000 0.002083 -0.002840 0.001589 +11227 1 0.000268 1560.000000 0.001039 0.000052 0.001608 +11228 1 0.000284 1560.000000 -0.000476 0.002452 0.008028 +11229 1 0.000224 1560.000000 -0.001808 0.000701 0.000721 +11230 1 0.000197 1560.000000 0.001139 0.002956 0.001960 +11231 1 0.000230 1560.000000 -0.002711 0.002710 0.009401 +11232 1 0.000199 1560.000000 0.000243 0.000412 0.006244 +11233 1 0.000257 1560.000000 -0.001232 -0.000833 0.007954 +11234 1 0.000236 1560.000000 0.003789 -0.000158 0.003023 +11235 1 0.000203 1560.000000 -0.001628 0.001280 0.009798 +11236 1 0.000243 1560.000000 -0.001083 0.000801 0.008924 +11237 1 0.000270 1560.000000 -0.002966 -0.000851 0.005719 +11238 1 0.000255 1560.000000 0.001065 -0.003699 0.009256 +11239 1 0.000217 1560.000000 -0.003595 0.000479 0.006226 +11240 1 0.000202 1560.000000 -0.002090 0.000514 0.008992 +11241 1 0.000281 1560.000000 0.000782 0.002966 0.003083 +11242 1 0.000263 1560.000000 -0.001683 0.002107 0.002404 +11243 1 0.000288 1560.000000 -0.001116 -0.002864 0.005048 +11244 1 0.000221 1560.000000 0.001033 0.000485 0.006559 +11245 1 0.000248 1560.000000 0.002431 0.001632 0.002451 +11246 1 0.000212 1560.000000 0.003271 -0.001900 0.004756 +11247 1 0.000218 1560.000000 -0.002531 -0.001541 0.007943 +11248 1 0.000238 1560.000000 0.001423 0.003573 0.000226 +11249 1 0.000282 1560.000000 0.001113 -0.000488 0.009210 +11250 1 0.000216 1560.000000 0.001253 -0.001092 0.007392 +11251 1 0.000199 1560.000000 -0.000015 0.001686 0.001172 +11252 1 0.000244 1560.000000 -0.002828 0.001167 0.003096 +11253 1 0.000198 1560.000000 -0.003319 -0.001576 0.008939 +11254 1 0.000209 1560.000000 -0.000289 0.003795 0.005988 +11255 1 0.000195 1560.000000 0.003439 -0.000809 0.004022 +11256 1 0.000223 1560.000000 0.003235 -0.001416 0.006968 +11257 1 0.000243 1560.000000 -0.001141 0.003024 0.000677 +11258 1 0.000231 1560.000000 -0.002248 0.002952 0.007460 +11259 1 0.000210 1560.000000 -0.002642 0.000050 0.007529 +11260 1 0.000218 1560.000000 0.003352 -0.001571 0.009079 +11261 1 0.000201 1560.000000 0.001311 -0.000287 0.008275 +11262 1 0.000193 1560.000000 0.002374 0.001889 0.006322 +11263 1 0.000260 1560.000000 -0.001863 -0.001626 0.005776 +11264 1 0.000239 1560.000000 -0.000263 0.000882 0.001279 +11265 1 0.000209 1560.000000 -0.001398 0.000296 0.008907 +11266 1 0.000224 1560.000000 0.002446 0.001044 0.008366 +11267 1 0.000220 1560.000000 -0.002588 -0.002805 0.000477 +11268 1 0.000235 1560.000000 -0.001184 -0.002952 0.001637 +11269 1 0.000209 1560.000000 0.000526 -0.001388 0.001552 +11270 1 0.000196 1560.000000 -0.000086 0.001825 0.004276 +11271 1 0.000278 1560.000000 0.001249 0.002528 0.007187 +11272 1 0.000210 1560.000000 0.002321 0.001940 0.004989 +11273 1 0.000237 1560.000000 0.002269 0.001986 0.004523 +11274 1 0.000241 1560.000000 0.000735 0.000678 0.009447 +11275 1 0.000274 1560.000000 0.001539 -0.001203 0.008353 +11276 1 0.000236 1560.000000 0.001933 -0.000154 0.004320 +11277 1 0.000230 1560.000000 -0.000237 -0.001143 0.000456 +11278 1 0.000215 1560.000000 0.003051 0.000479 0.008497 +11279 1 0.000287 1560.000000 0.000513 0.003629 0.008510 +11280 1 0.000245 1560.000000 0.002937 -0.001713 0.007286 +11281 1 0.000285 1560.000000 0.000878 -0.001459 0.009254 +11282 1 0.000231 1560.000000 -0.002956 0.002224 0.006152 +11283 1 0.000268 1560.000000 0.001170 0.001423 0.007141 +11284 1 0.000211 1560.000000 -0.002527 -0.000775 0.008699 +11285 1 0.000197 1560.000000 0.000861 -0.002152 0.006557 +11286 1 0.000245 1560.000000 0.001858 0.003368 0.004327 +11287 1 0.000201 1560.000000 -0.001186 0.001782 0.005237 +11288 1 0.000196 1560.000000 -0.001250 0.001435 0.006427 +11289 1 0.000199 1560.000000 0.000391 0.003768 0.005301 +11290 1 0.000214 1560.000000 0.000354 -0.001053 0.007325 +11291 1 0.000222 1560.000000 -0.000065 -0.002542 0.004211 +11292 1 0.000223 1560.000000 -0.001653 -0.003373 0.003863 +11293 1 0.000209 1560.000000 0.000046 -0.000382 0.000343 +11294 1 0.000210 1560.000000 -0.000439 -0.002055 0.004196 +11295 1 0.000262 1560.000000 -0.002727 -0.000090 0.002962 +11296 1 0.000195 1560.000000 0.000290 -0.002797 0.001922 +11297 1 0.000238 1560.000000 0.000045 -0.002706 0.004972 +11298 1 0.000245 1560.000000 -0.002480 -0.002708 0.003892 +11299 1 0.000216 1560.000000 -0.001498 0.001682 0.002380 +11300 1 0.000219 1560.000000 -0.000577 -0.000233 0.006077 +11301 1 0.000247 1560.000000 0.000881 0.003372 0.009346 +11302 1 0.000281 1560.000000 -0.001548 0.000448 0.000616 +11303 1 0.000193 1560.000000 0.002594 0.001012 0.003185 +11304 1 0.000212 1560.000000 0.000265 -0.003107 0.002059 +11305 1 0.000210 1560.000000 0.001634 -0.000501 0.002468 +11306 1 0.000212 1560.000000 -0.000228 0.000510 0.000981 +11307 1 0.000276 1560.000000 -0.000386 0.001271 0.007989 +11308 1 0.000196 1560.000000 -0.000313 -0.001172 0.001886 +11309 1 0.000229 1560.000000 -0.001632 0.001221 0.001918 +11310 1 0.000212 1560.000000 0.002738 0.002501 0.002653 +11311 1 0.000215 1560.000000 -0.000417 -0.002635 0.000171 +11312 1 0.000222 1560.000000 -0.001964 -0.000479 0.004300 +11313 1 0.000243 1560.000000 -0.003183 0.002099 0.000653 +11314 1 0.000204 1560.000000 0.000707 0.001556 0.004828 +11315 1 0.000262 1560.000000 0.001582 0.002314 0.007243 +11316 1 0.000239 1560.000000 0.001168 0.000325 0.006423 +11317 1 0.000245 1560.000000 -0.001609 -0.003470 0.006032 +11318 1 0.000208 1560.000000 -0.002939 -0.002390 0.006537 +11319 1 0.000207 1560.000000 0.001764 0.002258 0.004585 +11320 1 0.000242 1560.000000 -0.001377 0.002063 0.002605 +11321 1 0.000220 1560.000000 -0.003059 -0.000423 0.006177 +11322 1 0.000240 1560.000000 -0.002781 -0.000203 0.001486 +11323 1 0.000262 1560.000000 -0.000327 0.003414 0.007065 +11324 1 0.000261 1560.000000 0.001590 -0.003482 0.005091 +11325 1 0.000214 1560.000000 -0.001566 -0.000636 0.002834 +11326 1 0.000221 1560.000000 0.001911 0.000479 0.009032 +11327 1 0.000245 1560.000000 -0.000846 0.001792 0.004385 +11328 1 0.000282 1560.000000 0.000048 -0.002014 0.006463 +11329 1 0.000259 1560.000000 0.003161 0.002134 0.008125 +11330 1 0.000257 1560.000000 -0.003481 -0.000155 0.001077 +11331 1 0.000206 1560.000000 0.002842 -0.001177 0.005868 +11332 1 0.000192 1560.000000 0.000906 -0.000802 0.002555 +11333 1 0.000265 1560.000000 -0.001126 0.001952 0.001498 +11334 1 0.000228 1560.000000 0.001396 -0.001956 0.004439 +11335 1 0.000204 1560.000000 -0.003440 -0.000831 0.001064 +11336 1 0.000233 1560.000000 0.002240 -0.001482 0.008348 +11337 1 0.000263 1560.000000 0.003406 0.000272 0.004837 +11338 1 0.000258 1560.000000 0.002919 0.002233 0.006195 +11339 1 0.000202 1560.000000 0.000275 0.003693 0.003301 +11340 1 0.000225 1560.000000 -0.001660 0.001513 0.000500 +11341 1 0.000195 1560.000000 -0.003290 0.001870 0.002599 +11342 1 0.000254 1560.000000 0.002901 0.002283 0.007375 +11343 1 0.000212 1560.000000 0.001216 0.003127 0.004284 +11344 1 0.000234 1560.000000 -0.003254 -0.001609 0.000322 +11345 1 0.000222 1560.000000 0.002598 -0.001182 0.007863 +11346 1 0.000240 1560.000000 -0.000893 0.002331 0.007727 +11347 1 0.000207 1560.000000 -0.001386 0.001937 0.004578 +11348 1 0.000192 1560.000000 -0.002792 -0.000590 0.007068 +11349 1 0.000236 1560.000000 -0.001920 -0.002370 0.009313 +11350 1 0.000202 1560.000000 0.000795 -0.000892 0.002210 +11351 1 0.000282 1560.000000 0.001141 -0.000477 0.006604 +11352 1 0.000202 1560.000000 -0.000461 0.001228 0.005629 +11353 1 0.000258 1560.000000 0.003623 -0.000987 0.009249 +11354 1 0.000259 1560.000000 -0.002938 -0.000524 0.007810 +11355 1 0.000249 1560.000000 0.000343 0.001812 0.009355 +11356 1 0.000196 1560.000000 0.002022 -0.001789 0.008266 +11357 1 0.000204 1560.000000 -0.001487 0.001193 0.001344 +11358 1 0.000223 1560.000000 -0.002210 -0.001450 0.000245 +11359 1 0.000232 1560.000000 0.001263 -0.001772 0.004517 +11360 1 0.000218 1560.000000 -0.001504 0.003411 0.001815 +11361 1 0.000256 1560.000000 0.001078 0.003693 0.009669 +11362 1 0.000235 1560.000000 -0.001088 0.000809 0.009214 +11363 1 0.000241 1560.000000 -0.002032 -0.001392 0.005895 +11364 1 0.000253 1560.000000 -0.001788 -0.002318 0.001019 +11365 1 0.000240 1560.000000 -0.001898 -0.001445 0.007632 +11366 1 0.000234 1560.000000 0.000988 -0.002795 0.004909 +11367 1 0.000252 1560.000000 0.002021 -0.001755 0.005559 +11368 1 0.000193 1560.000000 0.000566 -0.003149 0.008356 +11369 1 0.000208 1560.000000 -0.002392 0.002111 0.009501 +11370 1 0.000194 1560.000000 0.000453 -0.000550 0.003822 +11371 1 0.000201 1560.000000 0.000276 -0.003288 0.004228 +11372 1 0.000205 1560.000000 -0.003144 0.002160 0.001046 +11373 1 0.000243 1560.000000 0.001786 -0.002530 0.001139 +11374 1 0.000194 1560.000000 0.001250 0.002072 0.004174 +11375 1 0.000256 1560.000000 -0.002122 -0.001411 0.001340 +11376 1 0.000278 1560.000000 -0.000705 0.002455 0.003583 +11377 1 0.000236 1560.000000 -0.000266 0.001498 0.008823 +11378 1 0.000285 1560.000000 0.002670 0.001895 0.000888 +11379 1 0.000256 1560.000000 -0.002234 0.003041 0.007786 +11380 1 0.000219 1560.000000 0.000557 0.003457 0.003981 +11381 1 0.000212 1560.000000 0.003629 -0.000450 0.007999 +11382 1 0.000199 1560.000000 -0.002921 -0.000162 0.003531 +11383 1 0.000264 1560.000000 -0.001664 0.002705 0.002125 +11384 1 0.000224 1560.000000 -0.003500 -0.001292 0.002698 +11385 1 0.000226 1560.000000 -0.000758 0.001937 0.006344 +11386 1 0.000272 1560.000000 -0.001475 0.002440 0.006864 +11387 1 0.000235 1560.000000 -0.002188 -0.001930 0.006424 +11388 1 0.000265 1560.000000 -0.001216 0.000943 0.009655 +11389 1 0.000200 1560.000000 0.001676 -0.003233 0.009385 +11390 1 0.000195 1560.000000 -0.002404 0.002895 0.006358 +11391 1 0.000218 1560.000000 0.000758 -0.002646 0.008950 +11392 1 0.000196 1560.000000 -0.003356 0.001434 0.007736 +11393 1 0.000248 1560.000000 -0.001235 0.003320 0.003684 +11394 1 0.000258 1560.000000 -0.002385 -0.001818 0.009204 +11395 1 0.000237 1560.000000 -0.001660 0.003404 0.003406 +11396 1 0.000272 1560.000000 0.001691 0.002848 0.007133 +11397 1 0.000231 1560.000000 0.002998 0.001703 0.003295 +11398 1 0.000237 1560.000000 0.000408 -0.000470 0.007430 +11399 1 0.000227 1560.000000 -0.000964 0.002753 0.005158 +11400 1 0.000199 1560.000000 0.002089 -0.001403 0.008849 +11401 1 0.000256 1560.000000 -0.002471 0.000004 0.004833 +11402 1 0.000263 1560.000000 0.000037 0.000678 0.002951 +11403 1 0.000238 1560.000000 -0.001445 -0.001571 0.001495 +11404 1 0.000245 1560.000000 -0.002978 0.001840 0.004763 +11405 1 0.000261 1560.000000 0.003105 -0.000020 0.009496 +11406 1 0.000278 1560.000000 -0.002554 0.000519 0.008771 +11407 1 0.000244 1560.000000 -0.000802 -0.000511 0.005636 +11408 1 0.000193 1560.000000 -0.002079 -0.000612 0.002935 +11409 1 0.000267 1560.000000 -0.001084 -0.002862 0.000289 +11410 1 0.000266 1560.000000 -0.000566 0.001113 0.001027 +11411 1 0.000210 1560.000000 -0.000286 -0.003221 0.009651 +11412 1 0.000201 1560.000000 0.002362 -0.002909 0.009453 +11413 1 0.000200 1560.000000 -0.001485 -0.001590 0.007408 +11414 1 0.000279 1560.000000 0.003526 -0.001304 0.002634 +11415 1 0.000234 1560.000000 -0.002274 -0.001198 0.008363 +11416 1 0.000285 1560.000000 0.000912 -0.001470 0.001433 +11417 1 0.000206 1560.000000 0.001492 0.001317 0.005007 +11418 1 0.000200 1560.000000 -0.003039 0.001765 0.008166 +11419 1 0.000246 1560.000000 -0.001399 0.003252 0.005795 +11420 1 0.000262 1560.000000 -0.000257 -0.001794 0.005022 +11421 1 0.000251 1560.000000 0.002799 0.002535 0.006317 +11422 1 0.000233 1560.000000 0.000170 0.003084 0.005671 +11423 1 0.000230 1560.000000 -0.000149 -0.003404 0.004348 +11424 1 0.000246 1560.000000 0.000839 0.001845 0.003853 +11425 1 0.000247 1560.000000 -0.002333 0.000800 0.000258 +11426 1 0.000247 1560.000000 -0.001489 0.003283 0.005363 +11427 1 0.000218 1560.000000 -0.002914 -0.000926 0.000774 +11428 1 0.000230 1560.000000 0.002452 0.002076 0.002501 +11429 1 0.000226 1560.000000 -0.003440 0.001385 0.006449 +11430 1 0.000225 1560.000000 0.001750 -0.002845 0.006585 +11431 1 0.000198 1560.000000 0.002556 0.000751 0.006014 +11432 1 0.000247 1560.000000 0.000811 0.000350 0.006645 +11433 1 0.000279 1560.000000 0.000697 0.001714 0.001252 +11434 1 0.000233 1560.000000 0.001115 -0.002560 0.006551 +11435 1 0.000272 1560.000000 0.000891 0.002647 0.000385 +11436 1 0.000219 1560.000000 0.001708 -0.003280 0.002782 +11437 1 0.000210 1560.000000 0.002367 -0.001022 0.001964 +11438 1 0.000211 1560.000000 0.001655 -0.002075 0.001452 +11439 1 0.000217 1560.000000 -0.000097 -0.001351 0.004657 +11440 1 0.000227 1560.000000 0.000620 -0.002228 0.005748 +11441 1 0.000202 1560.000000 -0.002743 -0.000366 0.006516 +11442 1 0.000266 1560.000000 0.000409 -0.003195 0.001428 +11443 1 0.000204 1560.000000 -0.003674 -0.000812 0.003317 +11444 1 0.000205 1560.000000 0.002096 -0.000287 0.003536 +11445 1 0.000242 1560.000000 0.001904 -0.002030 0.006189 +11446 1 0.000282 1560.000000 -0.000201 0.002906 0.002339 +11447 1 0.000275 1560.000000 0.002200 -0.000936 0.006474 +11448 1 0.000214 1560.000000 -0.000817 -0.003391 0.002641 +11449 1 0.000200 1560.000000 0.000577 -0.001280 0.008055 +11450 1 0.000288 1560.000000 0.002691 0.000536 0.008603 +11451 1 0.000274 1560.000000 0.002866 0.002539 0.003160 +11452 1 0.000199 1560.000000 -0.001139 0.002524 0.006000 +11453 1 0.000276 1560.000000 -0.002522 -0.002373 0.008575 +11454 1 0.000198 1560.000000 0.000085 0.001593 0.007296 +11455 1 0.000214 1560.000000 -0.002105 -0.001458 0.006119 +11456 1 0.000225 1560.000000 -0.003826 -0.000341 0.001213 +11457 1 0.000249 1560.000000 0.002419 -0.000900 0.000697 +11458 1 0.000268 1560.000000 -0.000987 -0.001027 0.005235 +11459 1 0.000267 1560.000000 -0.003743 -0.000855 0.007410 +11460 1 0.000198 1560.000000 0.002311 -0.000587 0.001096 +11461 1 0.000193 1560.000000 -0.003777 -0.000538 0.000555 +11462 1 0.000257 1560.000000 0.000497 0.002941 0.006002 +11463 1 0.000267 1560.000000 0.000540 0.003065 0.001900 +11464 1 0.000226 1560.000000 0.002949 0.002483 0.002917 +11465 1 0.000195 1560.000000 0.001743 0.001399 0.001115 +11466 1 0.000208 1560.000000 0.003296 0.001411 0.004123 +11467 1 0.000207 1560.000000 0.003385 -0.001808 0.001994 +11468 1 0.000211 1560.000000 -0.002724 -0.002601 0.006116 +11469 1 0.000237 1560.000000 0.001699 0.000409 0.001944 +11470 1 0.000199 1560.000000 0.001585 -0.000314 0.004560 +11471 1 0.000250 1560.000000 0.003101 0.001388 0.004309 +11472 1 0.000212 1560.000000 0.001448 0.003378 0.009205 +11473 1 0.000212 1560.000000 -0.000702 -0.002375 0.000443 +11474 1 0.000211 1560.000000 -0.000147 -0.002914 0.000371 +11475 1 0.000209 1560.000000 -0.003655 0.001128 0.004942 +11476 1 0.000193 1560.000000 -0.000108 -0.000795 0.002889 +11477 1 0.000204 1560.000000 -0.000810 0.000125 0.003219 +11478 1 0.000213 1560.000000 -0.001925 -0.001034 0.002742 +11479 1 0.000211 1560.000000 0.002797 0.001770 0.007225 +11480 1 0.000268 1560.000000 -0.000512 0.001981 0.006400 +11481 1 0.000225 1560.000000 0.001984 -0.000150 0.006263 +11482 1 0.000224 1560.000000 0.002162 -0.000220 0.002113 +11483 1 0.000199 1560.000000 -0.001408 -0.001326 0.000319 +11484 1 0.000199 1560.000000 -0.000024 0.001768 0.003186 +11485 1 0.000241 1560.000000 -0.000395 -0.002206 0.005703 +11486 1 0.000225 1560.000000 0.000047 0.002327 0.001279 +11487 1 0.000274 1560.000000 0.002782 -0.000972 0.008988 +11488 1 0.000220 1560.000000 0.002432 -0.002261 0.009726 +11489 1 0.000196 1560.000000 0.001744 0.000537 0.002695 +11490 1 0.000266 1560.000000 -0.000913 -0.001361 0.009799 +11491 1 0.000281 1560.000000 -0.001045 -0.003238 0.000635 +11492 1 0.000215 1560.000000 -0.001146 0.002638 0.002574 +11493 1 0.000272 1560.000000 0.003279 0.001910 0.008618 +11494 1 0.000280 1560.000000 0.002878 -0.002246 0.008254 +11495 1 0.000220 1560.000000 -0.002438 0.001882 0.000448 +11496 1 0.000224 1560.000000 -0.000434 -0.000435 0.000974 +11497 1 0.000276 1560.000000 0.002825 -0.002414 0.004063 +11498 1 0.000238 1560.000000 -0.001378 0.000743 0.001886 +11499 1 0.000262 1560.000000 -0.001869 -0.003319 0.008303 +11500 1 0.000196 1560.000000 -0.001232 -0.000158 0.005279 +11501 1 0.000269 1560.000000 0.001625 -0.000648 0.009520 +11502 1 0.000206 1560.000000 0.002536 0.000952 0.000842 +11503 1 0.000232 1560.000000 0.001405 -0.000236 0.003342 +11504 1 0.000224 1560.000000 -0.000683 0.000467 0.002187 +11505 1 0.000238 1560.000000 -0.001965 -0.002028 0.007795 +11506 1 0.000220 1560.000000 0.002205 -0.002172 0.003444 +11507 1 0.000201 1560.000000 -0.000194 0.000049 0.005255 +11508 1 0.000247 1560.000000 0.002268 -0.001440 0.001696 +11509 1 0.000198 1560.000000 -0.000626 0.002749 0.007262 +11510 1 0.000197 1560.000000 0.001097 0.000759 0.003474 +11511 1 0.000240 1560.000000 -0.001374 -0.003021 0.008771 +11512 1 0.000201 1560.000000 -0.000223 -0.000209 0.002403 +11513 1 0.000229 1560.000000 -0.000116 -0.001621 0.009824 +11514 1 0.000275 1560.000000 -0.001245 -0.003180 0.002170 +11515 1 0.000200 1560.000000 0.000796 0.000707 0.001222 +11516 1 0.000224 1560.000000 0.001200 -0.003174 0.000528 +11517 1 0.000227 1560.000000 0.000187 0.002748 0.003331 +11518 1 0.000283 1560.000000 0.003407 -0.001377 0.007307 +11519 1 0.000241 1560.000000 -0.001813 -0.001232 0.004870 +11520 1 0.000241 1560.000000 -0.000657 0.001973 0.002884 +11521 1 0.000235 1560.000000 -0.003411 -0.000696 0.003363 +11522 1 0.000245 1560.000000 0.002419 -0.001113 0.008657 +11523 1 0.000272 1560.000000 0.002153 0.002712 0.000193 +11524 1 0.000198 1560.000000 0.003578 0.000788 0.008496 +11525 1 0.000199 1560.000000 0.002770 0.002420 0.002396 +11526 1 0.000226 1560.000000 0.001103 0.001050 0.007876 +11527 1 0.000243 1560.000000 0.001725 -0.002372 0.008113 +11528 1 0.000202 1560.000000 0.002119 0.001937 0.000923 +11529 1 0.000270 1560.000000 -0.001140 0.003630 0.005427 +11530 1 0.000243 1560.000000 -0.000052 0.003513 0.008991 +11531 1 0.000265 1560.000000 0.003309 0.001537 0.001488 +11532 1 0.000285 1560.000000 0.001664 -0.003151 0.007375 +11533 1 0.000203 1560.000000 -0.000192 0.000366 0.009396 +11534 1 0.000239 1560.000000 -0.001124 -0.003621 0.008088 +11535 1 0.000229 1560.000000 -0.001825 0.002224 0.005283 +11536 1 0.000221 1560.000000 -0.001350 -0.000757 0.004810 +11537 1 0.000211 1560.000000 -0.000140 0.002570 0.000718 +11538 1 0.000254 1560.000000 0.000612 -0.003519 0.001425 +11539 1 0.000226 1560.000000 -0.001045 -0.000702 0.005630 +11540 1 0.000213 1560.000000 0.001954 -0.002799 0.004664 +11541 1 0.000247 1560.000000 -0.002277 -0.001619 0.007256 +11542 1 0.000216 1560.000000 0.001101 -0.003564 0.005275 +11543 1 0.000276 1560.000000 -0.002210 0.001063 0.003969 +11544 1 0.000212 1560.000000 -0.001678 0.001603 0.005562 +11545 1 0.000250 1560.000000 0.000631 0.002693 0.000748 +11546 1 0.000250 1560.000000 -0.002447 -0.002640 0.006002 +11547 1 0.000279 1560.000000 -0.002827 0.001760 0.003113 +11548 1 0.000196 1560.000000 0.001633 -0.001875 0.006116 +11549 1 0.000196 1560.000000 -0.002197 -0.000251 0.002483 +11550 1 0.000194 1560.000000 0.001056 0.002233 0.001065 +11551 1 0.000226 1560.000000 0.001670 0.001249 0.002881 +11552 1 0.000264 1560.000000 0.002324 0.000958 0.003792 +11553 1 0.000229 1560.000000 -0.000613 -0.000786 0.007854 +11554 1 0.000204 1560.000000 -0.000098 0.003248 0.006675 +11555 1 0.000194 1560.000000 0.000262 -0.003478 0.001840 +11556 1 0.000245 1560.000000 -0.001233 -0.003634 0.000375 +11557 1 0.000236 1560.000000 -0.001279 -0.000005 0.002692 +11558 1 0.000239 1560.000000 0.001046 0.003206 0.002249 +11559 1 0.000207 1560.000000 0.000481 0.001552 0.007945 +11560 1 0.000194 1560.000000 0.001552 -0.000854 0.008807 +11561 1 0.000203 1560.000000 0.003391 0.000315 0.007102 +11562 1 0.000204 1560.000000 0.000432 0.003079 0.007027 +11563 1 0.000257 1560.000000 -0.002841 0.000406 0.001804 +11564 1 0.000211 1560.000000 -0.000071 -0.002111 0.007369 +11565 1 0.000229 1560.000000 0.001500 0.000443 0.008540 +11566 1 0.000222 1560.000000 0.002413 0.000565 0.000140 +11567 1 0.000203 1560.000000 -0.003164 0.001705 0.006006 +11568 1 0.000195 1560.000000 -0.002240 0.000189 0.006350 +11569 1 0.000206 1560.000000 -0.000565 0.000390 0.002628 +11570 1 0.000260 1560.000000 -0.001609 0.002985 0.004978 +11571 1 0.000238 1560.000000 -0.001075 0.002088 0.006488 +11572 1 0.000198 1560.000000 -0.001576 0.001932 0.004818 +11573 1 0.000225 1560.000000 0.002490 -0.000056 0.002602 +11574 1 0.000257 1560.000000 0.003256 -0.000148 0.009174 +11575 1 0.000282 1560.000000 -0.000042 0.002668 0.002331 +11576 1 0.000208 1560.000000 0.003481 -0.001415 0.009691 +11577 1 0.000226 1560.000000 0.000820 0.001119 0.003956 +11578 1 0.000224 1560.000000 0.000565 0.003578 0.002696 +11579 1 0.000243 1560.000000 -0.001895 -0.000845 0.001616 +11580 1 0.000248 1560.000000 0.003071 0.001885 0.005174 +11581 1 0.000223 1560.000000 -0.001418 0.000191 0.001505 +11582 1 0.000199 1560.000000 -0.000364 0.003538 0.001799 +11583 1 0.000203 1560.000000 -0.001945 0.001459 0.005021 +11584 1 0.000254 1560.000000 0.001833 0.002931 0.001960 +11585 1 0.000268 1560.000000 -0.003423 0.000384 0.000537 +11586 1 0.000227 1560.000000 0.001553 0.002035 0.003349 +11587 1 0.000232 1560.000000 -0.002567 -0.001382 0.003008 +11588 1 0.000274 1560.000000 -0.003031 -0.002106 0.003243 +11589 1 0.000280 1560.000000 -0.001587 -0.001597 0.009661 +11590 1 0.000224 1560.000000 0.001133 0.002648 0.003766 +11591 1 0.000259 1560.000000 -0.002178 -0.001057 0.009131 +11592 1 0.000240 1560.000000 0.003469 -0.000171 0.001113 +11593 1 0.000241 1560.000000 -0.002463 -0.002466 0.000509 +11594 1 0.000281 1560.000000 0.000959 0.003213 0.008117 +11595 1 0.000194 1560.000000 -0.003136 0.001741 0.004060 +11596 1 0.000200 1560.000000 -0.000122 0.003732 0.001647 +11597 1 0.000217 1560.000000 -0.001969 -0.002462 0.005464 +11598 1 0.000194 1560.000000 -0.001858 0.001433 0.003533 +11599 1 0.000209 1560.000000 -0.000627 -0.000525 0.008841 +11600 1 0.000227 1560.000000 0.002589 -0.001924 0.003639 +11601 1 0.000249 1560.000000 -0.001999 0.000113 0.000414 +11602 1 0.000227 1560.000000 -0.001316 0.001850 0.000584 +11603 1 0.000202 1560.000000 -0.002542 0.002004 0.008162 +11604 1 0.000250 1560.000000 -0.000617 0.001812 0.001590 +11605 1 0.000211 1560.000000 0.000469 -0.000545 0.008145 +11606 1 0.000284 1560.000000 0.001198 -0.000471 0.008893 +11607 1 0.000217 1560.000000 0.002307 0.002285 0.002396 +11608 1 0.000274 1560.000000 -0.002323 -0.002940 0.006100 +11609 1 0.000224 1560.000000 0.002242 -0.002535 0.001292 +11610 1 0.000196 1560.000000 -0.001476 0.001795 0.005480 +11611 1 0.000286 1560.000000 0.001053 -0.002239 0.004855 +11612 1 0.000206 1560.000000 0.000858 0.002032 0.009359 +11613 1 0.000208 1560.000000 -0.000972 0.000258 0.008106 +11614 1 0.000198 1560.000000 -0.002078 0.002819 0.005215 +11615 1 0.000267 1560.000000 0.003405 -0.001682 0.007467 +11616 1 0.000245 1560.000000 0.002285 0.002509 0.000346 +11617 1 0.000198 1560.000000 0.003613 0.000919 0.002304 +11618 1 0.000264 1560.000000 -0.002399 -0.000511 0.004586 +11619 1 0.000199 1560.000000 0.002673 -0.002620 0.000400 +11620 1 0.000198 1560.000000 0.000739 0.002360 0.005510 +11621 1 0.000207 1560.000000 0.002061 0.000750 0.003121 +11622 1 0.000274 1560.000000 -0.003809 -0.000516 0.004436 +11623 1 0.000214 1560.000000 -0.002968 0.000227 0.005493 +11624 1 0.000247 1560.000000 0.001629 0.003344 0.000579 +11625 1 0.000246 1560.000000 -0.000964 0.002169 0.001830 +11626 1 0.000250 1560.000000 -0.002883 0.001219 0.004705 +11627 1 0.000286 1560.000000 -0.001724 0.000986 0.004639 +11628 1 0.000224 1560.000000 0.002228 0.000887 0.004962 +11629 1 0.000252 1560.000000 0.002833 -0.000261 0.002306 +11630 1 0.000205 1560.000000 0.003756 -0.000220 0.009036 +11631 1 0.000214 1560.000000 0.001816 0.002659 0.002768 +11632 1 0.000225 1560.000000 -0.002945 -0.000766 0.000118 +11633 1 0.000214 1560.000000 0.002443 -0.000805 0.003858 +11634 1 0.000215 1560.000000 0.000054 0.002723 0.001239 +11635 1 0.000238 1560.000000 -0.002880 0.000467 0.006846 +11636 1 0.000224 1560.000000 0.002653 -0.000099 0.002413 +11637 1 0.000221 1560.000000 0.002305 0.001456 0.007086 +11638 1 0.000231 1560.000000 -0.001240 0.000103 0.008059 +11639 1 0.000261 1560.000000 -0.001681 0.001838 0.004200 +11640 1 0.000213 1560.000000 -0.002869 -0.001434 0.007257 +11641 1 0.000212 1560.000000 -0.001861 -0.000552 0.007189 +11642 1 0.000252 1560.000000 -0.000579 -0.003183 0.009010 +11643 1 0.000227 1560.000000 0.001665 0.002355 0.006023 +11644 1 0.000240 1560.000000 -0.002942 -0.000233 0.004813 +11645 1 0.000246 1560.000000 -0.002113 0.001134 0.000961 +11646 1 0.000265 1560.000000 -0.000892 -0.003716 0.003679 +11647 1 0.000286 1560.000000 -0.003452 -0.000377 0.003941 +11648 1 0.000262 1560.000000 0.000210 0.002842 0.001949 +11649 1 0.000264 1560.000000 0.000495 0.001997 0.005856 +11650 1 0.000225 1560.000000 -0.002546 0.000504 0.000953 +11651 1 0.000282 1560.000000 0.000322 0.001360 0.008471 +11652 1 0.000250 1560.000000 -0.003364 0.000102 0.002074 +11653 1 0.000286 1560.000000 -0.003148 -0.001309 0.003067 +11654 1 0.000230 1560.000000 0.000599 -0.003363 0.008282 +11655 1 0.000225 1560.000000 0.000453 0.000694 0.004197 +11656 1 0.000204 1560.000000 0.000293 -0.001677 0.009604 +11657 1 0.000199 1560.000000 -0.002506 0.002262 0.007624 +11658 1 0.000195 1560.000000 -0.002943 -0.000485 0.001084 +11659 1 0.000229 1560.000000 -0.002402 0.000230 0.004440 +11660 1 0.000264 1560.000000 -0.000611 0.003768 0.005348 +11661 1 0.000195 1560.000000 -0.003451 0.001599 0.002483 +11662 1 0.000206 1560.000000 -0.001518 -0.000009 0.002642 +11663 1 0.000274 1560.000000 0.002207 -0.002063 0.006287 +11664 1 0.000211 1560.000000 0.000701 -0.001248 0.008764 +11665 1 0.000221 1560.000000 0.000721 -0.000147 0.003434 +11666 1 0.000232 1560.000000 -0.002053 -0.002367 0.007761 +11667 1 0.000221 1560.000000 0.000180 0.002200 0.004479 +11668 1 0.000254 1560.000000 -0.000975 -0.001860 0.002954 +11669 1 0.000199 1560.000000 -0.002699 -0.002008 0.005656 +11670 1 0.000254 1560.000000 -0.003572 0.001224 0.007537 +11671 1 0.000226 1560.000000 -0.000019 0.000671 0.003510 +11672 1 0.000248 1560.000000 -0.000438 0.002662 0.005882 +11673 1 0.000265 1560.000000 0.003414 0.001673 0.002982 +11674 1 0.000193 1560.000000 -0.001053 -0.000908 0.001735 +11675 1 0.000195 1560.000000 -0.001428 -0.003180 0.000466 +11676 1 0.000203 1560.000000 -0.000595 0.002389 0.006223 +11677 1 0.000237 1560.000000 -0.002122 -0.002953 0.005864 +11678 1 0.000251 1560.000000 -0.001762 -0.001248 0.003292 +11679 1 0.000249 1560.000000 -0.001077 0.001247 0.003881 +11680 1 0.000255 1560.000000 0.002314 -0.000426 0.002027 +11681 1 0.000267 1560.000000 -0.002748 0.000365 0.007615 +11682 1 0.000261 1560.000000 0.000931 -0.001699 0.008994 +11683 1 0.000192 1560.000000 -0.002621 -0.000433 0.004393 +11684 1 0.000284 1560.000000 -0.003069 -0.000722 0.003100 +11685 1 0.000226 1560.000000 -0.001918 -0.001202 0.003017 +11686 1 0.000227 1560.000000 0.002105 0.001880 0.004819 +11687 1 0.000252 1560.000000 -0.002365 0.003044 0.002867 +11688 1 0.000225 1560.000000 -0.003352 -0.001461 0.002871 +11689 1 0.000219 1560.000000 -0.003374 0.001546 0.004355 +11690 1 0.000201 1560.000000 -0.002272 0.000348 0.000604 +11691 1 0.000237 1560.000000 0.001525 0.002135 0.009315 +11692 1 0.000259 1560.000000 0.001564 -0.000404 0.002925 +11693 1 0.000223 1560.000000 0.000415 -0.002027 0.009195 +11694 1 0.000213 1560.000000 0.000716 0.002886 0.002352 +11695 1 0.000224 1560.000000 -0.001347 -0.002009 0.001587 +11696 1 0.000204 1560.000000 -0.001352 0.003588 0.004393 +11697 1 0.000229 1560.000000 -0.002588 0.001253 0.003682 +11698 1 0.000261 1560.000000 0.001740 -0.002663 0.009791 +11699 1 0.000202 1560.000000 -0.001821 0.001503 0.007213 +11700 1 0.000240 1560.000000 0.001893 0.002490 0.003435 +11701 1 0.000228 1560.000000 0.001950 -0.002118 0.009025 +11702 1 0.000245 1560.000000 0.003097 0.000934 0.009062 +11703 1 0.000200 1560.000000 -0.002773 -0.002250 0.005940 +11704 1 0.000257 1560.000000 0.000597 0.000005 0.001404 +11705 1 0.000193 1560.000000 0.002062 -0.003089 0.002673 +11706 1 0.000230 1560.000000 0.001322 0.002272 0.000909 +11707 1 0.000238 1560.000000 -0.002184 0.002495 0.006145 +11708 1 0.000208 1560.000000 0.001904 -0.003336 0.008760 +11709 1 0.000232 1560.000000 -0.001183 -0.002996 0.007251 +11710 1 0.000202 1560.000000 -0.002275 -0.003099 0.004730 +11711 1 0.000224 1560.000000 0.001671 0.000427 0.000986 +11712 1 0.000199 1560.000000 -0.001311 0.002959 0.008280 +11713 1 0.000241 1560.000000 -0.003529 0.000122 0.006990 +11714 1 0.000195 1560.000000 -0.000613 -0.002089 0.001154 +11715 1 0.000218 1560.000000 -0.003513 -0.001487 0.001045 +11716 1 0.000233 1560.000000 -0.000834 -0.002416 0.005241 +11717 1 0.000199 1560.000000 0.002222 -0.001012 0.003900 +11718 1 0.000197 1560.000000 -0.001980 0.002583 0.006678 +11719 1 0.000288 1560.000000 0.003614 -0.000688 0.003391 +11720 1 0.000210 1560.000000 -0.002265 0.001421 0.004661 +11721 1 0.000222 1560.000000 -0.002403 0.001684 0.009141 +11722 1 0.000223 1560.000000 -0.002980 0.001716 0.004295 +11723 1 0.000217 1560.000000 0.003127 -0.002231 0.008917 +11724 1 0.000257 1560.000000 -0.002208 0.000214 0.007565 +11725 1 0.000243 1560.000000 0.001785 -0.002126 0.007060 +11726 1 0.000215 1560.000000 0.002985 0.001425 0.000212 +11727 1 0.000208 1560.000000 0.001896 0.001333 0.004056 +11728 1 0.000202 1560.000000 0.000299 0.000072 0.007449 +11729 1 0.000218 1560.000000 -0.001192 0.002678 0.004553 +11730 1 0.000200 1560.000000 -0.003586 -0.000093 0.001808 +11731 1 0.000283 1560.000000 0.002888 -0.000934 0.009844 +11732 1 0.000198 1560.000000 0.001980 0.001009 0.009271 +11733 1 0.000231 1560.000000 -0.001605 0.002621 0.004586 +11734 1 0.000229 1560.000000 0.000423 -0.003373 0.006924 +11735 1 0.000196 1560.000000 0.001287 -0.002262 0.008901 +11736 1 0.000262 1560.000000 -0.000108 -0.003786 0.000276 +11737 1 0.000223 1560.000000 0.000856 -0.001310 0.007681 +11738 1 0.000271 1560.000000 0.002520 -0.002625 0.008997 +11739 1 0.000263 1560.000000 0.002900 0.000785 0.006519 +11740 1 0.000231 1560.000000 -0.002529 0.001773 0.007572 +11741 1 0.000201 1560.000000 0.001572 0.001248 0.001141 +11742 1 0.000193 1560.000000 0.003012 -0.001253 0.000956 +11743 1 0.000280 1560.000000 -0.000154 -0.002935 0.002383 +11744 1 0.000213 1560.000000 0.002959 0.001329 0.008858 +11745 1 0.000221 1560.000000 -0.002136 -0.002473 0.004345 +11746 1 0.000230 1560.000000 0.001168 0.002808 0.006670 +11747 1 0.000214 1560.000000 -0.003073 -0.000485 0.000741 +11748 1 0.000248 1560.000000 -0.002984 0.001429 0.007809 +11749 1 0.000276 1560.000000 0.002123 -0.000247 0.005996 +11750 1 0.000208 1560.000000 -0.000868 -0.001544 0.005403 +11751 1 0.000201 1560.000000 0.000632 0.000846 0.000799 +11752 1 0.000206 1560.000000 0.001777 0.001710 0.001896 +11753 1 0.000218 1560.000000 -0.000434 -0.000957 0.005601 +11754 1 0.000206 1560.000000 0.000274 0.003481 0.008408 +11755 1 0.000238 1560.000000 0.002227 0.003134 0.005711 +11756 1 0.000234 1560.000000 -0.002403 -0.002441 0.002726 +11757 1 0.000249 1560.000000 -0.000096 0.002990 0.000143 +11758 1 0.000268 1560.000000 -0.001531 0.000095 0.009755 +11759 1 0.000284 1560.000000 0.002201 -0.002328 0.003011 +11760 1 0.000255 1560.000000 0.002989 -0.002112 0.005961 +11761 1 0.000234 1560.000000 -0.000758 0.003521 0.001734 +11762 1 0.000254 1560.000000 0.001866 0.001394 0.007096 +11763 1 0.000264 1560.000000 -0.002062 -0.000532 0.000345 +11764 1 0.000212 1560.000000 -0.002666 -0.000785 0.007277 +11765 1 0.000213 1560.000000 -0.002929 -0.000687 0.002338 +11766 1 0.000194 1560.000000 -0.000641 0.003357 0.006003 +11767 1 0.000228 1560.000000 -0.002302 -0.002527 0.008911 +11768 1 0.000195 1560.000000 -0.000190 -0.000706 0.003414 +11769 1 0.000280 1560.000000 -0.003115 0.000110 0.002573 +11770 1 0.000237 1560.000000 0.000286 0.001944 0.000320 +11771 1 0.000276 1560.000000 -0.001119 -0.001480 0.000501 +11772 1 0.000209 1560.000000 -0.002319 -0.002871 0.001250 +11773 1 0.000229 1560.000000 -0.000674 -0.003613 0.000920 +11774 1 0.000209 1560.000000 0.001257 -0.001458 0.004555 +11775 1 0.000268 1560.000000 0.000707 0.001688 0.007346 +11776 1 0.000212 1560.000000 0.001718 0.000552 0.005686 +11777 1 0.000196 1560.000000 -0.001044 0.000603 0.007221 +11778 1 0.000219 1560.000000 -0.003047 -0.002274 0.009354 +11779 1 0.000199 1560.000000 -0.002542 -0.002409 0.007334 +11780 1 0.000202 1560.000000 -0.000443 -0.000100 0.009792 +11781 1 0.000219 1560.000000 -0.002395 0.001923 0.001026 +11782 1 0.000227 1560.000000 -0.002313 -0.001890 0.008490 +11783 1 0.000200 1560.000000 -0.002587 0.000934 0.006194 +11784 1 0.000212 1560.000000 0.002784 0.000206 0.001040 +11785 1 0.000233 1560.000000 0.003135 -0.000585 0.003534 +11786 1 0.000194 1560.000000 -0.000580 0.000920 0.008815 +11787 1 0.000264 1560.000000 -0.002725 0.002376 0.007315 +11788 1 0.000264 1560.000000 0.001741 -0.001751 0.008936 +11789 1 0.000210 1560.000000 -0.003085 -0.001817 0.003880 +11790 1 0.000194 1560.000000 0.000214 -0.001903 0.002516 +11791 1 0.000222 1560.000000 -0.000436 -0.003461 0.008078 +11792 1 0.000221 1560.000000 0.000891 0.001551 0.001359 +11793 1 0.000285 1560.000000 -0.000236 0.003484 0.000614 +11794 1 0.000231 1560.000000 -0.000557 0.001703 0.004244 +11795 1 0.000228 1560.000000 -0.000453 0.001026 0.000267 +11796 1 0.000225 1560.000000 -0.002819 -0.001094 0.007971 +11797 1 0.000196 1560.000000 0.001188 0.002589 0.003322 +11798 1 0.000260 1560.000000 -0.002967 0.002394 0.005208 +11799 1 0.000275 1560.000000 -0.003237 0.002066 0.006841 +11800 1 0.000271 1560.000000 0.001962 -0.002845 0.000845 +11801 1 0.000197 1560.000000 0.001318 0.001517 0.007369 +11802 1 0.000278 1560.000000 -0.000496 -0.001382 0.003090 +11803 1 0.000269 1560.000000 -0.000465 -0.001607 0.001210 +11804 1 0.000260 1560.000000 -0.000808 -0.003256 0.000412 +11805 1 0.000211 1560.000000 0.003314 -0.000916 0.001514 +11806 1 0.000194 1560.000000 -0.002474 0.002828 0.001795 +11807 1 0.000242 1560.000000 0.003263 -0.000435 0.006217 +11808 1 0.000246 1560.000000 -0.000751 -0.003086 0.005596 +11809 1 0.000229 1560.000000 0.001772 -0.002877 0.004009 +11810 1 0.000194 1560.000000 0.001346 -0.003168 0.008621 +11811 1 0.000259 1560.000000 -0.003528 -0.000206 0.008944 +11812 1 0.000216 1560.000000 0.001169 -0.003516 0.002116 +11813 1 0.000269 1560.000000 0.002598 0.001381 0.005345 +11814 1 0.000203 1560.000000 0.001883 0.002088 0.004967 +11815 1 0.000220 1560.000000 0.003217 -0.002118 0.009392 +11816 1 0.000205 1560.000000 -0.001693 -0.002017 0.003587 +11817 1 0.000248 1560.000000 0.001208 -0.001854 0.006658 +11818 1 0.000285 1560.000000 0.001794 -0.001363 0.001517 +11819 1 0.000230 1560.000000 -0.002316 0.001153 0.002203 +11820 1 0.000203 1560.000000 -0.000757 -0.001459 0.002014 +11821 1 0.000204 1560.000000 -0.001687 0.003451 0.000258 +11822 1 0.000254 1560.000000 0.001138 -0.000562 0.003419 +11823 1 0.000199 1560.000000 -0.000126 -0.002794 0.001239 +11824 1 0.000194 1560.000000 0.001912 0.002700 0.005745 +11825 1 0.000272 1560.000000 -0.003037 0.000961 0.007658 +11826 1 0.000267 1560.000000 -0.000057 0.003592 0.008165 +11827 1 0.000194 1560.000000 -0.003162 -0.000449 0.001240 +11828 1 0.000260 1560.000000 -0.002849 -0.001672 0.007276 +11829 1 0.000207 1560.000000 -0.001383 -0.002210 0.001084 +11830 1 0.000227 1560.000000 0.000394 0.002974 0.003850 +11831 1 0.000268 1560.000000 -0.001146 -0.001959 0.009508 +11832 1 0.000194 1560.000000 0.000727 0.001681 0.005257 +11833 1 0.000277 1560.000000 -0.001552 0.002567 0.001769 +11834 1 0.000270 1560.000000 0.000580 0.000397 0.007910 +11835 1 0.000258 1560.000000 -0.002216 0.001887 0.006423 +11836 1 0.000239 1560.000000 0.001071 0.003397 0.001449 +11837 1 0.000196 1560.000000 -0.000098 -0.002569 0.003545 +11838 1 0.000203 1560.000000 -0.001454 -0.000138 0.004265 +11839 1 0.000233 1560.000000 -0.001157 0.001573 0.006141 +11840 1 0.000202 1560.000000 0.001276 0.002866 0.000659 +11841 1 0.000227 1560.000000 -0.001052 0.000753 0.001001 +11842 1 0.000228 1560.000000 -0.000466 -0.001088 0.001355 +11843 1 0.000228 1560.000000 0.001840 0.002295 0.002481 +11844 1 0.000250 1560.000000 -0.000685 0.001658 0.008622 +11845 1 0.000247 1560.000000 -0.000469 0.001888 0.001822 +11846 1 0.000209 1560.000000 -0.001812 -0.002335 0.006482 +11847 1 0.000195 1560.000000 0.002301 -0.001594 0.004009 +11848 1 0.000192 1560.000000 0.001987 -0.000619 0.004367 +11849 1 0.000225 1560.000000 0.001967 -0.000495 0.007276 +11850 1 0.000206 1560.000000 -0.001137 -0.002027 0.009783 +11851 1 0.000195 1560.000000 0.000965 0.003236 0.008621 +11852 1 0.000251 1560.000000 -0.001127 -0.001004 0.002602 +11853 1 0.000234 1560.000000 -0.000640 0.000661 0.006094 +11854 1 0.000258 1560.000000 -0.002816 -0.000531 0.008897 +11855 1 0.000226 1560.000000 0.002646 -0.000121 0.001313 +11856 1 0.000223 1560.000000 0.000612 -0.001876 0.008629 +11857 1 0.000200 1560.000000 -0.000379 -0.002805 0.003977 +11858 1 0.000253 1560.000000 -0.001717 -0.003343 0.003423 +11859 1 0.000273 1560.000000 0.003203 0.002114 0.003755 +11860 1 0.000200 1560.000000 0.003725 -0.000182 0.009463 +11861 1 0.000279 1560.000000 -0.002519 0.002826 0.007278 +11862 1 0.000203 1560.000000 -0.003366 0.001659 0.003207 +11863 1 0.000215 1560.000000 0.002728 0.001758 0.002927 +11864 1 0.000276 1560.000000 -0.001773 0.000830 0.002678 +11865 1 0.000272 1560.000000 0.003295 0.001391 0.004895 +11866 1 0.000219 1560.000000 0.002270 0.001681 0.003101 +11867 1 0.000286 1560.000000 -0.000650 -0.001441 0.003364 +11868 1 0.000201 1560.000000 -0.001463 -0.002679 0.005749 +11869 1 0.000200 1560.000000 0.002535 0.002302 0.003434 +11870 1 0.000285 1560.000000 0.000303 0.003633 0.005513 +11871 1 0.000250 1560.000000 0.000407 0.001593 0.008777 +11872 1 0.000264 1560.000000 -0.000119 -0.001561 0.003660 +11873 1 0.000266 1560.000000 -0.003431 0.000757 0.000168 +11874 1 0.000210 1560.000000 -0.001896 -0.003247 0.001404 +11875 1 0.000288 1560.000000 -0.003320 0.000853 0.007891 +11876 1 0.000261 1560.000000 -0.002328 0.002712 0.006146 +11877 1 0.000192 1560.000000 -0.000747 0.000445 0.000951 +11878 1 0.000243 1560.000000 -0.001292 0.001304 0.005370 +11879 1 0.000214 1560.000000 0.001971 0.002616 0.001508 +11880 1 0.000232 1560.000000 -0.002581 -0.002588 0.003031 +11881 1 0.000224 1560.000000 -0.000098 -0.000277 0.002669 +11882 1 0.000204 1560.000000 -0.001147 0.003277 0.008753 +11883 1 0.000212 1560.000000 -0.001868 0.000230 0.007559 +11884 1 0.000223 1560.000000 0.001088 0.003515 0.007576 +11885 1 0.000227 1560.000000 0.001638 -0.002818 0.003591 +11886 1 0.000283 1560.000000 0.000454 0.003130 0.005129 +11887 1 0.000264 1560.000000 0.000534 0.002646 0.006087 +11888 1 0.000208 1560.000000 -0.001261 0.000765 0.002768 +11889 1 0.000240 1560.000000 -0.001178 0.002463 0.000418 +11890 1 0.000249 1560.000000 0.001235 -0.000741 0.005582 +11891 1 0.000214 1560.000000 -0.002702 -0.000343 0.008108 +11892 1 0.000274 1560.000000 -0.001018 0.002537 0.007238 +11893 1 0.000234 1560.000000 -0.000923 -0.003230 0.008696 +11894 1 0.000243 1560.000000 -0.000416 0.002761 0.004301 +11895 1 0.000278 1560.000000 -0.001167 0.001463 0.003126 +11896 1 0.000249 1560.000000 0.000063 0.003424 0.007979 +11897 1 0.000265 1560.000000 -0.001782 0.000723 0.001584 +11898 1 0.000253 1560.000000 -0.003548 -0.001254 0.009394 +11899 1 0.000249 1560.000000 -0.002888 0.000723 0.006657 +11900 1 0.000251 1560.000000 -0.003082 0.001356 0.008544 +11901 1 0.000203 1560.000000 0.000975 -0.002230 0.009550 +11902 1 0.000253 1560.000000 0.000664 0.003496 0.006130 +11903 1 0.000221 1560.000000 -0.000153 0.002745 0.002966 +11904 1 0.000194 1560.000000 -0.001997 0.000939 0.008278 +11905 1 0.000257 1560.000000 0.000354 0.001084 0.004618 +11906 1 0.000265 1560.000000 0.000951 0.002927 0.000764 +11907 1 0.000208 1560.000000 -0.000978 0.003573 0.002304 +11908 1 0.000237 1560.000000 -0.001861 -0.001159 0.002040 +11909 1 0.000198 1560.000000 0.001588 0.002254 0.006197 +11910 1 0.000212 1560.000000 -0.000533 -0.001318 0.005688 +11911 1 0.000230 1560.000000 -0.000591 -0.001152 0.002795 +11912 1 0.000215 1560.000000 -0.001797 0.002437 0.003879 +11913 1 0.000248 1560.000000 0.000188 -0.002628 0.005747 +11914 1 0.000253 1560.000000 -0.002938 -0.002361 0.009053 +11915 1 0.000263 1560.000000 -0.000366 -0.000997 0.006851 +11916 1 0.000270 1560.000000 -0.000574 -0.001360 0.009658 +11917 1 0.000208 1560.000000 -0.001031 -0.000875 0.002081 +11918 1 0.000197 1560.000000 0.000083 0.000255 0.007844 +11919 1 0.000205 1560.000000 -0.000241 0.002672 0.009464 +11920 1 0.000261 1560.000000 0.001066 0.002763 0.003530 +11921 1 0.000253 1560.000000 -0.002647 -0.002096 0.003782 +11922 1 0.000208 1560.000000 -0.000705 0.002733 0.009040 +11923 1 0.000211 1560.000000 0.001308 -0.000844 0.007680 +11924 1 0.000198 1560.000000 0.000597 0.002219 0.004022 +11925 1 0.000270 1560.000000 0.001240 0.002000 0.009781 +11926 1 0.000203 1560.000000 -0.000568 -0.001637 0.000895 +11927 1 0.000275 1560.000000 0.001111 -0.003165 0.004148 +11928 1 0.000210 1560.000000 0.001775 -0.002738 0.002153 +11929 1 0.000200 1560.000000 -0.002355 -0.001560 0.008653 +11930 1 0.000218 1560.000000 -0.000347 0.003366 0.005363 +11931 1 0.000249 1560.000000 0.003104 0.000783 0.001383 +11932 1 0.000271 1560.000000 -0.003112 0.002234 0.007831 +11933 1 0.000209 1560.000000 -0.001436 0.000762 0.009507 +11934 1 0.000242 1560.000000 0.000694 0.001479 0.003111 +11935 1 0.000265 1560.000000 -0.003150 -0.001419 0.001027 +11936 1 0.000268 1560.000000 0.003244 0.001735 0.000205 +11937 1 0.000222 1560.000000 0.000816 -0.003563 0.004863 +11938 1 0.000198 1560.000000 -0.001384 -0.000140 0.002403 +11939 1 0.000262 1560.000000 -0.002034 0.003120 0.000866 +11940 1 0.000256 1560.000000 -0.003345 0.000533 0.006340 +11941 1 0.000245 1560.000000 0.003280 -0.000435 0.002711 +11942 1 0.000235 1560.000000 -0.002108 -0.002311 0.000442 +11943 1 0.000196 1560.000000 -0.000942 -0.002849 0.006247 +11944 1 0.000197 1560.000000 0.002118 0.001008 0.008732 +11945 1 0.000282 1560.000000 -0.003617 -0.001088 0.007093 +11946 1 0.000210 1560.000000 -0.000177 -0.003015 0.001883 +11947 1 0.000246 1560.000000 0.000529 -0.003033 0.008005 +11948 1 0.000264 1560.000000 -0.001510 0.000833 0.003569 +11949 1 0.000285 1560.000000 0.000830 -0.000485 0.007835 +11950 1 0.000217 1560.000000 -0.000581 0.002714 0.003945 +11951 1 0.000243 1560.000000 0.003829 0.000222 0.009122 +11952 1 0.000244 1560.000000 0.001868 -0.003367 0.007283 +11953 1 0.000203 1560.000000 -0.001233 -0.003578 0.001106 +11954 1 0.000210 1560.000000 -0.000401 0.000075 0.000110 +11955 1 0.000218 1560.000000 0.001620 -0.001312 0.005644 +11956 1 0.000241 1560.000000 -0.000198 0.001459 0.007672 +11957 1 0.000235 1560.000000 0.001470 -0.000745 0.005174 +11958 1 0.000231 1560.000000 -0.002226 0.001664 0.006965 +11959 1 0.000204 1560.000000 -0.002775 -0.001689 0.006157 +11960 1 0.000277 1560.000000 -0.001500 0.000050 0.008404 +11961 1 0.000203 1560.000000 -0.002856 0.001860 0.002771 +11962 1 0.000198 1560.000000 0.002097 -0.000537 0.000600 +11963 1 0.000198 1560.000000 -0.001804 0.000163 0.005806 +11964 1 0.000236 1560.000000 -0.001968 -0.003082 0.002026 +11965 1 0.000237 1560.000000 -0.000208 0.002703 0.009200 +11966 1 0.000193 1560.000000 0.002077 0.001918 0.005164 +11967 1 0.000272 1560.000000 0.003355 -0.000570 0.001282 +11968 1 0.000263 1560.000000 -0.002238 -0.002038 0.006075 +11969 1 0.000199 1560.000000 0.003005 -0.000382 0.006549 +11970 1 0.000205 1560.000000 -0.000904 -0.001525 0.004090 +11971 1 0.000236 1560.000000 -0.001537 -0.002690 0.007526 +11972 1 0.000215 1560.000000 0.001876 -0.000429 0.001483 +11973 1 0.000238 1560.000000 0.000739 0.001677 0.005741 +11974 1 0.000212 1560.000000 0.000719 0.000636 0.004108 +11975 1 0.000193 1560.000000 -0.001005 0.000781 0.001298 +11976 1 0.000204 1560.000000 -0.002102 0.002066 0.000771 +11977 1 0.000204 1560.000000 -0.000572 -0.002817 0.008127 +11978 1 0.000244 1560.000000 0.002772 -0.000583 0.001213 +11979 1 0.000287 1560.000000 -0.001497 -0.002265 0.003667 +11980 1 0.000221 1560.000000 0.003245 -0.000088 0.005469 +11981 1 0.000208 1560.000000 0.001868 -0.002430 0.009070 +11982 1 0.000195 1560.000000 0.001337 0.000757 0.005810 +11983 1 0.000202 1560.000000 0.000363 0.003578 0.000627 +11984 1 0.000208 1560.000000 0.002893 -0.000718 0.000869 +11985 1 0.000271 1560.000000 -0.000338 0.002561 0.008938 +11986 1 0.000245 1560.000000 -0.000300 -0.002986 0.003796 +11987 1 0.000231 1560.000000 0.003393 0.000920 0.003373 +11988 1 0.000204 1560.000000 0.003266 0.001686 0.005864 +11989 1 0.000267 1560.000000 -0.000742 0.002238 0.005314 +11990 1 0.000209 1560.000000 -0.000191 0.003247 0.008578 +11991 1 0.000215 1560.000000 -0.000685 -0.000815 0.004436 +11992 1 0.000266 1560.000000 0.003232 0.000401 0.006625 +11993 1 0.000257 1560.000000 -0.002442 0.001006 0.005797 +11994 1 0.000213 1560.000000 -0.002506 0.000535 0.009270 +11995 1 0.000241 1560.000000 0.001940 0.002227 0.007412 +11996 1 0.000194 1560.000000 -0.001466 0.000751 0.006539 +11997 1 0.000230 1560.000000 -0.002902 0.000781 0.006925 +11998 1 0.000196 1560.000000 -0.000437 0.002315 0.007749 +11999 1 0.000213 1560.000000 0.000794 -0.003082 0.002362 +12000 1 0.000242 1560.000000 0.001368 0.000990 0.000139 +12001 1 0.000248 1560.000000 0.003474 -0.000255 0.005623 +12002 1 0.000238 1560.000000 -0.001766 -0.002915 0.002897 +12003 1 0.000205 1560.000000 0.001599 0.001100 0.000994 +12004 1 0.000198 1560.000000 -0.000546 0.000157 0.004916 +12005 1 0.000253 1560.000000 0.002559 0.002423 0.006349 +12006 1 0.000229 1560.000000 -0.000208 -0.003808 0.004636 +12007 1 0.000265 1560.000000 -0.000867 0.002151 0.000603 +12008 1 0.000213 1560.000000 -0.002239 -0.002362 0.008129 +12009 1 0.000210 1560.000000 -0.001524 0.002145 0.009109 +12010 1 0.000260 1560.000000 -0.000985 -0.002052 0.004906 +12011 1 0.000196 1560.000000 -0.001437 0.000325 0.007386 +12012 1 0.000217 1560.000000 0.002413 -0.001882 0.001113 +12013 1 0.000276 1560.000000 -0.000301 0.003804 0.003452 +12014 1 0.000213 1560.000000 -0.001531 0.001549 0.005108 +12015 1 0.000256 1560.000000 0.001129 0.002745 0.009352 +12016 1 0.000209 1560.000000 -0.002696 0.000137 0.002306 +12017 1 0.000221 1560.000000 -0.000841 -0.000605 0.001178 +12018 1 0.000235 1560.000000 -0.000148 0.003765 0.004324 +12019 1 0.000274 1560.000000 0.003177 -0.001701 0.006483 +12020 1 0.000202 1560.000000 0.000911 -0.000517 0.009075 +12021 1 0.000223 1560.000000 -0.000256 0.002453 0.008501 +12022 1 0.000220 1560.000000 -0.001264 -0.000576 0.006137 +12023 1 0.000279 1560.000000 -0.000604 0.001545 0.005344 +12024 1 0.000210 1560.000000 -0.002163 -0.001146 0.003588 +12025 1 0.000245 1560.000000 0.001840 -0.000741 0.003488 +12026 1 0.000209 1560.000000 0.000222 -0.003448 0.003019 +12027 1 0.000241 1560.000000 -0.000729 0.002957 0.001059 +12028 1 0.000193 1560.000000 -0.001715 0.003049 0.007066 +12029 1 0.000241 1560.000000 0.001121 0.002009 0.000898 +12030 1 0.000256 1560.000000 0.001751 0.000093 0.003587 +12031 1 0.000254 1560.000000 -0.002553 -0.002711 0.001603 +12032 1 0.000240 1560.000000 -0.001247 0.003606 0.000548 +12033 1 0.000229 1560.000000 -0.000711 0.003587 0.009365 +12034 1 0.000261 1560.000000 0.002552 0.002730 0.004570 +12035 1 0.000226 1560.000000 -0.002221 -0.000241 0.003186 +12036 1 0.000219 1560.000000 0.002306 -0.000846 0.000192 +12037 1 0.000251 1560.000000 0.002551 -0.001725 0.005234 +12038 1 0.000275 1560.000000 0.003068 0.001030 0.000881 +12039 1 0.000197 1560.000000 0.002313 0.000538 0.001561 +12040 1 0.000226 1560.000000 -0.000949 -0.000024 0.002805 +12041 1 0.000254 1560.000000 0.001843 -0.002788 0.005636 +12042 1 0.000223 1560.000000 0.003233 -0.000649 0.006810 +12043 1 0.000270 1560.000000 0.003179 -0.001837 0.003486 +12044 1 0.000203 1560.000000 0.001228 -0.000870 0.005386 +12045 1 0.000204 1560.000000 0.001821 0.003292 0.002680 +12046 1 0.000198 1560.000000 -0.000216 0.001749 0.007537 +12047 1 0.000198 1560.000000 0.003627 -0.001047 0.002908 +12048 1 0.000243 1560.000000 -0.001158 0.002790 0.003365 +12049 1 0.000226 1560.000000 -0.002901 -0.002305 0.004471 +12050 1 0.000224 1560.000000 0.001641 0.002635 0.000667 +12051 1 0.000256 1560.000000 -0.000365 -0.001754 0.001816 +12052 1 0.000198 1560.000000 -0.000501 -0.000143 0.005882 +12053 1 0.000212 1560.000000 -0.002904 0.001875 0.001718 +12054 1 0.000227 1560.000000 -0.000184 0.002368 0.001779 +12055 1 0.000205 1560.000000 -0.001247 -0.001790 0.004595 +12056 1 0.000244 1560.000000 -0.000142 -0.002375 0.009038 +12057 1 0.000253 1560.000000 0.001843 -0.002227 0.002797 +12058 1 0.000275 1560.000000 0.000665 0.002295 0.006104 +12059 1 0.000247 1560.000000 0.000020 -0.001335 0.008868 +12060 1 0.000284 1560.000000 -0.000658 0.001796 0.008932 +12061 1 0.000270 1560.000000 0.001412 -0.003284 0.007997 +12062 1 0.000209 1560.000000 0.001108 -0.002412 0.009777 +12063 1 0.000236 1560.000000 0.002577 -0.002622 0.005677 +12064 1 0.000196 1560.000000 -0.001269 -0.000409 0.003065 +12065 1 0.000198 1560.000000 0.003017 0.000038 0.005302 +12066 1 0.000217 1560.000000 -0.003320 0.001116 0.009718 +12067 1 0.000245 1560.000000 -0.001296 0.002320 0.003469 +12068 1 0.000234 1560.000000 0.000284 -0.002181 0.000129 +12069 1 0.000223 1560.000000 0.000643 0.002318 0.000628 +12070 1 0.000195 1560.000000 -0.001163 -0.001671 0.004904 +12071 1 0.000283 1560.000000 0.002583 0.002275 0.004701 +12072 1 0.000252 1560.000000 0.002713 -0.000719 0.007437 +12073 1 0.000194 1560.000000 -0.000202 0.001046 0.001588 +12074 1 0.000208 1560.000000 0.002884 0.001091 0.004886 +12075 1 0.000197 1560.000000 -0.001037 -0.000615 0.007124 +12076 1 0.000215 1560.000000 0.002845 0.002032 0.009599 +12077 1 0.000227 1560.000000 0.000044 -0.002862 0.008890 +12078 1 0.000247 1560.000000 -0.002297 -0.002856 0.007659 +12079 1 0.000237 1560.000000 0.003671 -0.000671 0.001663 +12080 1 0.000213 1560.000000 -0.001888 0.003083 0.005006 +12081 1 0.000196 1560.000000 -0.000459 -0.001749 0.002694 +12082 1 0.000201 1560.000000 -0.000842 0.003671 0.005299 +12083 1 0.000255 1560.000000 0.002225 -0.002955 0.003256 +12084 1 0.000264 1560.000000 -0.001864 0.002529 0.001777 +12085 1 0.000248 1560.000000 -0.000714 0.003153 0.003815 +12086 1 0.000264 1560.000000 -0.001049 -0.001248 0.009108 +12087 1 0.000240 1560.000000 -0.002087 -0.002291 0.005913 +12088 1 0.000252 1560.000000 0.002667 0.000586 0.005905 +12089 1 0.000219 1560.000000 0.001142 -0.002583 0.000705 +12090 1 0.000260 1560.000000 -0.003728 0.000652 0.001288 +12091 1 0.000237 1560.000000 0.000750 0.002471 0.009122 +12092 1 0.000236 1560.000000 0.002833 -0.000361 0.003423 +12093 1 0.000243 1560.000000 -0.002138 -0.001638 0.008905 +12094 1 0.000244 1560.000000 0.000828 -0.001966 0.001023 +12095 1 0.000244 1560.000000 0.000101 -0.001089 0.004889 +12096 1 0.000194 1560.000000 -0.002070 0.002802 0.008197 +12097 1 0.000267 1560.000000 0.002660 -0.000640 0.009277 +12098 1 0.000281 1560.000000 -0.003625 0.000924 0.004379 +12099 1 0.000209 1560.000000 0.001399 0.000932 0.007802 +12100 1 0.000205 1560.000000 -0.001371 -0.001465 0.003839 +12101 1 0.000262 1560.000000 0.002603 0.002751 0.006858 +12102 1 0.000251 1560.000000 -0.001845 -0.003095 0.004162 +12103 1 0.000237 1560.000000 -0.000331 -0.000627 0.005112 +12104 1 0.000201 1560.000000 -0.002374 0.001429 0.002380 +12105 1 0.000209 1560.000000 -0.001506 0.002858 0.005868 +12106 1 0.000194 1560.000000 0.000985 0.000728 0.008469 +12107 1 0.000243 1560.000000 -0.000392 -0.001495 0.002514 +12108 1 0.000224 1560.000000 0.002263 0.000801 0.001944 +12109 1 0.000273 1560.000000 -0.002059 0.001885 0.001781 +12110 1 0.000249 1560.000000 0.000727 -0.000218 0.009514 +12111 1 0.000196 1560.000000 -0.003202 -0.001253 0.009228 +12112 1 0.000201 1560.000000 -0.000534 0.000031 0.003131 +12113 1 0.000226 1560.000000 -0.001418 -0.003554 0.003399 +12114 1 0.000205 1560.000000 -0.000845 -0.000038 0.007256 +12115 1 0.000284 1560.000000 0.000457 0.002411 0.000150 +12116 1 0.000284 1560.000000 0.000710 0.001929 0.002883 +12117 1 0.000209 1560.000000 0.002514 -0.000265 0.005707 +12118 1 0.000242 1560.000000 -0.001854 0.002834 0.006206 +12119 1 0.000229 1560.000000 -0.002481 -0.000453 0.006533 +12120 1 0.000243 1560.000000 -0.001717 -0.001694 0.002319 +12121 1 0.000282 1560.000000 -0.001436 0.003318 0.006431 +12122 1 0.000211 1560.000000 0.000253 0.003759 0.009533 +12123 1 0.000286 1560.000000 -0.000949 0.002387 0.002509 +12124 1 0.000202 1560.000000 -0.000765 0.001636 0.009779 +12125 1 0.000218 1560.000000 -0.002548 -0.002597 0.009531 +12126 1 0.000201 1560.000000 -0.001429 -0.000048 0.007642 +12127 1 0.000227 1560.000000 -0.003023 -0.001140 0.001003 +12128 1 0.000288 1560.000000 -0.003801 -0.000169 0.008506 +12129 1 0.000239 1560.000000 -0.001393 -0.001029 0.001634 +12130 1 0.000256 1560.000000 -0.003164 -0.001903 0.004933 +12131 1 0.000258 1560.000000 -0.001945 -0.002597 0.002890 +12132 1 0.000234 1560.000000 0.001994 0.002109 0.005868 +12133 1 0.000242 1560.000000 0.000927 -0.000528 0.006851 +12134 1 0.000234 1560.000000 0.000675 0.002227 0.005197 +12135 1 0.000243 1560.000000 0.000754 -0.002731 0.002244 +12136 1 0.000229 1560.000000 -0.001426 -0.001331 0.001695 +12137 1 0.000200 1560.000000 0.002207 -0.002436 0.003444 +12138 1 0.000238 1560.000000 0.000787 0.003433 0.008748 +12139 1 0.000272 1560.000000 -0.002873 -0.000942 0.005174 +12140 1 0.000216 1560.000000 0.002970 0.000658 0.006255 +12141 1 0.000213 1560.000000 -0.000762 -0.002065 0.004347 +12142 1 0.000279 1560.000000 0.001843 -0.001027 0.000257 +12143 1 0.000202 1560.000000 -0.002178 0.000988 0.002002 +12144 1 0.000271 1560.000000 -0.000208 0.003178 0.002234 +12145 1 0.000266 1560.000000 0.002666 -0.001254 0.008649 +12146 1 0.000214 1560.000000 -0.002140 -0.002234 0.003424 +12147 1 0.000207 1560.000000 -0.003044 0.000030 0.003614 +12148 1 0.000226 1560.000000 0.001788 -0.003386 0.009803 +12149 1 0.000249 1560.000000 0.001214 -0.001391 0.008018 +12150 1 0.000198 1560.000000 -0.001200 -0.003425 0.000647 +12151 1 0.000204 1560.000000 -0.000734 0.002486 0.000149 +12152 1 0.000234 1560.000000 0.002007 -0.000756 0.008211 +12153 1 0.000198 1560.000000 0.000811 0.002272 0.007314 +12154 1 0.000201 1560.000000 0.003025 -0.000216 0.001300 +12155 1 0.000207 1560.000000 -0.001486 0.002917 0.006843 +12156 1 0.000192 1560.000000 0.000176 0.003784 0.006629 +12157 1 0.000283 1560.000000 0.003435 0.001110 0.007565 +12158 1 0.000217 1560.000000 -0.002056 -0.002895 0.002616 +12159 1 0.000240 1560.000000 -0.000580 0.000198 0.006694 +12160 1 0.000257 1560.000000 -0.001467 0.002361 0.004068 +12161 1 0.000196 1560.000000 0.000355 -0.001978 0.005728 +12162 1 0.000241 1560.000000 -0.000640 -0.002566 0.009817 +12163 1 0.000276 1560.000000 -0.000118 0.003062 0.006982 +12164 1 0.000260 1560.000000 -0.002489 0.000564 0.002990 +12165 1 0.000204 1560.000000 0.002922 0.001579 0.000401 +12166 1 0.000209 1560.000000 0.000254 0.003737 0.004328 +12167 1 0.000223 1560.000000 -0.000394 -0.002927 0.008269 +12168 1 0.000265 1560.000000 -0.002454 -0.001889 0.005986 +12169 1 0.000259 1560.000000 0.001149 -0.001136 0.009819 +12170 1 0.000252 1560.000000 -0.003063 -0.001422 0.000312 +12171 1 0.000252 1560.000000 -0.000217 -0.001672 0.008412 +12172 1 0.000227 1560.000000 0.001363 -0.000720 0.000354 +12173 1 0.000232 1560.000000 -0.000538 0.002811 0.009725 +12174 1 0.000231 1560.000000 -0.000948 0.003666 0.008552 +12175 1 0.000211 1560.000000 0.002364 0.002482 0.003640 +12176 1 0.000199 1560.000000 -0.000109 -0.002667 0.002469 +12177 1 0.000219 1560.000000 0.000219 -0.000870 0.007937 +12178 1 0.000208 1560.000000 -0.000237 -0.000431 0.008030 +12179 1 0.000228 1560.000000 -0.000432 -0.000542 0.004687 +12180 1 0.000228 1560.000000 0.003014 0.002342 0.002491 +12181 1 0.000238 1560.000000 0.003129 0.000103 0.000783 +12182 1 0.000206 1560.000000 -0.001285 -0.002367 0.009043 +12183 1 0.000204 1560.000000 0.002937 0.001943 0.005494 +12184 1 0.000201 1560.000000 -0.003215 0.000197 0.003737 +12185 1 0.000259 1560.000000 0.000360 -0.002694 0.004605 +12186 1 0.000251 1560.000000 -0.002063 -0.000814 0.005302 +12187 1 0.000278 1560.000000 -0.000576 -0.002998 0.006009 +12188 1 0.000234 1560.000000 -0.001384 0.001161 0.004838 +12189 1 0.000224 1560.000000 -0.000096 -0.001461 0.006410 +12190 1 0.000195 1560.000000 0.002465 0.000667 0.001521 +12191 1 0.000223 1560.000000 0.001964 -0.000109 0.004755 +12192 1 0.000253 1560.000000 0.001429 -0.000570 0.000868 +12193 1 0.000210 1560.000000 -0.000937 -0.000720 0.005970 +12194 1 0.000208 1560.000000 0.001285 -0.003119 0.003670 +12195 1 0.000287 1560.000000 -0.001648 -0.002193 0.005280 +12196 1 0.000231 1560.000000 0.000309 -0.003143 0.005483 +12197 1 0.000274 1560.000000 -0.000692 -0.002397 0.003100 +12198 1 0.000273 1560.000000 -0.001413 -0.000241 0.009776 +12199 1 0.000221 1560.000000 -0.000326 0.003839 0.000590 +12200 1 0.000266 1560.000000 0.002900 -0.000630 0.002990 +12201 1 0.000227 1560.000000 -0.002792 0.002274 0.002791 +12202 1 0.000281 1560.000000 -0.001941 -0.000425 0.001753 +12203 1 0.000235 1560.000000 0.003540 -0.001294 0.002233 +12204 1 0.000215 1560.000000 -0.003215 0.000357 0.005153 +12205 1 0.000198 1560.000000 -0.002119 0.000005 0.002315 +12206 1 0.000229 1560.000000 -0.002647 0.001069 0.003947 +12207 1 0.000200 1560.000000 -0.003467 -0.000096 0.002932 +12208 1 0.000221 1560.000000 0.002287 0.000322 0.001365 +12209 1 0.000217 1560.000000 -0.002590 -0.000893 0.000728 +12210 1 0.000199 1560.000000 -0.000969 -0.002187 0.007362 +12211 1 0.000226 1560.000000 -0.002273 -0.000454 0.003891 +12212 1 0.000233 1560.000000 0.001833 -0.003105 0.009263 +12213 1 0.000228 1560.000000 -0.001204 0.001221 0.005022 +12214 1 0.000232 1560.000000 0.002508 0.001374 0.007381 +12215 1 0.000229 1560.000000 -0.002022 -0.002687 0.006463 +12216 1 0.000195 1560.000000 0.002225 -0.000040 0.000401 +12217 1 0.000199 1560.000000 -0.001655 -0.002048 0.000954 +12218 1 0.000273 1560.000000 -0.001844 -0.000706 0.008483 +12219 1 0.000194 1560.000000 0.003071 0.001609 0.007118 +12220 1 0.000251 1560.000000 0.000283 -0.003535 0.003456 +12221 1 0.000281 1560.000000 0.002011 -0.003109 0.001242 +12222 1 0.000211 1560.000000 0.002987 -0.001841 0.007672 +12223 1 0.000217 1560.000000 0.003649 0.000214 0.003807 +12224 1 0.000257 1560.000000 -0.002266 -0.002538 0.001418 +12225 1 0.000288 1560.000000 0.001438 -0.002705 0.007635 +12226 1 0.000221 1560.000000 0.002180 -0.000660 0.007540 +12227 1 0.000227 1560.000000 -0.002490 -0.002675 0.002561 +12228 1 0.000239 1560.000000 -0.001991 0.001348 0.005722 +12229 1 0.000208 1560.000000 -0.002469 -0.001416 0.008483 +12230 1 0.000270 1560.000000 -0.001366 -0.001889 0.004117 +12231 1 0.000227 1560.000000 0.000630 0.001214 0.007468 +12232 1 0.000254 1560.000000 -0.001489 -0.000640 0.000558 +12233 1 0.000208 1560.000000 -0.000860 0.001961 0.001250 +12234 1 0.000206 1560.000000 -0.003656 -0.000054 0.009104 +12235 1 0.000199 1560.000000 0.002867 -0.002019 0.009399 +12236 1 0.000211 1560.000000 -0.000161 0.000759 0.006890 +12237 1 0.000205 1560.000000 0.003469 -0.000861 0.009724 +12238 1 0.000238 1560.000000 0.002796 -0.002100 0.007120 +12239 1 0.000192 1560.000000 0.000499 -0.003514 0.001658 +12240 1 0.000229 1560.000000 0.002087 -0.001936 0.004519 +12241 1 0.000233 1560.000000 -0.000984 -0.003567 0.006875 +12242 1 0.000218 1560.000000 -0.002334 -0.001076 0.005071 +12243 1 0.000237 1560.000000 0.002431 0.000825 0.009444 +12244 1 0.000209 1560.000000 -0.000880 0.000352 0.000526 +12245 1 0.000285 1560.000000 -0.000348 -0.002691 0.008173 +12246 1 0.000193 1560.000000 0.002488 -0.001445 0.002282 +12247 1 0.000224 1560.000000 -0.002006 -0.001832 0.009128 +12248 1 0.000208 1560.000000 -0.000373 -0.003713 0.008301 +12249 1 0.000220 1560.000000 -0.002315 0.000699 0.003090 +12250 1 0.000197 1560.000000 -0.003159 -0.001395 0.007885 +12251 1 0.000244 1560.000000 -0.001112 0.000337 0.007292 +12252 1 0.000198 1560.000000 0.000203 -0.003493 0.000205 +12253 1 0.000281 1560.000000 0.000744 -0.003011 0.005701 +12254 1 0.000263 1560.000000 -0.003228 -0.001227 0.006829 +12255 1 0.000277 1560.000000 0.002084 0.000523 0.006768 +12256 1 0.000255 1560.000000 -0.003625 -0.001271 0.001572 +12257 1 0.000246 1560.000000 -0.003837 -0.000185 0.009367 +12258 1 0.000269 1560.000000 0.002518 0.002654 0.003528 +12259 1 0.000223 1560.000000 -0.002515 -0.002892 0.005764 +12260 1 0.000223 1560.000000 -0.001999 -0.001286 0.008520 +12261 1 0.000204 1560.000000 0.003840 0.000035 0.001139 +12262 1 0.000210 1560.000000 0.002864 -0.001685 0.002670 +12263 1 0.000193 1560.000000 -0.000989 0.000741 0.000746 +12264 1 0.000196 1560.000000 -0.000556 0.003532 0.003042 +12265 1 0.000263 1560.000000 -0.002133 -0.002152 0.007636 +12266 1 0.000202 1560.000000 -0.000130 -0.002065 0.006249 +12267 1 0.000263 1560.000000 0.001161 0.002444 0.003536 +12268 1 0.000213 1560.000000 0.001594 -0.003434 0.007410 +12269 1 0.000232 1560.000000 0.003042 0.000215 0.002004 +12270 1 0.000213 1560.000000 -0.002030 0.000699 0.004829 +12271 1 0.000201 1560.000000 -0.003644 -0.000509 0.007795 +12272 1 0.000222 1560.000000 0.003826 -0.000421 0.001118 +12273 1 0.000233 1560.000000 0.002251 0.002266 0.001956 +12274 1 0.000237 1560.000000 0.001473 0.001066 0.004191 +12275 1 0.000245 1560.000000 -0.002404 0.002381 0.004702 +12276 1 0.000268 1560.000000 0.000337 0.003519 0.008007 +12277 1 0.000193 1560.000000 -0.001200 0.002936 0.001421 +12278 1 0.000213 1560.000000 -0.003426 0.001632 0.001197 +12279 1 0.000288 1560.000000 -0.000513 0.003047 0.000273 +12280 1 0.000198 1560.000000 0.002049 -0.003215 0.004835 +12281 1 0.000243 1560.000000 -0.000450 -0.002236 0.004909 +12282 1 0.000229 1560.000000 -0.001367 -0.000873 0.006684 +12283 1 0.000244 1560.000000 -0.003048 0.001974 0.007081 +12284 1 0.000211 1560.000000 0.002778 -0.002389 0.007255 +12285 1 0.000198 1560.000000 -0.001834 -0.003331 0.009012 +12286 1 0.000252 1560.000000 -0.002869 -0.000584 0.009318 +12287 1 0.000237 1560.000000 -0.003061 -0.000786 0.006697 +12288 1 0.000202 1560.000000 0.000509 -0.001589 0.005116 +12289 1 0.000242 1560.000000 0.002772 0.000556 0.007321 +12290 1 0.000255 1560.000000 -0.000021 -0.003172 0.001769 +12291 1 0.000245 1560.000000 0.003252 -0.000959 0.004197 +12292 1 0.000245 1560.000000 -0.003372 0.000452 0.004076 +12293 1 0.000237 1560.000000 0.000877 0.003368 0.006190 +12294 1 0.000196 1560.000000 0.000222 -0.002122 0.003998 +12295 1 0.000195 1560.000000 -0.001747 -0.001726 0.002925 +12296 1 0.000210 1560.000000 0.000889 0.000375 0.002018 +12297 1 0.000230 1560.000000 0.002310 -0.002799 0.007121 +12298 1 0.000196 1560.000000 0.001325 0.001607 0.001088 +12299 1 0.000199 1560.000000 -0.001087 -0.000768 0.009491 +12300 1 0.000221 1560.000000 0.002884 0.001144 0.003452 +12301 1 0.000264 1560.000000 -0.003070 -0.000170 0.008996 +12302 1 0.000285 1560.000000 -0.001439 0.001187 0.005806 +12303 1 0.000202 1560.000000 0.002827 -0.001460 0.006237 +12304 1 0.000198 1560.000000 0.003185 0.000620 0.006475 +12305 1 0.000232 1560.000000 0.001651 -0.003033 0.003273 +12306 1 0.000224 1560.000000 -0.001889 -0.003359 0.004206 +12307 1 0.000208 1560.000000 0.001733 0.001009 0.009008 +12308 1 0.000238 1560.000000 -0.001042 0.002058 0.005359 +12309 1 0.000243 1560.000000 0.000966 0.001266 0.005843 +12310 1 0.000202 1560.000000 -0.000961 0.000075 0.006130 +12311 1 0.000226 1560.000000 -0.003375 -0.000242 0.005727 +12312 1 0.000202 1560.000000 -0.000410 0.001417 0.006772 +12313 1 0.000221 1560.000000 0.000027 -0.003747 0.006720 +12314 1 0.000241 1560.000000 -0.001414 0.000905 0.002861 +12315 1 0.000225 1560.000000 0.002237 0.003128 0.002298 +12316 1 0.000202 1560.000000 0.000806 0.000747 0.003094 +12317 1 0.000210 1560.000000 -0.000108 -0.002004 0.008726 +12318 1 0.000280 1560.000000 0.002995 -0.002000 0.009196 +12319 1 0.000259 1560.000000 -0.003314 -0.001007 0.003088 +12320 1 0.000215 1560.000000 -0.000869 -0.001875 0.002208 +12321 1 0.000287 1560.000000 -0.001598 -0.000578 0.003793 +12322 1 0.000241 1560.000000 -0.003668 0.001163 0.001584 +12323 1 0.000270 1560.000000 -0.002031 0.002817 0.001555 +12324 1 0.000248 1560.000000 -0.000146 0.001142 0.007914 +12325 1 0.000196 1560.000000 -0.001789 -0.002466 0.004269 +12326 1 0.000242 1560.000000 0.002476 0.001407 0.004180 +12327 1 0.000267 1560.000000 -0.001054 0.002865 0.006069 +12328 1 0.000217 1560.000000 0.001006 0.003226 0.003525 +12329 1 0.000199 1560.000000 -0.003510 -0.000001 0.001461 +12330 1 0.000209 1560.000000 -0.002518 0.002844 0.006185 +12331 1 0.000228 1560.000000 -0.001455 0.001202 0.007455 +12332 1 0.000211 1560.000000 0.002198 -0.002134 0.003678 +12333 1 0.000206 1560.000000 -0.003189 0.000662 0.009413 +12334 1 0.000195 1560.000000 0.001002 0.001394 0.007803 +12335 1 0.000231 1560.000000 0.000126 -0.000506 0.008110 +12336 1 0.000203 1560.000000 0.003308 0.001913 0.000931 +12337 1 0.000258 1560.000000 0.000428 0.003282 0.003717 +12338 1 0.000206 1560.000000 0.000058 -0.003393 0.005179 +12339 1 0.000204 1560.000000 0.000683 0.003741 0.009320 +12340 1 0.000257 1560.000000 0.001945 0.000638 0.005503 +12341 1 0.000226 1560.000000 0.001420 0.003474 0.003435 +12342 1 0.000266 1560.000000 0.002054 0.002711 0.009535 +12343 1 0.000229 1560.000000 -0.002179 0.000489 0.001604 +12344 1 0.000241 1560.000000 0.000322 -0.003486 0.008137 +12345 1 0.000219 1560.000000 0.001944 0.002130 0.004613 +12346 1 0.000221 1560.000000 -0.003555 -0.000572 0.008395 +12347 1 0.000230 1560.000000 0.000685 -0.002618 0.006660 +12348 1 0.000224 1560.000000 0.003185 -0.000084 0.005916 +12349 1 0.000208 1560.000000 -0.000687 0.003732 0.003149 +12350 1 0.000237 1560.000000 -0.002691 0.001562 0.004124 +12351 1 0.000269 1560.000000 0.003324 -0.001517 0.003769 +12352 1 0.000257 1560.000000 -0.003210 0.001305 0.006655 +12353 1 0.000280 1560.000000 0.002187 0.002593 0.001907 +12354 1 0.000205 1560.000000 0.002585 0.000829 0.001717 +12355 1 0.000288 1560.000000 0.002893 0.001428 0.003559 +12356 1 0.000283 1560.000000 0.002239 -0.002259 0.007715 +12357 1 0.000192 1560.000000 -0.000947 -0.000990 0.003900 +12358 1 0.000218 1560.000000 -0.000760 -0.000700 0.008374 +12359 1 0.000193 1560.000000 0.002640 0.000867 0.001922 +12360 1 0.000205 1560.000000 0.000303 -0.003778 0.004927 +12361 1 0.000266 1560.000000 -0.000413 0.002053 0.000986 +12362 1 0.000240 1560.000000 -0.003696 0.000588 0.006988 +12363 1 0.000210 1560.000000 -0.001458 -0.002426 0.003938 +12364 1 0.000211 1560.000000 -0.003698 -0.000131 0.001567 +12365 1 0.000202 1560.000000 0.000998 -0.001341 0.009451 +12366 1 0.000268 1560.000000 0.001274 0.003075 0.007520 +12367 1 0.000193 1560.000000 0.003099 -0.002187 0.004904 +12368 1 0.000231 1560.000000 0.001127 0.003634 0.007953 +12369 1 0.000200 1560.000000 0.000162 -0.000128 0.006652 +12370 1 0.000243 1560.000000 -0.000498 -0.001066 0.007305 +12371 1 0.000235 1560.000000 0.002971 -0.000433 0.001784 +12372 1 0.000195 1560.000000 0.002558 -0.002672 0.009358 +12373 1 0.000210 1560.000000 -0.000210 -0.001038 0.004864 +12374 1 0.000234 1560.000000 0.002265 -0.000549 0.008542 +12375 1 0.000243 1560.000000 -0.000974 0.002799 0.000957 +12376 1 0.000242 1560.000000 -0.002755 0.001878 0.004981 +12377 1 0.000197 1560.000000 0.003558 0.001270 0.000671 +12378 1 0.000233 1560.000000 0.003557 0.001331 0.004664 +12379 1 0.000197 1560.000000 -0.001097 -0.002597 0.008776 +12380 1 0.000234 1560.000000 -0.000156 -0.002805 0.005540 +12381 1 0.000249 1560.000000 -0.001542 0.003479 0.001504 +12382 1 0.000201 1560.000000 -0.003230 0.000780 0.007505 +12383 1 0.000196 1560.000000 0.000704 0.001182 0.005737 +12384 1 0.000283 1560.000000 0.001183 -0.003453 0.000155 +12385 1 0.000207 1560.000000 0.000257 -0.001245 0.005458 +12386 1 0.000217 1560.000000 0.001125 0.000232 0.008965 +12387 1 0.000227 1560.000000 -0.001177 0.001689 0.009813 +12388 1 0.000212 1560.000000 -0.001320 -0.000528 0.003803 +12389 1 0.000217 1560.000000 -0.001799 0.002929 0.004297 +12390 1 0.000193 1560.000000 -0.000460 0.002301 0.003640 +12391 1 0.000214 1560.000000 0.000052 0.001062 0.003478 +12392 1 0.000279 1560.000000 -0.002423 -0.002241 0.003797 +12393 1 0.000221 1560.000000 -0.003454 0.000700 0.006205 +12394 1 0.000194 1560.000000 -0.001483 0.002480 0.003570 +12395 1 0.000210 1560.000000 0.002511 0.002715 0.009150 +12396 1 0.000278 1560.000000 0.000093 -0.000483 0.009803 +12397 1 0.000202 1560.000000 -0.001720 0.002947 0.007759 +12398 1 0.000255 1560.000000 0.000982 0.000202 0.009816 +12399 1 0.000207 1560.000000 0.001987 -0.002515 0.000622 +12400 1 0.000251 1560.000000 0.000271 -0.000731 0.000712 +12401 1 0.000271 1560.000000 -0.003457 0.000136 0.007385 +12402 1 0.000263 1560.000000 0.001225 0.003533 0.001023 +12403 1 0.000245 1560.000000 -0.001498 0.003311 0.001283 +12404 1 0.000212 1560.000000 0.003046 -0.001152 0.005577 +12405 1 0.000259 1560.000000 0.001058 0.001901 0.000620 +12406 1 0.000252 1560.000000 0.001837 -0.002357 0.004634 +12407 1 0.000271 1560.000000 -0.002487 0.002924 0.007876 +12408 1 0.000229 1560.000000 -0.000614 0.002950 0.007028 +12409 1 0.000239 1560.000000 -0.002194 -0.000934 0.004632 +12410 1 0.000192 1560.000000 -0.003510 0.000740 0.000523 +12411 1 0.000226 1560.000000 0.000102 0.001847 0.000183 +12412 1 0.000280 1560.000000 0.003306 -0.001907 0.005965 +12413 1 0.000258 1560.000000 0.000717 -0.002564 0.004504 +12414 1 0.000244 1560.000000 -0.002606 0.001115 0.009361 +12415 1 0.000232 1560.000000 0.002426 0.001244 0.005594 +12416 1 0.000198 1560.000000 -0.001394 -0.003289 0.009208 +12417 1 0.000285 1560.000000 -0.000448 -0.001777 0.002383 +12418 1 0.000216 1560.000000 -0.000042 0.002531 0.003977 +12419 1 0.000233 1560.000000 -0.000752 0.001751 0.002599 +12420 1 0.000252 1560.000000 0.002790 -0.002624 0.006497 +12421 1 0.000280 1560.000000 -0.002800 0.001550 0.005337 +12422 1 0.000273 1560.000000 0.001182 -0.001962 0.002781 +12423 1 0.000211 1560.000000 0.001164 -0.003324 0.003773 +12424 1 0.000272 1560.000000 0.001047 -0.000732 0.006709 +12425 1 0.000199 1560.000000 0.001414 0.002242 0.007618 +12426 1 0.000277 1560.000000 -0.000534 0.000917 0.007450 +12427 1 0.000200 1560.000000 -0.000844 0.002438 0.002123 +12428 1 0.000241 1560.000000 0.002019 0.001686 0.005569 +12429 1 0.000198 1560.000000 0.001804 0.002525 0.001920 +12430 1 0.000194 1560.000000 -0.001031 -0.000845 0.000122 +12431 1 0.000195 1560.000000 -0.000240 0.003347 0.009202 +12432 1 0.000208 1560.000000 0.002200 0.001243 0.007509 +12433 1 0.000206 1560.000000 -0.001383 0.003418 0.008685 +12434 1 0.000224 1560.000000 -0.001426 0.003241 0.000936 +12435 1 0.000262 1560.000000 0.002170 -0.003149 0.000711 +12436 1 0.000274 1560.000000 0.002895 -0.000905 0.006201 +12437 1 0.000245 1560.000000 0.000615 -0.000292 0.004815 +12438 1 0.000210 1560.000000 -0.002324 0.000474 0.005494 +12439 1 0.000244 1560.000000 -0.002948 -0.002126 0.006721 +12440 1 0.000274 1560.000000 -0.001691 0.002540 0.009563 +12441 1 0.000211 1560.000000 0.002999 -0.002041 0.008902 +12442 1 0.000247 1560.000000 -0.001990 0.000636 0.003259 +12443 1 0.000215 1560.000000 0.001930 0.001927 0.001466 +12444 1 0.000236 1560.000000 0.001350 0.001956 0.005684 +12445 1 0.000195 1560.000000 0.002346 0.001522 0.000519 +12446 1 0.000270 1560.000000 -0.001221 0.001357 0.004421 +12447 1 0.000279 1560.000000 0.002287 -0.001328 0.008112 +12448 1 0.000255 1560.000000 -0.000519 0.001930 0.009121 +12449 1 0.000197 1560.000000 0.001407 -0.002721 0.004462 +12450 1 0.000197 1560.000000 0.002053 0.001596 0.001172 +12451 1 0.000204 1560.000000 0.000529 0.001387 0.002581 +12452 1 0.000214 1560.000000 0.002308 0.001311 0.009301 +12453 1 0.000202 1560.000000 0.001719 0.000537 0.008872 +12454 1 0.000206 1560.000000 0.000192 0.003036 0.005079 +12455 1 0.000196 1560.000000 0.003332 -0.000880 0.006868 +12456 1 0.000195 1560.000000 -0.003371 0.000142 0.007994 +12457 1 0.000240 1560.000000 0.002076 0.000180 0.007438 +12458 1 0.000206 1560.000000 0.000791 0.001529 0.001094 +12459 1 0.000217 1560.000000 -0.003044 -0.001026 0.006635 +12460 1 0.000202 1560.000000 0.000412 0.001041 0.008396 +12461 1 0.000197 1560.000000 0.000418 -0.002117 0.004837 +12462 1 0.000205 1560.000000 0.002778 0.001348 0.004845 +12463 1 0.000219 1560.000000 -0.002587 0.001296 0.000475 +12464 1 0.000226 1560.000000 0.003182 0.000565 0.006097 +12465 1 0.000218 1560.000000 0.001460 -0.000858 0.000998 +12466 1 0.000276 1560.000000 -0.000855 -0.002039 0.003825 +12467 1 0.000198 1560.000000 0.000806 -0.000650 0.001353 +12468 1 0.000260 1560.000000 0.000066 -0.002354 0.000781 +12469 1 0.000256 1560.000000 -0.000576 0.001456 0.004843 +12470 1 0.000209 1560.000000 0.001914 0.000157 0.004993 +12471 1 0.000222 1560.000000 0.001768 0.001948 0.004466 +12472 1 0.000249 1560.000000 -0.001845 0.001449 0.008255 +12473 1 0.000195 1560.000000 0.002997 0.001895 0.001244 +12474 1 0.000253 1560.000000 -0.001368 0.002053 0.001294 +12475 1 0.000194 1560.000000 -0.001576 -0.001240 0.004078 +12476 1 0.000210 1560.000000 -0.000603 -0.000864 0.009721 +12477 1 0.000212 1560.000000 0.000940 -0.003430 0.004576 +12478 1 0.000199 1560.000000 -0.001227 -0.001323 0.008707 +12479 1 0.000222 1560.000000 -0.003311 -0.001863 0.000974 +12480 1 0.000279 1560.000000 -0.002004 0.002330 0.009677 +12481 1 0.000235 1560.000000 -0.000504 0.002387 0.005931 +12482 1 0.000274 1560.000000 -0.002796 0.001584 0.000542 +12483 1 0.000283 1560.000000 -0.002812 -0.002509 0.009809 +12484 1 0.000200 1560.000000 -0.003845 -0.000069 0.002940 +12485 1 0.000219 1560.000000 -0.003186 0.001548 0.004843 +12486 1 0.000251 1560.000000 -0.002564 0.002714 0.008664 +12487 1 0.000245 1560.000000 -0.002480 0.002855 0.003301 +12488 1 0.000257 1560.000000 -0.001947 -0.002835 0.004815 +12489 1 0.000263 1560.000000 -0.001976 -0.000528 0.009585 +12490 1 0.000231 1560.000000 -0.003189 -0.000295 0.003919 +12491 1 0.000247 1560.000000 -0.002077 -0.000558 0.000670 +12492 1 0.000270 1560.000000 -0.000768 0.000197 0.002423 +12493 1 0.000196 1560.000000 0.002423 0.001436 0.006241 +12494 1 0.000270 1560.000000 -0.001669 0.003259 0.008126 +12495 1 0.000231 1560.000000 0.003430 0.001642 0.007706 +12496 1 0.000193 1560.000000 0.002660 -0.000755 0.005575 +12497 1 0.000224 1560.000000 -0.000268 -0.000390 0.006440 +12498 1 0.000197 1560.000000 -0.000824 0.003361 0.006235 +12499 1 0.000249 1560.000000 -0.002738 0.000228 0.004068 +12500 1 0.000288 1560.000000 0.001479 -0.002628 0.002035 +12501 1 0.000280 1560.000000 0.003298 0.000703 0.004927 +12502 1 0.000212 1560.000000 -0.001781 0.002740 0.001081 +12503 1 0.000247 1560.000000 0.002020 0.001388 0.001738 +12504 1 0.000256 1560.000000 0.001507 -0.001327 0.002079 +12505 1 0.000284 1560.000000 -0.001692 0.003456 0.008962 +12506 1 0.000245 1560.000000 0.001035 -0.000016 0.003129 +12507 1 0.000208 1560.000000 -0.003586 -0.000767 0.006877 +12508 1 0.000262 1560.000000 0.001116 -0.002392 0.001821 +12509 1 0.000204 1560.000000 -0.003178 -0.000558 0.005021 +12510 1 0.000194 1560.000000 -0.000144 0.003298 0.008059 +12511 1 0.000230 1560.000000 -0.001372 0.000385 0.001169 +12512 1 0.000246 1560.000000 0.003427 -0.001282 0.008996 +12513 1 0.000221 1560.000000 -0.001013 0.000871 0.007981 +12514 1 0.000209 1560.000000 -0.003049 0.000915 0.000998 +12515 1 0.000268 1560.000000 -0.000856 0.000249 0.009838 +12516 1 0.000198 1560.000000 0.002020 0.000667 0.005873 +12517 1 0.000195 1560.000000 0.000289 0.003570 0.000179 +12518 1 0.000246 1560.000000 0.000037 -0.002002 0.004842 +12519 1 0.000236 1560.000000 0.002350 0.002245 0.005843 +12520 1 0.000270 1560.000000 -0.000094 0.002927 0.001472 +12521 1 0.000243 1560.000000 -0.001864 -0.001482 0.002264 +12522 1 0.000256 1560.000000 -0.000099 -0.001759 0.006674 +12523 1 0.000232 1560.000000 0.000086 -0.002314 0.002701 +12524 1 0.000261 1560.000000 -0.001823 -0.000746 0.003796 +12525 1 0.000224 1560.000000 0.002728 -0.001353 0.000965 +12526 1 0.000202 1560.000000 -0.001539 0.001235 0.002164 +12527 1 0.000275 1560.000000 0.001740 -0.002760 0.000144 +12528 1 0.000242 1560.000000 -0.000417 -0.002165 0.007706 +12529 1 0.000274 1560.000000 0.000764 -0.002836 0.004724 +12530 1 0.000250 1560.000000 0.002381 0.002932 0.003444 +12531 1 0.000265 1560.000000 0.002769 0.001160 0.006427 +12532 1 0.000275 1560.000000 -0.000611 -0.000261 0.003697 +12533 1 0.000197 1560.000000 -0.000552 -0.001069 0.009687 +12534 1 0.000212 1560.000000 0.001698 0.002952 0.002332 +12535 1 0.000232 1560.000000 -0.001838 0.001610 0.002658 +12536 1 0.000199 1560.000000 0.000334 0.002588 0.000624 +12537 1 0.000219 1560.000000 -0.000511 -0.000003 0.001569 +12538 1 0.000221 1560.000000 -0.001639 0.000058 0.001436 +12539 1 0.000215 1560.000000 -0.001180 0.001820 0.000881 +12540 1 0.000203 1560.000000 0.002064 0.001868 0.006991 +12541 1 0.000201 1560.000000 0.002475 0.000943 0.008974 +12542 1 0.000201 1560.000000 0.001311 -0.001510 0.005024 +12543 1 0.000230 1560.000000 0.000502 0.003310 0.004460 +12544 1 0.000233 1560.000000 0.002682 0.002263 0.007687 +12545 1 0.000267 1560.000000 0.003493 0.001621 0.000412 +12546 1 0.000268 1560.000000 0.001989 0.002930 0.001480 +12547 1 0.000216 1560.000000 0.001851 -0.001566 0.005664 +12548 1 0.000262 1560.000000 0.001021 0.003308 0.001123 +12549 1 0.000281 1560.000000 -0.001746 0.003404 0.004350 +12550 1 0.000215 1560.000000 -0.001509 0.001078 0.006832 +12551 1 0.000235 1560.000000 -0.002869 -0.001766 0.004338 +12552 1 0.000199 1560.000000 -0.001073 0.000255 0.006261 +12553 1 0.000232 1560.000000 0.001923 0.001235 0.001439 +12554 1 0.000274 1560.000000 -0.001246 -0.003009 0.004073 +12555 1 0.000255 1560.000000 -0.002430 0.001891 0.004408 +12556 1 0.000217 1560.000000 0.003357 -0.000317 0.006430 +12557 1 0.000218 1560.000000 0.002025 -0.002427 0.007723 +12558 1 0.000204 1560.000000 -0.002121 0.001360 0.005215 +12559 1 0.000228 1560.000000 -0.001888 -0.002982 0.000834 +12560 1 0.000264 1560.000000 0.002080 0.000981 0.004362 +12561 1 0.000284 1560.000000 0.002505 0.002800 0.008128 +12562 1 0.000195 1560.000000 -0.000651 -0.000033 0.009013 +12563 1 0.000231 1560.000000 0.002022 0.001392 0.006540 +12564 1 0.000285 1560.000000 0.001472 0.003283 0.001685 +12565 1 0.000265 1560.000000 -0.003525 -0.001346 0.006521 +12566 1 0.000226 1560.000000 -0.001810 0.001300 0.006164 +12567 1 0.000195 1560.000000 -0.001322 -0.000849 0.009426 +12568 1 0.000224 1560.000000 0.002266 -0.001276 0.008497 +12569 1 0.000230 1560.000000 0.002768 -0.002170 0.007927 +12570 1 0.000196 1560.000000 0.002430 0.000847 0.004564 +12571 1 0.000214 1560.000000 -0.000217 0.001742 0.003464 +12572 1 0.000245 1560.000000 -0.000047 0.001463 0.003509 +12573 1 0.000286 1560.000000 -0.002014 -0.001934 0.009812 +12574 1 0.000196 1560.000000 -0.000603 -0.003664 0.001726 +12575 1 0.000235 1560.000000 0.002853 -0.000960 0.008659 +12576 1 0.000202 1560.000000 0.000638 -0.002254 0.003139 +12577 1 0.000194 1560.000000 0.003620 0.000444 0.005633 +12578 1 0.000197 1560.000000 -0.000298 0.002160 0.007070 +12579 1 0.000266 1560.000000 -0.000626 -0.002654 0.001568 +12580 1 0.000250 1560.000000 -0.002421 -0.001913 0.006583 +12581 1 0.000198 1560.000000 -0.000682 -0.000125 0.004684 +12582 1 0.000280 1560.000000 -0.003096 0.002100 0.002916 +12583 1 0.000207 1560.000000 -0.000598 -0.003408 0.008794 +12584 1 0.000221 1560.000000 -0.000142 -0.003058 0.005534 +12585 1 0.000195 1560.000000 -0.003676 0.000150 0.009453 +12586 1 0.000213 1560.000000 -0.003377 0.000367 0.003511 +12587 1 0.000249 1560.000000 0.002423 -0.001968 0.007910 +12588 1 0.000213 1560.000000 -0.002544 0.002434 0.008763 +12589 1 0.000232 1560.000000 0.002829 -0.001249 0.009473 +12590 1 0.000226 1560.000000 0.000883 -0.001265 0.004651 +12591 1 0.000195 1560.000000 -0.002278 0.001502 0.008811 +12592 1 0.000207 1560.000000 -0.001763 0.002344 0.009321 +12593 1 0.000237 1560.000000 -0.003178 -0.000329 0.005043 +12594 1 0.000231 1560.000000 -0.003339 0.001848 0.003692 +12595 1 0.000223 1560.000000 0.001277 0.000939 0.005697 +12596 1 0.000260 1560.000000 -0.001443 0.000941 0.009321 +12597 1 0.000236 1560.000000 0.002038 -0.002402 0.008188 +12598 1 0.000193 1560.000000 0.000840 0.002121 0.008879 +12599 1 0.000213 1560.000000 -0.003259 -0.000633 0.007236 +12600 1 0.000237 1560.000000 -0.002201 0.001614 0.003852 +12601 1 0.000282 1560.000000 -0.002397 0.001669 0.002243 +12602 1 0.000282 1560.000000 0.002757 -0.002547 0.001715 +12603 1 0.000208 1560.000000 -0.002989 -0.002223 0.000717 +12604 1 0.000224 1560.000000 -0.001922 0.003341 0.007562 +12605 1 0.000249 1560.000000 0.001319 -0.003049 0.001143 +12606 1 0.000242 1560.000000 0.002373 -0.003015 0.003642 +12607 1 0.000198 1560.000000 -0.000372 0.003045 0.007231 +12608 1 0.000246 1560.000000 -0.000784 -0.002137 0.001423 +12609 1 0.000225 1560.000000 0.001855 -0.000482 0.009242 +12610 1 0.000252 1560.000000 0.000810 0.003367 0.004446 +12611 1 0.000210 1560.000000 -0.002437 -0.000078 0.006262 +12612 1 0.000216 1560.000000 0.000162 -0.002020 0.001514 +12613 1 0.000211 1560.000000 0.003671 0.000228 0.007565 +12614 1 0.000201 1560.000000 0.002060 -0.003033 0.006234 +12615 1 0.000204 1560.000000 0.001047 0.003507 0.003321 +12616 1 0.000274 1560.000000 -0.000679 0.001664 0.007917 +12617 1 0.000194 1560.000000 -0.001163 0.000979 0.009432 +12618 1 0.000240 1560.000000 0.000636 0.002480 0.007138 +12619 1 0.000216 1560.000000 -0.000375 0.000869 0.003258 +12620 1 0.000260 1560.000000 -0.000031 -0.003394 0.003494 +12621 1 0.000200 1560.000000 -0.002749 -0.002200 0.007222 +12622 1 0.000205 1560.000000 -0.003317 -0.000764 0.005496 +12623 1 0.000215 1560.000000 -0.001875 -0.000883 0.005005 +12624 1 0.000211 1560.000000 -0.002674 0.001962 0.009513 +12625 1 0.000234 1560.000000 0.002645 -0.001875 0.002948 +12626 1 0.000270 1560.000000 0.001467 -0.002146 0.006322 +12627 1 0.000275 1560.000000 0.000647 -0.003752 0.005198 +12628 1 0.000221 1560.000000 0.002714 -0.001731 0.009737 +12629 1 0.000211 1560.000000 -0.002963 0.001278 0.006916 +12630 1 0.000261 1560.000000 -0.000696 -0.000230 0.004132 +12631 1 0.000219 1560.000000 0.000333 -0.000336 0.000112 +12632 1 0.000214 1560.000000 -0.001314 0.002290 0.005988 +12633 1 0.000230 1560.000000 -0.002945 -0.001825 0.009707 +12634 1 0.000226 1560.000000 -0.001406 -0.002382 0.005344 +12635 1 0.000210 1560.000000 -0.003364 0.000788 0.002634 +12636 1 0.000242 1560.000000 -0.003205 -0.000645 0.009369 +12637 1 0.000262 1560.000000 -0.001517 0.000233 0.003601 +12638 1 0.000261 1560.000000 0.002920 0.001239 0.002177 +12639 1 0.000194 1560.000000 0.002496 0.002797 0.000183 +12640 1 0.000267 1560.000000 -0.002658 0.000903 0.005472 +12641 1 0.000207 1560.000000 0.000783 0.003635 0.005249 +12642 1 0.000271 1560.000000 -0.001158 0.001462 0.000310 +12643 1 0.000201 1560.000000 -0.001533 0.002101 0.007454 +12644 1 0.000209 1560.000000 0.001789 -0.003368 0.001169 +12645 1 0.000235 1560.000000 -0.001114 0.000383 0.003764 +12646 1 0.000196 1560.000000 0.003582 0.000277 0.006225 +12647 1 0.000203 1560.000000 -0.000889 0.001893 0.003856 +12648 1 0.000275 1560.000000 0.000087 0.000952 0.008068 +12649 1 0.000277 1560.000000 -0.001459 0.002954 0.007257 +12650 1 0.000286 1560.000000 0.002901 0.000945 0.005659 +12651 1 0.000287 1560.000000 -0.000415 0.003089 0.009826 +12652 1 0.000215 1560.000000 0.001791 -0.002834 0.005914 +12653 1 0.000200 1560.000000 0.001487 0.001153 0.006579 +12654 1 0.000196 1560.000000 -0.001110 0.001896 0.000431 +12655 1 0.000225 1560.000000 0.002044 -0.000966 0.001228 +12656 1 0.000195 1560.000000 0.000152 -0.002482 0.003387 +12657 1 0.000220 1560.000000 -0.002724 0.000249 0.004976 +12658 1 0.000194 1560.000000 0.000889 0.000062 0.003941 +12659 1 0.000240 1560.000000 -0.002582 0.001536 0.008829 +12660 1 0.000223 1560.000000 -0.001453 -0.002962 0.004222 +12661 1 0.000213 1560.000000 -0.000043 0.003621 0.000714 +12662 1 0.000204 1560.000000 -0.002792 0.002568 0.009600 +12663 1 0.000255 1560.000000 0.003766 -0.000034 0.008792 +12664 1 0.000199 1560.000000 -0.000815 0.000180 0.004791 +12665 1 0.000200 1560.000000 0.002064 0.000628 0.008358 +12666 1 0.000273 1560.000000 -0.000083 -0.003552 0.006199 +12667 1 0.000278 1560.000000 -0.002622 -0.002410 0.008200 +12668 1 0.000215 1560.000000 0.001855 0.001124 0.007675 +12669 1 0.000206 1560.000000 0.000630 -0.000502 0.007314 +12670 1 0.000234 1560.000000 0.000883 0.001642 0.000141 +12671 1 0.000247 1560.000000 0.000136 -0.001869 0.009350 +12672 1 0.000195 1560.000000 0.003318 0.001953 0.007045 +12673 1 0.000217 1560.000000 -0.002152 -0.003089 0.002774 +12674 1 0.000251 1560.000000 0.000358 0.000979 0.009016 +12675 1 0.000275 1560.000000 -0.002064 -0.000169 0.000859 +12676 1 0.000221 1560.000000 -0.000874 0.000337 0.002231 +12677 1 0.000201 1560.000000 0.000623 0.003451 0.006690 +12678 1 0.000266 1560.000000 -0.000024 -0.003757 0.008597 +12679 1 0.000215 1560.000000 0.000822 -0.003733 0.009011 +12680 1 0.000197 1560.000000 -0.000650 -0.002794 0.003235 +12681 1 0.000243 1560.000000 0.003430 -0.000151 0.009767 +12682 1 0.000229 1560.000000 -0.001098 0.002006 0.005077 +12683 1 0.000229 1560.000000 0.001720 -0.001235 0.002576 +12684 1 0.000281 1560.000000 -0.003053 0.001115 0.003250 +12685 1 0.000222 1560.000000 -0.000908 -0.002605 0.001324 +12686 1 0.000224 1560.000000 -0.001327 -0.001733 0.005591 +12687 1 0.000206 1560.000000 -0.001509 -0.001920 0.009542 +12688 1 0.000208 1560.000000 0.002996 -0.000638 0.007297 +12689 1 0.000264 1560.000000 0.000218 0.002699 0.002955 +12690 1 0.000197 1560.000000 0.001236 -0.001207 0.004027 +12691 1 0.000205 1560.000000 0.000181 -0.001402 0.008350 +12692 1 0.000197 1560.000000 0.000274 0.003453 0.009174 +12693 1 0.000228 1560.000000 -0.000087 0.001853 0.002299 +12694 1 0.000249 1560.000000 0.003318 0.001808 0.009324 +12695 1 0.000237 1560.000000 0.002473 -0.002876 0.005294 +12696 1 0.000274 1560.000000 -0.003515 -0.001118 0.001010 +12697 1 0.000211 1560.000000 0.000479 -0.003017 0.007111 +12698 1 0.000248 1560.000000 -0.000288 -0.001951 0.007176 +12699 1 0.000193 1560.000000 -0.003031 -0.001844 0.006046 +12700 1 0.000199 1560.000000 -0.000815 0.002357 0.007261 +12701 1 0.000210 1560.000000 0.001681 -0.002916 0.001653 +12702 1 0.000236 1560.000000 -0.002804 0.000175 0.008841 +12703 1 0.000221 1560.000000 0.000902 -0.000232 0.005741 +12704 1 0.000214 1560.000000 -0.002406 -0.001888 0.007014 +12705 1 0.000220 1560.000000 -0.001621 0.002382 0.003434 +12706 1 0.000252 1560.000000 -0.000084 0.001222 0.009416 +12707 1 0.000226 1560.000000 0.001995 -0.000871 0.006008 +12708 1 0.000227 1560.000000 0.003022 0.002261 0.009695 +12709 1 0.000216 1560.000000 0.000523 -0.003359 0.001103 +12710 1 0.000197 1560.000000 0.000660 -0.002173 0.000527 +12711 1 0.000282 1560.000000 -0.002039 0.002234 0.002732 +12712 1 0.000224 1560.000000 0.001926 -0.002932 0.002977 +12713 1 0.000217 1560.000000 -0.000242 0.000307 0.009605 +12714 1 0.000282 1560.000000 0.002171 0.001124 0.006451 +12715 1 0.000231 1560.000000 -0.002757 -0.000103 0.001854 +12716 1 0.000200 1560.000000 0.000162 -0.000209 0.000160 +12717 1 0.000213 1560.000000 0.001827 -0.002904 0.009029 +12718 1 0.000277 1560.000000 0.002691 -0.000237 0.005431 +12719 1 0.000228 1560.000000 0.000680 0.000554 0.007164 +12720 1 0.000257 1560.000000 -0.000890 -0.002571 0.003737 +12721 1 0.000214 1560.000000 -0.002471 -0.000149 0.001535 +12722 1 0.000220 1560.000000 -0.000950 -0.000101 0.004958 +12723 1 0.000260 1560.000000 -0.001337 0.003604 0.005804 +12724 1 0.000201 1560.000000 0.003091 0.001205 0.009623 +12725 1 0.000254 1560.000000 0.001029 0.003196 0.000171 +12726 1 0.000231 1560.000000 -0.000164 -0.001628 0.003364 +12727 1 0.000231 1560.000000 0.001968 0.001103 0.004952 +12728 1 0.000281 1560.000000 -0.000339 0.003448 0.005045 +12729 1 0.000264 1560.000000 -0.003775 -0.000535 0.001030 +12730 1 0.000192 1560.000000 0.002050 -0.002704 0.007714 +12731 1 0.000205 1560.000000 -0.001685 0.001003 0.007891 +12732 1 0.000285 1560.000000 0.001487 0.001724 0.000293 +12733 1 0.000208 1560.000000 0.000105 -0.001201 0.000765 +12734 1 0.000195 1560.000000 0.003683 -0.000064 0.008272 +12735 1 0.000210 1560.000000 -0.003502 -0.000880 0.002385 +12736 1 0.000249 1560.000000 -0.000282 0.001652 0.002390 +12737 1 0.000199 1560.000000 -0.001391 0.000046 0.005029 +12738 1 0.000251 1560.000000 0.001112 0.001849 0.005334 +12739 1 0.000250 1560.000000 -0.001829 -0.000455 0.002346 +12740 1 0.000208 1560.000000 0.000157 -0.001385 0.000467 +12741 1 0.000254 1560.000000 -0.003809 -0.000074 0.004414 +12742 1 0.000258 1560.000000 0.003204 -0.001740 0.000600 +12743 1 0.000207 1560.000000 0.002703 0.000627 0.006643 +12744 1 0.000213 1560.000000 0.001607 -0.003208 0.000108 +12745 1 0.000236 1560.000000 -0.003299 0.000721 0.001862 +12746 1 0.000230 1560.000000 -0.001629 0.003330 0.003639 +12747 1 0.000253 1560.000000 0.001895 0.003034 0.005320 +12748 1 0.000202 1560.000000 -0.000447 0.003271 0.006358 +12749 1 0.000249 1560.000000 0.000939 -0.002467 0.008805 +12750 1 0.000273 1560.000000 -0.000085 -0.001760 0.007636 +12751 1 0.000284 1560.000000 0.002958 -0.002295 0.001536 +12752 1 0.000270 1560.000000 -0.000663 -0.003700 0.008585 +12753 1 0.000244 1560.000000 0.003322 -0.001478 0.000778 +12754 1 0.000208 1560.000000 0.000029 -0.000675 0.003842 +12755 1 0.000234 1560.000000 0.002646 0.000324 0.009217 +12756 1 0.000228 1560.000000 -0.003538 0.000413 0.000295 +12757 1 0.000196 1560.000000 -0.002491 -0.000067 0.002617 +12758 1 0.000194 1560.000000 0.002482 0.002465 0.007895 +12759 1 0.000214 1560.000000 -0.000590 -0.002868 0.000964 +12760 1 0.000273 1560.000000 -0.001460 -0.001804 0.009825 +12761 1 0.000258 1560.000000 -0.002561 0.002772 0.009727 +12762 1 0.000246 1560.000000 0.002104 -0.002296 0.004578 +12763 1 0.000194 1560.000000 -0.003125 -0.002052 0.001621 +12764 1 0.000196 1560.000000 -0.000825 -0.000149 0.006485 +12765 1 0.000195 1560.000000 0.002720 0.001256 0.006653 +12766 1 0.000218 1560.000000 0.000440 0.000271 0.005605 +12767 1 0.000199 1560.000000 -0.002109 -0.001690 0.001417 +12768 1 0.000196 1560.000000 -0.001781 0.003081 0.004048 +12769 1 0.000287 1560.000000 -0.001925 -0.001479 0.006456 +12770 1 0.000235 1560.000000 0.000524 0.003761 0.007333 +12771 1 0.000262 1560.000000 -0.000361 0.002629 0.006200 +12772 1 0.000242 1560.000000 0.001979 -0.002074 0.003580 +12773 1 0.000194 1560.000000 0.001149 -0.001964 0.006370 +12774 1 0.000210 1560.000000 -0.001766 -0.001194 0.007441 +12775 1 0.000215 1560.000000 -0.001514 -0.001604 0.003371 +12776 1 0.000217 1560.000000 0.002056 -0.000367 0.004733 +12777 1 0.000215 1560.000000 -0.002218 -0.001068 0.000213 +12778 1 0.000257 1560.000000 0.002328 -0.002457 0.002748 +12779 1 0.000212 1560.000000 0.003007 -0.000902 0.000918 +12780 1 0.000221 1560.000000 -0.002869 -0.000664 0.003280 +12781 1 0.000232 1560.000000 0.001115 -0.002690 0.009124 +12782 1 0.000200 1560.000000 -0.002741 0.000632 0.004591 +12783 1 0.000282 1560.000000 0.002543 -0.000639 0.008214 +12784 1 0.000254 1560.000000 0.002575 -0.002640 0.006673 +12785 1 0.000274 1560.000000 -0.000039 -0.003400 0.007339 +12786 1 0.000251 1560.000000 0.003209 -0.001214 0.005302 +12787 1 0.000197 1560.000000 -0.001796 0.000833 0.007354 +12788 1 0.000239 1560.000000 -0.001030 0.003517 0.006325 +12789 1 0.000243 1560.000000 -0.002063 0.002323 0.008249 +12790 1 0.000238 1560.000000 -0.001743 0.001569 0.009146 +12791 1 0.000205 1560.000000 -0.002784 0.001398 0.009126 +12792 1 0.000278 1560.000000 -0.002111 -0.002539 0.008708 +12793 1 0.000196 1560.000000 0.002929 0.000374 0.005358 +12794 1 0.000223 1560.000000 -0.001306 0.003542 0.006764 +12795 1 0.000209 1560.000000 -0.001925 -0.002009 0.003568 +12796 1 0.000193 1560.000000 -0.001575 0.001233 0.003232 +12797 1 0.000229 1560.000000 0.000900 0.000153 0.009496 +12798 1 0.000234 1560.000000 -0.001325 0.003580 0.008905 +12799 1 0.000257 1560.000000 0.000603 -0.002831 0.007228 +12800 1 0.000196 1560.000000 -0.002241 0.002817 0.008963 +12801 1 0.000228 1560.000000 0.002460 0.000016 0.005318 +12802 1 0.000233 1560.000000 -0.002280 0.001841 0.004009 +12803 1 0.000193 1560.000000 0.002527 -0.002015 0.004287 +12804 1 0.000241 1560.000000 -0.000253 0.001031 0.005967 +12805 1 0.000259 1560.000000 0.001725 0.000388 0.007527 +12806 1 0.000200 1560.000000 0.000453 -0.003141 0.009041 +12807 1 0.000209 1560.000000 -0.000757 0.002458 0.005535 +12808 1 0.000212 1560.000000 -0.002441 0.002930 0.004578 +12809 1 0.000205 1560.000000 0.002112 0.002162 0.002336 +12810 1 0.000217 1560.000000 0.002740 -0.001446 0.006493 +12811 1 0.000279 1560.000000 -0.001633 -0.002484 0.000691 +12812 1 0.000214 1560.000000 -0.002804 0.001375 0.003578 +12813 1 0.000225 1560.000000 0.003302 0.001905 0.004719 +12814 1 0.000240 1560.000000 -0.000491 -0.002713 0.007919 +12815 1 0.000216 1560.000000 0.001777 0.002174 0.005830 +12816 1 0.000226 1560.000000 0.001594 0.002568 0.009593 +12817 1 0.000198 1560.000000 -0.003119 0.001404 0.007618 +12818 1 0.000271 1560.000000 0.002621 0.001118 0.000437 +12819 1 0.000208 1560.000000 -0.002149 0.000637 0.001098 +12820 1 0.000240 1560.000000 0.000173 0.003390 0.009774 +12821 1 0.000263 1560.000000 -0.000210 0.003449 0.001133 +12822 1 0.000233 1560.000000 0.001853 -0.000428 0.005573 +12823 1 0.000218 1560.000000 -0.000454 0.003786 0.006931 +12824 1 0.000224 1560.000000 0.001909 -0.001494 0.003042 +12825 1 0.000196 1560.000000 -0.001497 -0.000586 0.004686 +12826 1 0.000245 1560.000000 0.001687 0.002562 0.002481 +12827 1 0.000219 1560.000000 -0.002244 -0.002738 0.009094 +12828 1 0.000236 1560.000000 0.002664 -0.001039 0.009313 +12829 1 0.000231 1560.000000 0.003305 -0.001191 0.003820 +12830 1 0.000220 1560.000000 -0.003428 0.001361 0.004188 +12831 1 0.000212 1560.000000 0.000714 0.001001 0.000680 +12832 1 0.000205 1560.000000 -0.000272 -0.000658 0.000968 +12833 1 0.000235 1560.000000 0.000729 0.000556 0.007552 +12834 1 0.000270 1560.000000 -0.000031 -0.002116 0.003256 +12835 1 0.000224 1560.000000 -0.001142 0.000233 0.006912 +12836 1 0.000287 1560.000000 0.001252 -0.001664 0.007517 +12837 1 0.000250 1560.000000 -0.002226 -0.002970 0.003315 +12838 1 0.000212 1560.000000 0.001975 -0.001041 0.003296 +12839 1 0.000248 1560.000000 -0.002745 0.000750 0.008130 +12840 1 0.000275 1560.000000 0.000861 -0.000891 0.003217 +12841 1 0.000248 1560.000000 -0.000846 -0.002819 0.001047 +12842 1 0.000211 1560.000000 0.002368 0.000504 0.005369 +12843 1 0.000269 1560.000000 -0.003754 0.000040 0.008302 +12844 1 0.000265 1560.000000 0.003032 -0.000452 0.001201 +12845 1 0.000233 1560.000000 -0.001764 0.002670 0.004865 +12846 1 0.000208 1560.000000 0.001037 0.001465 0.008930 +12847 1 0.000233 1560.000000 0.003450 0.001576 0.002261 +12848 1 0.000240 1560.000000 -0.001604 0.001344 0.000884 +12849 1 0.000219 1560.000000 -0.000568 -0.003262 0.001625 +12850 1 0.000207 1560.000000 -0.001162 -0.002353 0.008653 +12851 1 0.000196 1560.000000 -0.002900 -0.001454 0.002018 +12852 1 0.000210 1560.000000 0.000828 0.002039 0.001410 +12853 1 0.000207 1560.000000 -0.003769 0.000756 0.008041 +12854 1 0.000221 1560.000000 0.003090 -0.001870 0.002163 +12855 1 0.000250 1560.000000 -0.000825 0.002446 0.006014 +12856 1 0.000203 1560.000000 0.000723 0.001683 0.001511 +12857 1 0.000241 1560.000000 0.002470 -0.002694 0.002454 +12858 1 0.000196 1560.000000 -0.001743 -0.001798 0.003853 +12859 1 0.000247 1560.000000 0.001561 -0.000078 0.000328 +12860 1 0.000227 1560.000000 0.001480 0.003516 0.005154 +12861 1 0.000209 1560.000000 0.000531 -0.001045 0.001197 +12862 1 0.000264 1560.000000 0.002309 0.002953 0.001771 +12863 1 0.000239 1560.000000 -0.002225 -0.001544 0.002141 +12864 1 0.000230 1560.000000 0.000035 0.002389 0.008679 +12865 1 0.000261 1560.000000 -0.002037 -0.000222 0.004516 +12866 1 0.000214 1560.000000 -0.003492 0.001514 0.009025 +12867 1 0.000204 1560.000000 -0.000091 -0.000473 0.006554 +12868 1 0.000228 1560.000000 -0.001913 0.001342 0.000453 +12869 1 0.000236 1560.000000 0.000971 -0.003626 0.002879 +12870 1 0.000267 1560.000000 -0.003772 -0.000750 0.001748 +12871 1 0.000226 1560.000000 -0.002990 0.001062 0.008155 +12872 1 0.000267 1560.000000 0.001552 -0.002707 0.009246 +12873 1 0.000220 1560.000000 0.000948 -0.002917 0.003471 +12874 1 0.000224 1560.000000 0.000002 0.003814 0.006446 +12875 1 0.000247 1560.000000 -0.002104 0.001593 0.000768 +12876 1 0.000209 1560.000000 -0.001300 -0.003617 0.006047 +12877 1 0.000208 1560.000000 0.000685 -0.002796 0.008385 +12878 1 0.000252 1560.000000 -0.002325 0.002783 0.008751 +12879 1 0.000264 1560.000000 -0.002108 0.001096 0.007774 +12880 1 0.000260 1560.000000 0.002970 0.000266 0.006967 +12881 1 0.000287 1560.000000 -0.003825 0.000454 0.000824 +12882 1 0.000193 1560.000000 -0.000543 0.003667 0.004626 +12883 1 0.000200 1560.000000 0.001150 0.002132 0.009045 +12884 1 0.000238 1560.000000 0.002738 -0.002365 0.004797 +12885 1 0.000230 1560.000000 0.003461 -0.001680 0.005856 +12886 1 0.000216 1560.000000 0.000785 -0.001534 0.008640 +12887 1 0.000205 1560.000000 0.002590 0.001880 0.005118 +12888 1 0.000210 1560.000000 -0.000828 -0.001805 0.002609 +12889 1 0.000262 1560.000000 0.001658 0.001428 0.000235 +12890 1 0.000212 1560.000000 0.002503 0.002233 0.001951 +12891 1 0.000208 1560.000000 -0.001506 0.001179 0.004338 +12892 1 0.000231 1560.000000 -0.000247 -0.000836 0.003708 +12893 1 0.000276 1560.000000 0.000339 -0.002576 0.005112 +12894 1 0.000240 1560.000000 -0.003463 0.000411 0.008623 +12895 1 0.000263 1560.000000 0.002964 0.001596 0.008108 +12896 1 0.000194 1560.000000 -0.000181 -0.002034 0.000982 +12897 1 0.000229 1560.000000 0.000700 0.001035 0.001198 +12898 1 0.000218 1560.000000 -0.000371 0.000649 0.006053 +12899 1 0.000272 1560.000000 -0.000951 -0.002352 0.009423 +12900 1 0.000230 1560.000000 0.001941 -0.000164 0.000335 +12901 1 0.000201 1560.000000 -0.001889 -0.002152 0.005940 +12902 1 0.000254 1560.000000 0.002988 0.000808 0.002141 +12903 1 0.000202 1560.000000 0.000073 -0.003731 0.004131 +12904 1 0.000273 1560.000000 -0.002314 0.000793 0.006918 +12905 1 0.000278 1560.000000 -0.001838 0.001914 0.003775 +12906 1 0.000239 1560.000000 0.000413 0.002046 0.002173 +12907 1 0.000224 1560.000000 -0.001706 0.001547 0.000723 +12908 1 0.000255 1560.000000 0.001287 -0.001471 0.008350 +12909 1 0.000242 1560.000000 -0.001107 -0.002690 0.005867 +12910 1 0.000282 1560.000000 -0.002676 0.002577 0.000627 +12911 1 0.000256 1560.000000 0.001236 0.001458 0.003327 +12912 1 0.000208 1560.000000 0.001939 0.001311 0.005648 +12913 1 0.000192 1560.000000 -0.001179 -0.003407 0.005095 +12914 1 0.000210 1560.000000 0.000403 -0.001708 0.006139 +12915 1 0.000250 1560.000000 0.001446 0.000639 0.003273 +12916 1 0.000268 1560.000000 -0.003510 0.001306 0.008628 +12917 1 0.000250 1560.000000 -0.000080 -0.002416 0.006411 +12918 1 0.000204 1560.000000 -0.000281 -0.000516 0.006738 +12919 1 0.000258 1560.000000 0.002907 0.002441 0.002049 +12920 1 0.000284 1560.000000 -0.001390 -0.002972 0.005137 +12921 1 0.000250 1560.000000 0.001818 -0.001676 0.003770 +12922 1 0.000195 1560.000000 0.000666 -0.002387 0.003561 +12923 1 0.000213 1560.000000 -0.000728 -0.000800 0.008907 +12924 1 0.000195 1560.000000 0.003220 0.000428 0.003167 +12925 1 0.000207 1560.000000 -0.001207 -0.003029 0.000444 +12926 1 0.000207 1560.000000 0.001583 0.002018 0.003920 +12927 1 0.000210 1560.000000 0.002454 0.001148 0.004181 +12928 1 0.000258 1560.000000 0.000472 0.001759 0.003784 +12929 1 0.000223 1560.000000 -0.000170 -0.003565 0.003861 +12930 1 0.000221 1560.000000 0.002254 0.002631 0.009018 +12931 1 0.000203 1560.000000 -0.001806 0.001234 0.002073 +12932 1 0.000217 1560.000000 0.000458 -0.001133 0.000140 +12933 1 0.000200 1560.000000 0.000676 -0.003787 0.000455 +12934 1 0.000205 1560.000000 -0.002459 0.000941 0.001734 +12935 1 0.000218 1560.000000 -0.001234 -0.002794 0.003905 +12936 1 0.000255 1560.000000 -0.000971 -0.002506 0.007383 +12937 1 0.000267 1560.000000 0.001694 -0.001706 0.005953 +12938 1 0.000195 1560.000000 -0.002545 0.001694 0.004512 +12939 1 0.000213 1560.000000 -0.002840 -0.001953 0.006359 +12940 1 0.000235 1560.000000 0.001045 -0.002492 0.005939 +12941 1 0.000262 1560.000000 -0.000001 -0.002169 0.003591 +12942 1 0.000198 1560.000000 0.002847 -0.000516 0.008844 +12943 1 0.000261 1560.000000 -0.001866 0.000627 0.006586 +12944 1 0.000267 1560.000000 0.001232 -0.000522 0.000232 +12945 1 0.000204 1560.000000 0.001124 -0.002163 0.006866 +12946 1 0.000199 1560.000000 0.002558 0.000677 0.008801 +12947 1 0.000220 1560.000000 0.000189 0.002587 0.001079 +12948 1 0.000192 1560.000000 -0.002382 0.001252 0.007058 +12949 1 0.000234 1560.000000 0.003325 0.000329 0.001589 +12950 1 0.000265 1560.000000 0.000801 -0.002117 0.004001 +12951 1 0.000243 1560.000000 -0.000457 -0.001718 0.009047 +12952 1 0.000279 1560.000000 -0.000472 0.003470 0.008408 +12953 1 0.000239 1560.000000 0.001550 -0.000506 0.006720 +12954 1 0.000256 1560.000000 0.001988 -0.003098 0.007045 +12955 1 0.000201 1560.000000 0.002388 0.000389 0.003419 +12956 1 0.000194 1560.000000 0.001251 0.000139 0.002837 +12957 1 0.000229 1560.000000 0.001377 -0.003302 0.002032 +12958 1 0.000281 1560.000000 0.000288 -0.003377 0.006227 +12959 1 0.000193 1560.000000 -0.000051 0.001465 0.006822 +12960 1 0.000223 1560.000000 -0.002842 0.000698 0.003703 +12961 1 0.000256 1560.000000 -0.000785 0.003729 0.004127 +12962 1 0.000219 1560.000000 0.003071 -0.000087 0.006972 +12963 1 0.000253 1560.000000 0.001213 -0.002474 0.000942 +12964 1 0.000280 1560.000000 0.001467 0.000483 0.000457 +12965 1 0.000212 1560.000000 -0.000816 -0.001572 0.005158 +12966 1 0.000211 1560.000000 -0.000599 -0.001540 0.006490 +12967 1 0.000201 1560.000000 0.000858 0.002055 0.005203 +12968 1 0.000249 1560.000000 -0.001885 0.001317 0.009141 +12969 1 0.000239 1560.000000 0.000751 -0.000799 0.004831 +12970 1 0.000261 1560.000000 -0.003664 0.000350 0.006445 +12971 1 0.000261 1560.000000 0.000394 -0.003819 0.003317 +12972 1 0.000230 1560.000000 -0.003041 -0.000654 0.006957 +12973 1 0.000194 1560.000000 -0.001517 -0.002087 0.009416 +12974 1 0.000274 1560.000000 -0.001150 0.001082 0.002227 +12975 1 0.000262 1560.000000 -0.003765 -0.000649 0.002508 +12976 1 0.000271 1560.000000 0.002137 0.002397 0.007277 +12977 1 0.000217 1560.000000 -0.002522 -0.001712 0.003368 +12978 1 0.000239 1560.000000 -0.000572 -0.002417 0.006571 +12979 1 0.000224 1560.000000 -0.000116 -0.003825 0.003446 +12980 1 0.000233 1560.000000 -0.001666 -0.002623 0.000405 +12981 1 0.000199 1560.000000 -0.003719 -0.000421 0.005395 +12982 1 0.000231 1560.000000 -0.002169 0.002067 0.005502 +12983 1 0.000248 1560.000000 0.000095 0.002814 0.009080 +12984 1 0.000224 1560.000000 0.003733 0.000225 0.005272 +12985 1 0.000225 1560.000000 -0.000053 0.003599 0.003529 +12986 1 0.000236 1560.000000 -0.000167 0.002155 0.004225 +12987 1 0.000200 1560.000000 0.001358 -0.002577 0.000517 +12988 1 0.000278 1560.000000 -0.000354 0.002586 0.009840 +12989 1 0.000258 1560.000000 0.001776 -0.000530 0.002068 +12990 1 0.000263 1560.000000 0.001065 0.001071 0.004618 +12991 1 0.000223 1560.000000 0.000951 -0.001983 0.002650 +12992 1 0.000211 1560.000000 0.001269 0.003404 0.009395 +12993 1 0.000255 1560.000000 -0.001095 0.002448 0.006923 +12994 1 0.000212 1560.000000 -0.000288 -0.001827 0.005812 +12995 1 0.000278 1560.000000 0.002551 -0.002851 0.008351 +12996 1 0.000194 1560.000000 0.000811 -0.003245 0.000642 +12997 1 0.000250 1560.000000 0.000822 0.003599 0.001028 +12998 1 0.000200 1560.000000 0.003549 -0.000730 0.004945 +12999 1 0.000241 1560.000000 -0.003731 0.000087 0.006465 +13000 1 0.000193 1560.000000 0.000059 0.000502 0.000766 +13001 1 0.000246 1560.000000 -0.002955 0.000335 0.008500 +13002 1 0.000206 1560.000000 0.000941 0.000840 0.006970 +13003 1 0.000264 1560.000000 0.003449 -0.001640 0.008333 +13004 1 0.000200 1560.000000 -0.001745 -0.000372 0.000737 +13005 1 0.000226 1560.000000 -0.002174 -0.003136 0.006332 +13006 1 0.000207 1560.000000 0.000045 -0.000535 0.008329 +13007 1 0.000212 1560.000000 0.000533 0.000747 0.001108 +13008 1 0.000204 1560.000000 -0.000124 -0.000249 0.008787 +13009 1 0.000231 1560.000000 -0.001958 -0.002468 0.008254 +13010 1 0.000193 1560.000000 0.001611 -0.001360 0.002852 +13011 1 0.000274 1560.000000 0.002279 -0.001674 0.006792 +13012 1 0.000274 1560.000000 -0.003212 0.000987 0.004142 +13013 1 0.000257 1560.000000 0.003696 0.000663 0.004349 +13014 1 0.000206 1560.000000 0.000523 0.001811 0.003054 +13015 1 0.000237 1560.000000 -0.000837 -0.001661 0.008700 +13016 1 0.000278 1560.000000 0.001233 -0.003145 0.008907 +13017 1 0.000198 1560.000000 -0.000650 0.003614 0.003923 +13018 1 0.000253 1560.000000 -0.002230 0.002616 0.006523 +13019 1 0.000204 1560.000000 -0.000447 -0.000423 0.006831 +13020 1 0.000225 1560.000000 -0.002577 0.001719 0.000221 +13021 1 0.000260 1560.000000 0.000202 -0.003005 0.009512 +13022 1 0.000274 1560.000000 0.003513 -0.000862 0.003068 +13023 1 0.000266 1560.000000 0.003205 -0.000523 0.007175 +13024 1 0.000202 1560.000000 -0.003660 0.000182 0.008690 +13025 1 0.000195 1560.000000 -0.002229 0.000451 0.003680 +13026 1 0.000216 1560.000000 -0.001975 -0.000060 0.002106 +13027 1 0.000227 1560.000000 0.003289 0.001612 0.007045 +13028 1 0.000200 1560.000000 0.001068 -0.002900 0.003204 +13029 1 0.000267 1560.000000 -0.000203 0.003766 0.002472 +13030 1 0.000260 1560.000000 0.001493 0.002888 0.006944 +13031 1 0.000235 1560.000000 0.000604 0.002887 0.005778 +13032 1 0.000204 1560.000000 0.001163 -0.001362 0.005088 +13033 1 0.000202 1560.000000 -0.001999 0.002966 0.002343 +13034 1 0.000203 1560.000000 0.000979 -0.002310 0.007665 +13035 1 0.000268 1560.000000 0.002941 0.001465 0.002653 +13036 1 0.000238 1560.000000 0.000433 0.003192 0.009046 +13037 1 0.000225 1560.000000 -0.001059 -0.003610 0.005669 +13038 1 0.000254 1560.000000 0.001411 0.003132 0.000142 +13039 1 0.000254 1560.000000 0.001793 0.002844 0.008170 +13040 1 0.000212 1560.000000 -0.000970 -0.001232 0.002799 +13041 1 0.000193 1560.000000 -0.001909 0.002407 0.006398 +13042 1 0.000271 1560.000000 0.000636 0.000112 0.008326 +13043 1 0.000233 1560.000000 -0.000879 -0.003341 0.004126 +13044 1 0.000266 1560.000000 -0.002626 0.002477 0.006674 +13045 1 0.000204 1560.000000 0.001985 0.002782 0.009781 +13046 1 0.000206 1560.000000 0.001818 -0.002645 0.006200 +13047 1 0.000268 1560.000000 0.000169 0.001003 0.009818 +13048 1 0.000266 1560.000000 0.001657 0.003444 0.006645 +13049 1 0.000248 1560.000000 0.002256 0.001682 0.006321 +13050 1 0.000199 1560.000000 -0.000295 0.002106 0.002272 +13051 1 0.000208 1560.000000 -0.001200 -0.001709 0.007653 +13052 1 0.000217 1560.000000 0.002102 -0.002772 0.000421 +13053 1 0.000251 1560.000000 -0.002664 0.002619 0.006013 +13054 1 0.000237 1560.000000 -0.000862 -0.000162 0.008189 +13055 1 0.000225 1560.000000 -0.002038 0.002313 0.001070 +13056 1 0.000248 1560.000000 -0.003443 0.001459 0.006102 +13057 1 0.000203 1560.000000 0.000366 0.003380 0.005107 +13058 1 0.000222 1560.000000 -0.002011 0.001007 0.005942 +13059 1 0.000211 1560.000000 -0.003456 -0.000995 0.009507 +13060 1 0.000205 1560.000000 0.002735 0.000804 0.003023 +13061 1 0.000279 1560.000000 0.002191 0.000012 0.006210 +13062 1 0.000201 1560.000000 -0.000513 -0.000543 0.001561 +13063 1 0.000273 1560.000000 0.001812 -0.002296 0.005145 +13064 1 0.000216 1560.000000 0.001034 -0.001588 0.007849 +13065 1 0.000279 1560.000000 0.001089 0.001954 0.009488 +13066 1 0.000254 1560.000000 -0.000011 0.001954 0.008468 +13067 1 0.000215 1560.000000 0.001201 0.000390 0.004739 +13068 1 0.000276 1560.000000 -0.003093 0.001407 0.005162 +13069 1 0.000200 1560.000000 -0.000216 0.003761 0.003829 +13070 1 0.000220 1560.000000 0.002168 -0.000052 0.009815 +13071 1 0.000222 1560.000000 0.001801 -0.001171 0.005404 +13072 1 0.000273 1560.000000 0.001840 0.002632 0.009366 +13073 1 0.000202 1560.000000 -0.000447 0.000397 0.005271 +13074 1 0.000228 1560.000000 -0.001131 -0.000911 0.001445 +13075 1 0.000202 1560.000000 0.000912 -0.000530 0.003573 +13076 1 0.000235 1560.000000 -0.000926 -0.003652 0.001741 +13077 1 0.000227 1560.000000 0.003509 -0.001564 0.002734 +13078 1 0.000194 1560.000000 -0.000747 -0.003710 0.004178 +13079 1 0.000231 1560.000000 -0.001520 0.001020 0.003069 +13080 1 0.000224 1560.000000 0.003804 0.000421 0.001990 +13081 1 0.000229 1560.000000 -0.001494 0.002195 0.008221 +13082 1 0.000198 1560.000000 -0.001192 -0.003218 0.001764 +13083 1 0.000248 1560.000000 0.000269 -0.001481 0.002561 +13084 1 0.000205 1560.000000 -0.001961 -0.002104 0.000420 +13085 1 0.000255 1560.000000 -0.003208 0.000479 0.003781 +13086 1 0.000256 1560.000000 -0.001570 -0.000822 0.003982 +13087 1 0.000222 1560.000000 -0.001926 -0.001357 0.007203 +13088 1 0.000203 1560.000000 0.001173 -0.000307 0.006803 +13089 1 0.000234 1560.000000 -0.000049 0.001339 0.007095 +13090 1 0.000242 1560.000000 0.001372 -0.001181 0.001921 +13091 1 0.000196 1560.000000 -0.001068 -0.000634 0.004321 +13092 1 0.000252 1560.000000 -0.001540 -0.000270 0.001068 +13093 1 0.000198 1560.000000 0.002417 0.000577 0.004586 +13094 1 0.000194 1560.000000 0.000938 -0.000582 0.006057 +13095 1 0.000210 1560.000000 -0.000734 -0.001679 0.006636 +13096 1 0.000206 1560.000000 0.001719 0.001909 0.003553 +13097 1 0.000285 1560.000000 -0.002675 0.000319 0.001442 +13098 1 0.000239 1560.000000 -0.000429 0.003314 0.002378 +13099 1 0.000222 1560.000000 0.002781 0.000239 0.008434 +13100 1 0.000206 1560.000000 -0.003070 -0.001954 0.001412 +13101 1 0.000218 1560.000000 -0.000776 -0.000959 0.006041 +13102 1 0.000208 1560.000000 0.003649 -0.000784 0.006867 +13103 1 0.000211 1560.000000 0.000313 0.001145 0.005464 +13104 1 0.000200 1560.000000 0.001527 -0.001674 0.001602 +13105 1 0.000212 1560.000000 0.000634 0.002884 0.008841 +13106 1 0.000206 1560.000000 0.000098 0.001594 0.000171 +13107 1 0.000196 1560.000000 -0.000943 0.003515 0.009254 +13108 1 0.000218 1560.000000 -0.002843 0.002523 0.002014 +13109 1 0.000252 1560.000000 -0.003503 -0.001542 0.008148 +13110 1 0.000199 1560.000000 -0.003746 0.000012 0.004170 +13111 1 0.000211 1560.000000 0.000709 0.002262 0.008361 +13112 1 0.000254 1560.000000 0.000961 -0.000388 0.009461 +13113 1 0.000281 1560.000000 -0.001614 0.000515 0.008807 +13114 1 0.000280 1560.000000 0.001531 -0.003241 0.003017 +13115 1 0.000207 1560.000000 0.003385 0.000704 0.000155 +13116 1 0.000214 1560.000000 0.000765 0.001667 0.001857 +13117 1 0.000210 1560.000000 0.001218 -0.002040 0.005500 +13118 1 0.000216 1560.000000 0.002554 -0.000506 0.007033 +13119 1 0.000193 1560.000000 -0.001769 0.002827 0.003190 +13120 1 0.000274 1560.000000 0.001846 0.003338 0.002963 +13121 1 0.000261 1560.000000 -0.002780 0.000458 0.002958 +13122 1 0.000271 1560.000000 0.002079 -0.001685 0.004840 +13123 1 0.000264 1560.000000 0.003722 0.000897 0.008802 +13124 1 0.000279 1560.000000 0.001705 0.002485 0.006860 +13125 1 0.000266 1560.000000 -0.002292 -0.001721 0.003944 +13126 1 0.000245 1560.000000 0.001114 0.002194 0.001308 +13127 1 0.000209 1560.000000 -0.000964 -0.001312 0.007723 +13128 1 0.000271 1560.000000 0.002654 -0.000743 0.008827 +13129 1 0.000245 1560.000000 0.001403 0.001980 0.008366 +13130 1 0.000210 1560.000000 0.002195 -0.000320 0.005014 +13131 1 0.000274 1560.000000 -0.000860 -0.003402 0.008207 +13132 1 0.000205 1560.000000 -0.002695 -0.002729 0.002741 +13133 1 0.000214 1560.000000 -0.001697 -0.002511 0.007322 +13134 1 0.000206 1560.000000 -0.001580 -0.002672 0.004276 +13135 1 0.000219 1560.000000 0.001155 0.002300 0.007341 +13136 1 0.000227 1560.000000 -0.003333 -0.000670 0.001269 +13137 1 0.000247 1560.000000 0.001314 0.000280 0.008541 +13138 1 0.000203 1560.000000 0.001765 -0.000965 0.008945 +13139 1 0.000260 1560.000000 0.001914 -0.003112 0.003768 +13140 1 0.000221 1560.000000 -0.002075 -0.001223 0.000138 +13141 1 0.000215 1560.000000 -0.001140 0.000371 0.002995 +13142 1 0.000284 1560.000000 0.002132 -0.000353 0.004325 +13143 1 0.000205 1560.000000 0.001595 0.000962 0.005993 +13144 1 0.000234 1560.000000 0.000228 -0.000486 0.002337 +13145 1 0.000257 1560.000000 0.002599 0.001698 0.008723 +13146 1 0.000273 1560.000000 0.001633 0.002071 0.004875 +13147 1 0.000223 1560.000000 0.001568 -0.000740 0.002395 +13148 1 0.000200 1560.000000 -0.002395 -0.000836 0.007665 +13149 1 0.000220 1560.000000 -0.000814 0.003031 0.008478 +13150 1 0.000193 1560.000000 -0.003753 -0.000802 0.000606 +13151 1 0.000266 1560.000000 0.002226 -0.000078 0.001723 +13152 1 0.000239 1560.000000 0.001362 0.003098 0.000643 +13153 1 0.000249 1560.000000 -0.000204 0.001130 0.000135 +13154 1 0.000233 1560.000000 0.002097 0.002545 0.004689 +13155 1 0.000242 1560.000000 -0.000380 -0.003812 0.002210 +13156 1 0.000212 1560.000000 0.001835 -0.002522 0.005742 +13157 1 0.000208 1560.000000 -0.001155 -0.002801 0.003143 +13158 1 0.000269 1560.000000 0.001787 0.000219 0.005810 +13159 1 0.000247 1560.000000 -0.002391 0.002523 0.004190 +13160 1 0.000279 1560.000000 0.000423 0.003714 0.009232 +13161 1 0.000216 1560.000000 -0.000280 0.001750 0.000209 +13162 1 0.000206 1560.000000 -0.003535 -0.001197 0.007744 +13163 1 0.000200 1560.000000 0.003233 0.000792 0.001070 +13164 1 0.000212 1560.000000 0.001857 0.001966 0.005341 +13165 1 0.000248 1560.000000 0.003013 0.001019 0.007636 +13166 1 0.000209 1560.000000 -0.001535 -0.001652 0.005519 +13167 1 0.000213 1560.000000 -0.000103 -0.002962 0.004176 +13168 1 0.000195 1560.000000 0.002431 0.000605 0.005109 +13169 1 0.000241 1560.000000 0.001636 0.001657 0.006332 +13170 1 0.000234 1560.000000 -0.002647 0.002743 0.007639 +13171 1 0.000220 1560.000000 -0.000126 0.000743 0.002269 +13172 1 0.000205 1560.000000 0.000191 -0.002948 0.006603 +13173 1 0.000277 1560.000000 0.002665 0.001614 0.001122 +13174 1 0.000248 1560.000000 -0.000904 -0.001274 0.003227 +13175 1 0.000201 1560.000000 0.002874 0.000399 0.000387 +13176 1 0.000202 1560.000000 0.002421 0.000860 0.009732 +13177 1 0.000212 1560.000000 0.003026 0.000534 0.007604 +13178 1 0.000231 1560.000000 -0.002507 -0.002354 0.006779 +13179 1 0.000227 1560.000000 0.001618 -0.000454 0.001474 +13180 1 0.000201 1560.000000 -0.001692 0.001691 0.008961 +13181 1 0.000217 1560.000000 0.001921 -0.000714 0.001791 +13182 1 0.000207 1560.000000 -0.002033 0.002996 0.003700 +13183 1 0.000219 1560.000000 0.002459 -0.000134 0.007237 +13184 1 0.000200 1560.000000 -0.001827 0.001974 0.006451 +13185 1 0.000216 1560.000000 0.001500 0.002188 0.004126 +13186 1 0.000230 1560.000000 0.000642 -0.001071 0.009150 +13187 1 0.000218 1560.000000 -0.001502 0.002135 0.006998 +13188 1 0.000247 1560.000000 0.001284 0.000432 0.006090 +13189 1 0.000216 1560.000000 0.002473 -0.000987 0.006284 +13190 1 0.000202 1560.000000 -0.000931 -0.002301 0.001859 +13191 1 0.000210 1560.000000 -0.003723 0.000112 0.005391 +13192 1 0.000268 1560.000000 -0.000621 0.001933 0.003774 +13193 1 0.000196 1560.000000 -0.002495 -0.001740 0.001742 +13194 1 0.000267 1560.000000 0.001265 0.000474 0.007213 +13195 1 0.000276 1560.000000 -0.002993 -0.000965 0.008525 +13196 1 0.000250 1560.000000 0.002632 0.001509 0.002756 +13197 1 0.000278 1560.000000 0.002611 -0.000970 0.006065 +13198 1 0.000223 1560.000000 -0.001905 -0.001016 0.003336 +13199 1 0.000224 1560.000000 -0.003115 0.000286 0.005808 +13200 1 0.000221 1560.000000 -0.001228 0.002503 0.000661 +13201 1 0.000198 1560.000000 0.002582 0.002735 0.009367 +13202 1 0.000283 1560.000000 -0.000935 -0.001471 0.008440 +13203 1 0.000252 1560.000000 -0.003027 0.002011 0.009605 +13204 1 0.000229 1560.000000 -0.002041 0.002043 0.000225 +13205 1 0.000216 1560.000000 0.001308 0.003136 0.005957 +13206 1 0.000226 1560.000000 -0.000341 0.000920 0.004702 +13207 1 0.000232 1560.000000 0.002773 0.000803 0.000690 +13208 1 0.000216 1560.000000 -0.000746 -0.002943 0.002902 +13209 1 0.000237 1560.000000 -0.002755 -0.001257 0.006553 +13210 1 0.000196 1560.000000 0.003431 0.000698 0.009680 +13211 1 0.000215 1560.000000 0.003019 -0.002309 0.003730 +13212 1 0.000278 1560.000000 0.001424 0.000081 0.002316 +13213 1 0.000194 1560.000000 0.003446 0.000279 0.003878 +13214 1 0.000222 1560.000000 -0.000530 0.000006 0.007471 +13215 1 0.000229 1560.000000 -0.000949 0.003670 0.006828 +13216 1 0.000230 1560.000000 0.001355 -0.003571 0.001972 +13217 1 0.000243 1560.000000 -0.003461 -0.000122 0.004736 +13218 1 0.000232 1560.000000 -0.003405 0.000568 0.009130 +13219 1 0.000251 1560.000000 0.003313 -0.001324 0.006352 +13220 1 0.000261 1560.000000 0.000418 0.001737 0.001655 +13221 1 0.000193 1560.000000 -0.000099 -0.001358 0.008273 +13222 1 0.000224 1560.000000 -0.000775 0.001334 0.005301 +13223 1 0.000209 1560.000000 0.000404 0.000697 0.003613 +13224 1 0.000219 1560.000000 -0.002235 -0.000709 0.002610 +13225 1 0.000193 1560.000000 -0.000720 -0.001824 0.002361 +13226 1 0.000202 1560.000000 0.000186 0.002572 0.005921 +13227 1 0.000261 1560.000000 -0.002691 0.001471 0.008566 +13228 1 0.000203 1560.000000 -0.000546 0.003175 0.008741 +13229 1 0.000214 1560.000000 0.000067 0.002805 0.004018 +13230 1 0.000261 1560.000000 -0.001425 -0.002367 0.001822 +13231 1 0.000218 1560.000000 -0.001285 -0.001968 0.006070 +13232 1 0.000208 1560.000000 0.001456 0.003039 0.000355 +13233 1 0.000196 1560.000000 0.000054 -0.002552 0.001524 +13234 1 0.000258 1560.000000 -0.000438 0.002720 0.002630 +13235 1 0.000201 1560.000000 -0.000738 -0.000772 0.004182 +13236 1 0.000244 1560.000000 0.003338 -0.001917 0.005386 +13237 1 0.000231 1560.000000 0.001604 0.000119 0.003856 +13238 1 0.000243 1560.000000 -0.003736 -0.000852 0.006357 +13239 1 0.000280 1560.000000 0.002930 0.001664 0.006526 +13240 1 0.000242 1560.000000 0.000956 0.000611 0.000592 +13241 1 0.000223 1560.000000 0.001395 0.000029 0.001060 +13242 1 0.000193 1560.000000 -0.000576 -0.000836 0.001294 +13243 1 0.000261 1560.000000 0.003600 -0.001230 0.001095 +13244 1 0.000251 1560.000000 -0.000051 -0.002233 0.007584 +13245 1 0.000237 1560.000000 0.001374 -0.000207 0.007915 +13246 1 0.000219 1560.000000 -0.001943 0.001928 0.003132 +13247 1 0.000243 1560.000000 -0.000432 0.001180 0.006195 +13248 1 0.000279 1560.000000 -0.002085 -0.001982 0.002599 +13249 1 0.000286 1560.000000 0.002823 0.001607 0.009853 +13250 1 0.000258 1560.000000 -0.000609 -0.003094 0.002385 +13251 1 0.000219 1560.000000 -0.000467 -0.003569 0.006929 +13252 1 0.000272 1560.000000 -0.002213 -0.002126 0.005256 +13253 1 0.000261 1560.000000 -0.001156 -0.000528 0.008977 +13254 1 0.000227 1560.000000 0.001705 -0.001816 0.002428 +13255 1 0.000242 1560.000000 -0.002139 0.002669 0.001783 +13256 1 0.000218 1560.000000 -0.000653 -0.002512 0.008500 +13257 1 0.000197 1560.000000 0.000579 -0.002241 0.000850 +13258 1 0.000263 1560.000000 -0.002401 0.002967 0.005180 +13259 1 0.000228 1560.000000 0.000288 -0.002987 0.009250 +13260 1 0.000286 1560.000000 0.001687 -0.003373 0.006016 +13261 1 0.000265 1560.000000 -0.003447 0.001594 0.004854 +13262 1 0.000210 1560.000000 -0.002252 -0.000657 0.001126 +13263 1 0.000246 1560.000000 0.002973 -0.001656 0.000375 +13264 1 0.000214 1560.000000 0.001234 -0.002871 0.001408 +13265 1 0.000237 1560.000000 -0.001732 -0.002584 0.006679 +13266 1 0.000237 1560.000000 0.001247 0.001890 0.008861 +13267 1 0.000271 1560.000000 0.002868 0.001515 0.004252 +13268 1 0.000232 1560.000000 0.000223 0.000238 0.002341 +13269 1 0.000193 1560.000000 0.000752 -0.000156 0.004458 +13270 1 0.000274 1560.000000 -0.003755 -0.000842 0.005342 +13271 1 0.000247 1560.000000 -0.002821 0.000272 0.008209 +13272 1 0.000203 1560.000000 0.001001 0.002703 0.009562 +13273 1 0.000275 1560.000000 -0.000356 0.000896 0.007772 +13274 1 0.000227 1560.000000 0.002017 -0.002992 0.005630 +13275 1 0.000265 1560.000000 0.002563 -0.000274 0.007587 +13276 1 0.000201 1560.000000 0.001926 -0.001545 0.008206 +13277 1 0.000200 1560.000000 -0.000915 0.001276 0.005905 +13278 1 0.000198 1560.000000 -0.000038 -0.003085 0.006676 +13279 1 0.000210 1560.000000 -0.002900 -0.002254 0.005184 +13280 1 0.000202 1560.000000 -0.002149 0.002914 0.009333 +13281 1 0.000274 1560.000000 0.000767 0.002610 0.004732 +13282 1 0.000220 1560.000000 -0.003069 0.002250 0.006963 +13283 1 0.000227 1560.000000 0.003165 0.001806 0.001993 +13284 1 0.000221 1560.000000 -0.001508 0.002939 0.009411 +13285 1 0.000271 1560.000000 0.000978 0.002372 0.008598 +13286 1 0.000241 1560.000000 -0.000057 0.002958 0.003885 +13287 1 0.000246 1560.000000 -0.003603 -0.000110 0.007672 +13288 1 0.000194 1560.000000 0.000010 0.003803 0.004863 +13289 1 0.000232 1560.000000 0.002260 -0.001266 0.001446 +13290 1 0.000228 1560.000000 -0.001426 0.000445 0.004874 +13291 1 0.000235 1560.000000 -0.000498 0.000961 0.001841 +13292 1 0.000209 1560.000000 0.002473 -0.001868 0.004054 +13293 1 0.000259 1560.000000 -0.001050 -0.002702 0.009290 +13294 1 0.000286 1560.000000 -0.000140 0.002165 0.006515 +13295 1 0.000195 1560.000000 -0.001181 -0.002629 0.007262 +13296 1 0.000271 1560.000000 0.000139 0.002961 0.004418 +13297 1 0.000199 1560.000000 -0.003075 -0.000572 0.009204 +13298 1 0.000232 1560.000000 0.000609 0.002836 0.009685 +13299 1 0.000242 1560.000000 -0.003307 -0.001188 0.001462 +13300 1 0.000233 1560.000000 -0.002688 0.001437 0.003820 +13301 1 0.000210 1560.000000 -0.001516 -0.002683 0.008579 +13302 1 0.000194 1560.000000 0.001430 0.000626 0.005468 +13303 1 0.000280 1560.000000 -0.000034 -0.003153 0.008393 +13304 1 0.000207 1560.000000 0.002805 -0.001761 0.007904 +13305 1 0.000207 1560.000000 0.003044 -0.000616 0.007650 +13306 1 0.000248 1560.000000 0.000270 -0.002589 0.000253 +13307 1 0.000205 1560.000000 0.001944 -0.000725 0.000948 +13308 1 0.000204 1560.000000 -0.001253 0.002832 0.003570 +13309 1 0.000195 1560.000000 0.000003 0.002454 0.009687 +13310 1 0.000211 1560.000000 0.001789 0.003349 0.005603 +13311 1 0.000237 1560.000000 0.002873 0.001996 0.004801 +13312 1 0.000269 1560.000000 -0.002458 -0.002069 0.000607 +13313 1 0.000279 1560.000000 0.001271 -0.001488 0.007745 +13314 1 0.000265 1560.000000 -0.003515 -0.001488 0.006251 +13315 1 0.000218 1560.000000 -0.001975 -0.001503 0.004245 +13316 1 0.000204 1560.000000 0.001136 0.001114 0.003482 +13317 1 0.000286 1560.000000 -0.002937 0.000440 0.009024 +13318 1 0.000266 1560.000000 -0.001332 0.001144 0.008717 +13319 1 0.000280 1560.000000 0.001118 -0.000958 0.004979 +13320 1 0.000195 1560.000000 -0.003190 -0.001903 0.000132 +13321 1 0.000221 1560.000000 0.000458 -0.003382 0.005907 +13322 1 0.000203 1560.000000 -0.002549 0.001759 0.009809 +13323 1 0.000225 1560.000000 -0.001890 0.001701 0.005692 +13324 1 0.000241 1560.000000 -0.001576 0.000350 0.002250 +13325 1 0.000222 1560.000000 0.002398 -0.002606 0.003194 +13326 1 0.000259 1560.000000 0.002321 0.000900 0.005895 +13327 1 0.000215 1560.000000 0.001573 0.001241 0.000389 +13328 1 0.000212 1560.000000 0.001968 -0.002478 0.001884 +13329 1 0.000239 1560.000000 0.002593 -0.000548 0.000258 +13330 1 0.000221 1560.000000 0.000926 -0.001380 0.005959 +13331 1 0.000260 1560.000000 -0.002118 0.001072 0.004547 +13332 1 0.000272 1560.000000 -0.001058 -0.002497 0.009083 +13333 1 0.000285 1560.000000 0.002351 -0.002091 0.006552 +13334 1 0.000227 1560.000000 0.000415 0.001184 0.001760 +13335 1 0.000257 1560.000000 -0.001717 -0.003006 0.000565 +13336 1 0.000228 1560.000000 -0.003154 0.000246 0.001035 +13337 1 0.000223 1560.000000 0.000209 -0.001435 0.009658 +13338 1 0.000254 1560.000000 -0.002901 -0.001064 0.006349 +13339 1 0.000201 1560.000000 -0.001652 -0.000580 0.004341 +13340 1 0.000218 1560.000000 -0.000927 -0.000543 0.009540 +13341 1 0.000287 1560.000000 -0.002988 0.000859 0.003459 +13342 1 0.000237 1560.000000 -0.002213 -0.001022 0.002279 +13343 1 0.000286 1560.000000 0.000581 -0.001669 0.008841 +13344 1 0.000206 1560.000000 0.003028 -0.001703 0.006859 +13345 1 0.000252 1560.000000 -0.003082 -0.000692 0.006302 +13346 1 0.000203 1560.000000 0.002711 0.001530 0.009410 +13347 1 0.000192 1560.000000 0.001362 0.001851 0.009079 +13348 1 0.000199 1560.000000 0.003197 -0.001531 0.007878 +13349 1 0.000253 1560.000000 -0.002366 0.001894 0.001903 +13350 1 0.000206 1560.000000 -0.000633 0.002771 0.006445 +13351 1 0.000195 1560.000000 0.000643 0.001697 0.008429 +13352 1 0.000211 1560.000000 0.001603 -0.001063 0.002084 +13353 1 0.000202 1560.000000 -0.001008 0.001266 0.008833 +13354 1 0.000212 1560.000000 0.000753 -0.001238 0.007953 +13355 1 0.000248 1560.000000 -0.001643 0.000134 0.002848 +13356 1 0.000224 1560.000000 0.001560 -0.002365 0.008466 +13357 1 0.000222 1560.000000 0.000460 -0.003631 0.009489 +13358 1 0.000223 1560.000000 -0.000662 -0.003784 0.006472 +13359 1 0.000274 1560.000000 -0.000518 -0.002380 0.000237 +13360 1 0.000245 1560.000000 -0.003277 -0.001575 0.003863 +13361 1 0.000202 1560.000000 -0.000755 -0.002157 0.009785 +13362 1 0.000203 1560.000000 0.001679 0.002896 0.001750 +13363 1 0.000200 1560.000000 -0.000546 0.001214 0.007445 +13364 1 0.000226 1560.000000 -0.000629 0.001161 0.007732 +13365 1 0.000207 1560.000000 -0.001009 0.001169 0.002641 +13366 1 0.000205 1560.000000 0.001337 -0.000679 0.005376 +13367 1 0.000234 1560.000000 -0.000459 -0.001078 0.003109 +13368 1 0.000199 1560.000000 -0.001996 0.002533 0.000202 +13369 1 0.000283 1560.000000 -0.003346 -0.001597 0.009200 +13370 1 0.000214 1560.000000 0.002259 0.001213 0.006708 +13371 1 0.000215 1560.000000 -0.000081 0.002120 0.001201 +13372 1 0.000283 1560.000000 0.003819 0.000518 0.001215 +13373 1 0.000228 1560.000000 0.001305 -0.000852 0.001560 +13374 1 0.000262 1560.000000 0.003737 -0.000424 0.003473 +13375 1 0.000268 1560.000000 0.002479 -0.002893 0.005556 +13376 1 0.000202 1560.000000 -0.000777 0.003706 0.007354 +13377 1 0.000257 1560.000000 -0.003081 -0.002052 0.007058 +13378 1 0.000246 1560.000000 0.001299 -0.000717 0.002853 +13379 1 0.000278 1560.000000 0.003086 -0.000916 0.003479 +13380 1 0.000251 1560.000000 0.001298 0.000957 0.000816 +13381 1 0.000242 1560.000000 -0.002781 0.001190 0.001748 +13382 1 0.000225 1560.000000 0.000318 -0.002767 0.006550 +13383 1 0.000206 1560.000000 -0.000841 0.003174 0.008836 +13384 1 0.000210 1560.000000 0.000303 0.001177 0.004015 +13385 1 0.000196 1560.000000 -0.002272 0.000214 0.000947 +13386 1 0.000239 1560.000000 0.001053 -0.000088 0.008796 +13387 1 0.000232 1560.000000 -0.003707 -0.000406 0.008606 +13388 1 0.000226 1560.000000 0.001036 -0.001020 0.000907 +13389 1 0.000197 1560.000000 0.000690 0.003410 0.001819 +13390 1 0.000263 1560.000000 -0.002886 -0.001786 0.000137 +13391 1 0.000210 1560.000000 -0.001558 -0.001472 0.001828 +13392 1 0.000210 1560.000000 0.001955 0.002832 0.007510 +13393 1 0.000194 1560.000000 0.003771 -0.000568 0.004121 +13394 1 0.000199 1560.000000 0.003192 0.001758 0.008448 +13395 1 0.000245 1560.000000 -0.000518 0.003055 0.002913 +13396 1 0.000260 1560.000000 -0.001099 -0.003255 0.003085 +13397 1 0.000272 1560.000000 0.003762 -0.000690 0.002953 +13398 1 0.000210 1560.000000 -0.002854 -0.002329 0.008044 +13399 1 0.000215 1560.000000 -0.001338 -0.000046 0.008232 +13400 1 0.000204 1560.000000 0.000745 -0.002533 0.001354 +13401 1 0.000219 1560.000000 0.003283 0.000089 0.006845 +13402 1 0.000255 1560.000000 -0.002366 0.002477 0.009785 +13403 1 0.000280 1560.000000 -0.000713 0.000101 0.007103 +13404 1 0.000212 1560.000000 -0.003062 0.001452 0.008186 +13405 1 0.000231 1560.000000 -0.001852 -0.000134 0.003601 +13406 1 0.000210 1560.000000 0.002483 -0.000962 0.008043 +13407 1 0.000235 1560.000000 -0.000184 0.000751 0.006264 +13408 1 0.000216 1560.000000 0.000176 0.000561 0.009535 +13409 1 0.000213 1560.000000 -0.001554 0.002919 0.003651 +13410 1 0.000286 1560.000000 0.001371 0.000949 0.007113 +13411 1 0.000227 1560.000000 0.000084 -0.003768 0.007863 +13412 1 0.000231 1560.000000 -0.002569 -0.000592 0.007006 +13413 1 0.000248 1560.000000 0.003773 0.000731 0.001928 +13414 1 0.000206 1560.000000 -0.003365 -0.000028 0.005581 +13415 1 0.000252 1560.000000 -0.000768 0.001424 0.007314 +13416 1 0.000276 1560.000000 -0.002570 0.000797 0.003280 +13417 1 0.000214 1560.000000 -0.000925 -0.001313 0.003747 +13418 1 0.000216 1560.000000 0.001277 -0.003581 0.001620 +13419 1 0.000267 1560.000000 -0.000608 -0.002370 0.005368 +13420 1 0.000207 1560.000000 -0.001798 0.002037 0.002807 +13421 1 0.000222 1560.000000 -0.003214 -0.000001 0.007951 +13422 1 0.000257 1560.000000 0.003574 -0.000320 0.004009 +13423 1 0.000243 1560.000000 -0.002129 -0.001283 0.004445 +13424 1 0.000281 1560.000000 -0.001295 -0.001505 0.009844 +13425 1 0.000276 1560.000000 0.001055 0.000162 0.003764 +13426 1 0.000271 1560.000000 -0.002750 0.000311 0.005875 +13427 1 0.000252 1560.000000 -0.001151 0.001789 0.007368 +13428 1 0.000275 1560.000000 -0.003232 0.001806 0.001705 +13429 1 0.000233 1560.000000 0.000521 -0.000991 0.005251 +13430 1 0.000232 1560.000000 0.001827 -0.000972 0.008648 +13431 1 0.000238 1560.000000 -0.002801 0.000489 0.008023 +13432 1 0.000224 1560.000000 -0.000934 0.001378 0.007498 +13433 1 0.000196 1560.000000 0.000610 0.000554 0.002893 +13434 1 0.000233 1560.000000 -0.001099 0.001380 0.003373 +13435 1 0.000236 1560.000000 0.000724 -0.003596 0.009403 +13436 1 0.000193 1560.000000 0.000734 0.002507 0.008649 +13437 1 0.000272 1560.000000 -0.003043 -0.001157 0.002103 +13438 1 0.000195 1560.000000 -0.003599 0.000680 0.004095 +13439 1 0.000281 1560.000000 -0.001287 0.003084 0.003242 +13440 1 0.000211 1560.000000 -0.000574 -0.000579 0.005158 +13441 1 0.000227 1560.000000 0.002426 0.000176 0.003123 +13442 1 0.000227 1560.000000 -0.003169 0.001022 0.000397 +13443 1 0.000255 1560.000000 0.002294 -0.000556 0.003628 +13444 1 0.000256 1560.000000 0.002184 0.002647 0.005438 +13445 1 0.000221 1560.000000 -0.001282 -0.002788 0.001140 +13446 1 0.000226 1560.000000 0.001161 -0.000624 0.007620 +13447 1 0.000212 1560.000000 -0.000383 0.001869 0.005594 +13448 1 0.000200 1560.000000 0.000219 0.003258 0.002972 +13449 1 0.000214 1560.000000 -0.003029 0.001364 0.009733 +13450 1 0.000239 1560.000000 0.003423 -0.000864 0.006274 +13451 1 0.000285 1560.000000 0.002799 -0.000108 0.009232 +13452 1 0.000279 1560.000000 -0.002932 -0.002178 0.009784 +13453 1 0.000261 1560.000000 -0.002249 -0.000437 0.001932 +13454 1 0.000239 1560.000000 0.001465 0.002436 0.004931 +13455 1 0.000250 1560.000000 -0.001635 0.001022 0.008171 +13456 1 0.000239 1560.000000 0.001481 0.000758 0.006925 +13457 1 0.000204 1560.000000 -0.001583 -0.000834 0.009236 +13458 1 0.000253 1560.000000 -0.002417 -0.001189 0.008584 +13459 1 0.000277 1560.000000 -0.002287 0.000390 0.002748 +13460 1 0.000259 1560.000000 0.002015 -0.000978 0.003025 +13461 1 0.000258 1560.000000 -0.001598 0.002978 0.009659 +13462 1 0.000228 1560.000000 -0.003718 0.000510 0.004311 +13463 1 0.000242 1560.000000 0.002625 0.002502 0.008241 +13464 1 0.000262 1560.000000 -0.000319 -0.001957 0.004435 +13465 1 0.000261 1560.000000 -0.003461 0.000361 0.002081 +13466 1 0.000255 1560.000000 0.002627 -0.001600 0.006280 +13467 1 0.000207 1560.000000 0.001234 0.000628 0.000253 +13468 1 0.000275 1560.000000 -0.001762 0.003334 0.001244 +13469 1 0.000252 1560.000000 0.003518 -0.001494 0.001520 +13470 1 0.000239 1560.000000 0.002574 0.002303 0.002331 +13471 1 0.000203 1560.000000 -0.000125 0.002222 0.005070 +13472 1 0.000200 1560.000000 0.001122 -0.000157 0.000601 +13473 1 0.000203 1560.000000 -0.000688 -0.000941 0.005371 +13474 1 0.000211 1560.000000 -0.001921 0.003336 0.000530 +13475 1 0.000216 1560.000000 -0.001462 -0.001194 0.007921 +13476 1 0.000227 1560.000000 -0.001037 -0.003188 0.003586 +13477 1 0.000220 1560.000000 0.000545 0.001419 0.002244 +13478 1 0.000282 1560.000000 -0.000973 0.001966 0.002130 +13479 1 0.000198 1560.000000 0.003463 0.000422 0.009794 +13480 1 0.000255 1560.000000 0.000232 0.002401 0.000797 +13481 1 0.000249 1560.000000 0.000657 -0.003625 0.008181 +13482 1 0.000229 1560.000000 0.001862 -0.000305 0.006555 +13483 1 0.000193 1560.000000 0.002959 0.001199 0.006884 +13484 1 0.000240 1560.000000 -0.001373 0.000878 0.007664 +13485 1 0.000252 1560.000000 0.001337 -0.000050 0.007333 +13486 1 0.000218 1560.000000 0.002856 0.002515 0.007608 +13487 1 0.000207 1560.000000 -0.001700 0.001301 0.007760 +13488 1 0.000229 1560.000000 0.000103 -0.002902 0.000455 +13489 1 0.000247 1560.000000 -0.002147 0.001962 0.004852 +13490 1 0.000227 1560.000000 0.001389 -0.000607 0.001574 +13491 1 0.000211 1560.000000 0.001144 0.001108 0.009784 +13492 1 0.000208 1560.000000 -0.003040 0.001763 0.008479 +13493 1 0.000231 1560.000000 0.002515 -0.000623 0.005879 +13494 1 0.000208 1560.000000 -0.001630 0.000740 0.005074 +13495 1 0.000242 1560.000000 -0.000299 -0.000135 0.003080 +13496 1 0.000211 1560.000000 0.001352 0.001435 0.002152 +13497 1 0.000217 1560.000000 -0.002882 0.000145 0.007064 +13498 1 0.000230 1560.000000 -0.000654 -0.001150 0.004724 +13499 1 0.000198 1560.000000 -0.001960 -0.000216 0.004791 +13500 1 0.000228 1560.000000 0.003341 0.001027 0.002085 +13501 1 0.000217 1560.000000 -0.000230 0.001712 0.004070 +13502 1 0.000217 1560.000000 -0.000835 -0.002635 0.004227 +13503 1 0.000211 1560.000000 -0.003356 -0.000037 0.008154 +13504 1 0.000199 1560.000000 -0.000636 -0.003344 0.002086 +13505 1 0.000230 1560.000000 -0.000098 0.000751 0.003260 +13506 1 0.000218 1560.000000 0.002836 -0.002608 0.009630 +13507 1 0.000273 1560.000000 -0.003063 0.000007 0.008229 +13508 1 0.000195 1560.000000 0.002365 -0.000088 0.003156 +13509 1 0.000196 1560.000000 0.002595 -0.002706 0.000181 +13510 1 0.000236 1560.000000 -0.000812 -0.000927 0.002060 +13511 1 0.000196 1560.000000 -0.002031 -0.000360 0.003308 +13512 1 0.000209 1560.000000 0.002390 0.002140 0.008548 +13513 1 0.000193 1560.000000 -0.002301 -0.003091 0.005338 +13514 1 0.000226 1560.000000 0.001061 -0.002160 0.002315 +13515 1 0.000230 1560.000000 -0.000339 0.002459 0.004306 +13516 1 0.000219 1560.000000 -0.001198 0.003254 0.006726 +13517 1 0.000194 1560.000000 0.000380 -0.002237 0.002511 +13518 1 0.000218 1560.000000 0.000933 0.001680 0.008127 +13519 1 0.000273 1560.000000 -0.003639 -0.000443 0.006605 +13520 1 0.000194 1560.000000 -0.001035 0.000875 0.006080 +13521 1 0.000202 1560.000000 -0.000170 -0.002192 0.009230 +13522 1 0.000224 1560.000000 0.002070 0.000092 0.000337 +13523 1 0.000274 1560.000000 0.000928 -0.001423 0.002990 +13524 1 0.000248 1560.000000 -0.002882 0.002044 0.002098 +13525 1 0.000253 1560.000000 -0.000411 0.003031 0.000840 +13526 1 0.000204 1560.000000 0.001923 0.001755 0.005223 +13527 1 0.000275 1560.000000 -0.003051 -0.002171 0.001210 +13528 1 0.000193 1560.000000 0.002277 -0.002362 0.002088 +13529 1 0.000281 1560.000000 -0.003817 0.000347 0.004057 +13530 1 0.000288 1560.000000 -0.002469 0.002542 0.000238 +13531 1 0.000205 1560.000000 -0.002269 0.003054 0.001096 +13532 1 0.000193 1560.000000 -0.002834 0.001618 0.005717 +13533 1 0.000241 1560.000000 -0.001210 0.002115 0.009105 +13534 1 0.000211 1560.000000 0.000011 0.003261 0.003347 +13535 1 0.000218 1560.000000 0.001654 0.001234 0.005722 +13536 1 0.000265 1560.000000 0.002215 -0.002312 0.002459 +13537 1 0.000246 1560.000000 -0.000920 0.003239 0.001131 +13538 1 0.000202 1560.000000 -0.002457 0.001994 0.005388 +13539 1 0.000217 1560.000000 0.001590 0.001554 0.004887 +13540 1 0.000195 1560.000000 0.002505 0.002611 0.001015 +13541 1 0.000194 1560.000000 -0.002541 0.001284 0.004707 +13542 1 0.000198 1560.000000 0.001705 0.000543 0.004003 +13543 1 0.000265 1560.000000 0.000077 -0.001132 0.002482 +13544 1 0.000207 1560.000000 -0.000709 0.002326 0.007881 +13545 1 0.000193 1560.000000 -0.001547 0.001761 0.005130 +13546 1 0.000269 1560.000000 -0.003668 -0.001003 0.004500 +13547 1 0.000240 1560.000000 -0.001131 0.003197 0.005080 +13548 1 0.000201 1560.000000 0.002617 -0.002663 0.004248 +13549 1 0.000273 1560.000000 0.002671 0.000589 0.003236 +13550 1 0.000259 1560.000000 -0.001917 0.000908 0.009169 +13551 1 0.000221 1560.000000 0.000824 0.001406 0.005660 +13552 1 0.000235 1560.000000 -0.000572 -0.001207 0.007871 +13553 1 0.000197 1560.000000 0.001156 -0.001175 0.002731 +13554 1 0.000260 1560.000000 0.002159 -0.001225 0.003028 +13555 1 0.000246 1560.000000 0.003620 -0.000428 0.006535 +13556 1 0.000226 1560.000000 -0.000319 -0.001706 0.007184 +13557 1 0.000214 1560.000000 -0.000104 0.003851 0.005294 +13558 1 0.000215 1560.000000 -0.001745 0.000616 0.007323 +13559 1 0.000246 1560.000000 0.002910 -0.001294 0.000501 +13560 1 0.000227 1560.000000 0.001332 -0.001574 0.002653 +13561 1 0.000264 1560.000000 -0.001438 -0.002460 0.002564 +13562 1 0.000198 1560.000000 -0.002533 -0.001345 0.004754 +13563 1 0.000221 1560.000000 -0.001893 0.002951 0.009542 +13564 1 0.000263 1560.000000 0.001515 -0.002215 0.004352 +13565 1 0.000193 1560.000000 0.003447 0.001483 0.007865 +13566 1 0.000262 1560.000000 0.002135 -0.002951 0.004460 +13567 1 0.000224 1560.000000 -0.001573 0.002607 0.005456 +13568 1 0.000235 1560.000000 0.000046 0.001165 0.005306 +13569 1 0.000262 1560.000000 -0.002731 0.001030 0.008157 +13570 1 0.000212 1560.000000 -0.002898 -0.002294 0.000483 +13571 1 0.000260 1560.000000 -0.002593 0.000965 0.007047 +13572 1 0.000215 1560.000000 -0.002362 -0.001077 0.006557 +13573 1 0.000247 1560.000000 0.001898 -0.001367 0.006607 +13574 1 0.000206 1560.000000 -0.000182 0.002947 0.004439 +13575 1 0.000199 1560.000000 0.002633 -0.000556 0.009034 +13576 1 0.000218 1560.000000 -0.000445 0.003263 0.003404 +13577 1 0.000218 1560.000000 -0.001585 0.003405 0.007493 +13578 1 0.000276 1560.000000 0.001061 0.001427 0.007480 +13579 1 0.000271 1560.000000 0.001015 0.003699 0.008582 +13580 1 0.000201 1560.000000 0.002109 0.002853 0.004647 +13581 1 0.000277 1560.000000 -0.001757 -0.003191 0.002660 +13582 1 0.000196 1560.000000 0.000695 0.003178 0.009474 +13583 1 0.000194 1560.000000 0.000913 -0.001773 0.006865 +13584 1 0.000283 1560.000000 -0.002453 0.000634 0.003753 +13585 1 0.000232 1560.000000 -0.002388 -0.003010 0.006634 +13586 1 0.000209 1560.000000 0.002254 0.001647 0.007896 +13587 1 0.000263 1560.000000 -0.000946 0.001664 0.008433 +13588 1 0.000227 1560.000000 -0.000048 -0.003551 0.009585 +13589 1 0.000220 1560.000000 -0.000377 0.002374 0.007320 +13590 1 0.000236 1560.000000 0.002352 0.000804 0.001132 +13591 1 0.000247 1560.000000 0.001743 0.003309 0.000804 +13592 1 0.000271 1560.000000 -0.001321 0.003208 0.007070 +13593 1 0.000272 1560.000000 -0.002720 -0.001891 0.008005 +13594 1 0.000201 1560.000000 -0.001381 0.000225 0.006850 +13595 1 0.000248 1560.000000 -0.003428 -0.001752 0.007704 +13596 1 0.000226 1560.000000 0.003576 0.000511 0.006817 +13597 1 0.000234 1560.000000 0.000424 0.002350 0.008262 +13598 1 0.000236 1560.000000 0.000160 0.001092 0.007408 +13599 1 0.000243 1560.000000 -0.001184 0.002530 0.000165 +13600 1 0.000285 1560.000000 0.002692 -0.002190 0.005395 +13601 1 0.000259 1560.000000 0.003582 0.001241 0.005486 +13602 1 0.000197 1560.000000 -0.001640 -0.001961 0.002422 +13603 1 0.000252 1560.000000 0.002372 0.001300 0.009775 +13604 1 0.000249 1560.000000 -0.000572 0.003262 0.006637 +13605 1 0.000256 1560.000000 0.003811 -0.000515 0.004705 +13606 1 0.000235 1560.000000 -0.001290 -0.001974 0.006801 +13607 1 0.000221 1560.000000 0.000636 -0.000966 0.000232 +13608 1 0.000211 1560.000000 0.000301 0.003310 0.004201 +13609 1 0.000226 1560.000000 -0.001990 -0.001766 0.008099 +13610 1 0.000205 1560.000000 0.003074 -0.000010 0.006573 +13611 1 0.000237 1560.000000 0.001431 -0.001056 0.003184 +13612 1 0.000240 1560.000000 -0.001892 0.002283 0.006101 +13613 1 0.000219 1560.000000 -0.000483 -0.002018 0.000973 +13614 1 0.000202 1560.000000 0.001686 -0.000640 0.009041 +13615 1 0.000283 1560.000000 0.001165 -0.002256 0.005709 +13616 1 0.000216 1560.000000 -0.002062 -0.003248 0.004302 +13617 1 0.000206 1560.000000 -0.000188 -0.000910 0.009688 +13618 1 0.000208 1560.000000 -0.001668 0.000169 0.008981 +13619 1 0.000277 1560.000000 0.002916 0.000036 0.009839 +13620 1 0.000197 1560.000000 -0.000143 -0.000890 0.001668 +13621 1 0.000202 1560.000000 -0.002090 0.001824 0.001434 +13622 1 0.000242 1560.000000 0.000423 0.001127 0.006499 +13623 1 0.000247 1560.000000 0.002171 -0.000806 0.001692 +13624 1 0.000210 1560.000000 -0.001276 0.000673 0.006641 +13625 1 0.000273 1560.000000 0.000511 -0.003346 0.006669 +13626 1 0.000232 1560.000000 0.001140 0.002727 0.005243 +13627 1 0.000200 1560.000000 -0.001933 -0.001873 0.000372 +13628 1 0.000201 1560.000000 0.000335 -0.003822 0.008458 +13629 1 0.000199 1560.000000 -0.001136 0.003602 0.007275 +13630 1 0.000223 1560.000000 -0.001211 -0.002577 0.000678 +13631 1 0.000237 1560.000000 0.000098 -0.003148 0.000574 +13632 1 0.000198 1560.000000 -0.001137 0.000487 0.008338 +13633 1 0.000200 1560.000000 -0.001005 0.001447 0.006034 +13634 1 0.000216 1560.000000 0.002712 0.001992 0.006002 +13635 1 0.000271 1560.000000 -0.001931 0.002480 0.005038 +13636 1 0.000210 1560.000000 0.001874 0.003264 0.007512 +13637 1 0.000272 1560.000000 0.000392 0.002588 0.008777 +13638 1 0.000218 1560.000000 0.002408 -0.002973 0.001601 +13639 1 0.000208 1560.000000 0.001994 0.002776 0.007839 +13640 1 0.000208 1560.000000 -0.001116 0.001308 0.001845 +13641 1 0.000252 1560.000000 0.002700 -0.002702 0.003237 +13642 1 0.000220 1560.000000 0.002335 0.002911 0.005573 +13643 1 0.000220 1560.000000 -0.002487 0.000878 0.006517 +13644 1 0.000250 1560.000000 0.000730 0.001806 0.009492 +13645 1 0.000213 1560.000000 -0.000177 -0.003805 0.002925 +13646 1 0.000200 1560.000000 0.002173 -0.002043 0.003237 +13647 1 0.000230 1560.000000 -0.001264 -0.003589 0.004685 +13648 1 0.000264 1560.000000 0.003240 0.001946 0.000526 +13649 1 0.000216 1560.000000 -0.000318 -0.003382 0.009494 +13650 1 0.000276 1560.000000 -0.001540 0.000214 0.000178 +13651 1 0.000239 1560.000000 -0.002604 -0.001947 0.006389 +13652 1 0.000241 1560.000000 0.000498 0.001982 0.003947 +13653 1 0.000271 1560.000000 -0.003651 0.000766 0.008824 +13654 1 0.000267 1560.000000 0.001226 0.003417 0.004945 +13655 1 0.000216 1560.000000 0.001679 0.002286 0.005115 +13656 1 0.000193 1560.000000 0.000487 0.002048 0.000828 +13657 1 0.000278 1560.000000 0.001862 0.000122 0.001135 +13658 1 0.000234 1560.000000 0.001390 -0.003541 0.007211 +13659 1 0.000194 1560.000000 0.002071 -0.002464 0.007112 +13660 1 0.000228 1560.000000 0.002398 0.002189 0.009325 +13661 1 0.000211 1560.000000 -0.001997 0.000941 0.007196 +13662 1 0.000231 1560.000000 -0.000125 -0.000429 0.000754 +13663 1 0.000264 1560.000000 0.002027 0.001554 0.006279 +13664 1 0.000233 1560.000000 0.003388 -0.000483 0.000898 +13665 1 0.000250 1560.000000 0.003581 0.001357 0.001474 +13666 1 0.000193 1560.000000 -0.000681 0.002576 0.006827 +13667 1 0.000228 1560.000000 -0.000673 -0.002876 0.006208 +13668 1 0.000243 1560.000000 -0.000656 -0.000362 0.007786 +13669 1 0.000200 1560.000000 0.001220 0.000606 0.001297 +13670 1 0.000201 1560.000000 -0.002663 -0.000758 0.004440 +13671 1 0.000270 1560.000000 -0.003066 -0.000989 0.009306 +13672 1 0.000206 1560.000000 -0.002071 0.000711 0.000275 +13673 1 0.000215 1560.000000 -0.003834 0.000174 0.006268 +13674 1 0.000212 1560.000000 -0.002403 0.002434 0.005259 +13675 1 0.000233 1560.000000 -0.002262 -0.001616 0.000587 +13676 1 0.000212 1560.000000 -0.000825 -0.003396 0.000915 +13677 1 0.000238 1560.000000 0.000712 -0.003129 0.007692 +13678 1 0.000205 1560.000000 -0.003618 0.000603 0.000189 +13679 1 0.000196 1560.000000 -0.001738 -0.000890 0.002822 +13680 1 0.000214 1560.000000 -0.000195 0.003083 0.006386 +13681 1 0.000274 1560.000000 -0.001048 0.002489 0.006219 +13682 1 0.000278 1560.000000 -0.000892 0.000288 0.003655 +13683 1 0.000198 1560.000000 0.002364 0.000096 0.000439 +13684 1 0.000259 1560.000000 -0.002246 -0.001004 0.000730 +13685 1 0.000216 1560.000000 -0.000611 0.003538 0.007955 +13686 1 0.000203 1560.000000 0.000980 0.000764 0.002008 +13687 1 0.000280 1560.000000 -0.001021 0.001506 0.002822 +13688 1 0.000193 1560.000000 0.002589 -0.002246 0.002749 +13689 1 0.000244 1560.000000 0.000466 0.001086 0.009567 +13690 1 0.000227 1560.000000 -0.001753 0.000957 0.004110 +13691 1 0.000210 1560.000000 -0.002984 0.001681 0.003578 +13692 1 0.000259 1560.000000 -0.000621 -0.003148 0.006266 +13693 1 0.000240 1560.000000 0.000009 -0.001640 0.000265 +13694 1 0.000247 1560.000000 -0.001277 0.000722 0.000758 +13695 1 0.000277 1560.000000 -0.002247 -0.002444 0.009700 +13696 1 0.000244 1560.000000 -0.001334 -0.003381 0.006302 +13697 1 0.000251 1560.000000 0.000376 -0.001610 0.001510 +13698 1 0.000234 1560.000000 0.001912 0.000437 0.003847 +13699 1 0.000196 1560.000000 0.000893 0.002372 0.003027 +13700 1 0.000276 1560.000000 -0.001074 -0.002704 0.007053 +13701 1 0.000226 1560.000000 0.000557 -0.003406 0.000124 +13702 1 0.000252 1560.000000 0.001321 -0.003254 0.005148 +13703 1 0.000202 1560.000000 -0.002457 0.001810 0.006767 +13704 1 0.000244 1560.000000 0.002903 -0.001009 0.000208 +13705 1 0.000205 1560.000000 0.002901 0.001866 0.002175 +13706 1 0.000260 1560.000000 -0.000977 0.000654 0.009400 +13707 1 0.000271 1560.000000 -0.001052 -0.001204 0.004073 +13708 1 0.000196 1560.000000 0.002192 0.001617 0.002839 +13709 1 0.000249 1560.000000 0.003216 -0.000903 0.003141 +13710 1 0.000219 1560.000000 0.002276 -0.002390 0.006366 +13711 1 0.000276 1560.000000 -0.002833 0.001182 0.007308 +13712 1 0.000239 1560.000000 0.003612 0.000009 0.005010 +13713 1 0.000225 1560.000000 0.000261 -0.003617 0.007398 +13714 1 0.000235 1560.000000 0.002605 -0.001855 0.009047 +13715 1 0.000230 1560.000000 -0.001766 -0.000496 0.002071 +13716 1 0.000194 1560.000000 -0.000880 0.001343 0.008140 +13717 1 0.000228 1560.000000 0.002426 0.000163 0.002699 +13718 1 0.000243 1560.000000 -0.001894 -0.002542 0.008927 +13719 1 0.000197 1560.000000 -0.001798 0.002791 0.005739 +13720 1 0.000209 1560.000000 0.000510 0.003765 0.004886 +13721 1 0.000205 1560.000000 -0.000490 0.000936 0.001608 +13722 1 0.000227 1560.000000 -0.001482 -0.001329 0.002047 +13723 1 0.000226 1560.000000 0.000564 -0.001098 0.002662 +13724 1 0.000209 1560.000000 0.002088 -0.003163 0.008987 +13725 1 0.000197 1560.000000 0.000912 -0.002504 0.009682 +13726 1 0.000232 1560.000000 -0.003144 -0.000544 0.003958 +13727 1 0.000215 1560.000000 0.001482 0.000674 0.004882 +13728 1 0.000234 1560.000000 -0.001885 -0.001745 0.003415 +13729 1 0.000282 1560.000000 0.003537 0.001175 0.008497 +13730 1 0.000194 1560.000000 0.001758 -0.003322 0.002332 +13731 1 0.000236 1560.000000 0.003603 -0.000755 0.006494 +13732 1 0.000210 1560.000000 -0.002561 0.002834 0.003544 +13733 1 0.000199 1560.000000 0.001536 -0.003351 0.004909 +13734 1 0.000256 1560.000000 0.000526 0.002566 0.001433 +13735 1 0.000208 1560.000000 0.001790 -0.000834 0.003799 +13736 1 0.000224 1560.000000 0.002797 0.002490 0.008743 +13737 1 0.000239 1560.000000 0.001065 0.003420 0.002920 +13738 1 0.000259 1560.000000 0.000040 -0.003311 0.001993 +13739 1 0.000249 1560.000000 0.001793 -0.002986 0.001961 +13740 1 0.000224 1560.000000 -0.003538 0.000920 0.002931 +13741 1 0.000230 1560.000000 0.003403 -0.000441 0.001501 +13742 1 0.000203 1560.000000 -0.000452 0.002059 0.008683 +13743 1 0.000245 1560.000000 -0.003771 -0.000779 0.007692 +13744 1 0.000223 1560.000000 0.003810 0.000027 0.004707 +13745 1 0.000246 1560.000000 0.002171 0.003127 0.007189 +13746 1 0.000251 1560.000000 0.003674 -0.001118 0.000432 +13747 1 0.000193 1560.000000 0.000820 -0.003202 0.007045 +13748 1 0.000273 1560.000000 0.000435 0.001752 0.004251 +13749 1 0.000277 1560.000000 0.003578 -0.001299 0.006130 +13750 1 0.000209 1560.000000 0.000913 0.001715 0.003672 +13751 1 0.000241 1560.000000 0.001875 -0.000519 0.001139 +13752 1 0.000234 1560.000000 -0.002268 0.000451 0.000151 +13753 1 0.000243 1560.000000 0.000103 0.003727 0.002585 +13754 1 0.000229 1560.000000 0.000011 0.002849 0.007989 +13755 1 0.000203 1560.000000 0.000728 -0.003383 0.009779 +13756 1 0.000193 1560.000000 0.002656 0.002430 0.009522 +13757 1 0.000244 1560.000000 -0.003062 -0.000180 0.001926 +13758 1 0.000198 1560.000000 -0.000439 -0.001458 0.006739 +13759 1 0.000286 1560.000000 0.001816 -0.001587 0.005174 +13760 1 0.000223 1560.000000 -0.003259 -0.001863 0.007017 +13761 1 0.000205 1560.000000 -0.002007 -0.000622 0.006856 +13762 1 0.000243 1560.000000 -0.000310 -0.002752 0.005745 +13763 1 0.000225 1560.000000 -0.002083 0.003182 0.007398 +13764 1 0.000286 1560.000000 -0.003330 -0.001661 0.007285 +13765 1 0.000202 1560.000000 0.001638 -0.001283 0.007828 +13766 1 0.000281 1560.000000 -0.001723 0.003378 0.006373 +13767 1 0.000219 1560.000000 0.002182 -0.002406 0.009503 +13768 1 0.000256 1560.000000 0.001849 0.002771 0.008455 +13769 1 0.000199 1560.000000 -0.002705 -0.000810 0.004191 +13770 1 0.000200 1560.000000 0.001899 -0.000739 0.000137 +13771 1 0.000220 1560.000000 0.002370 0.003021 0.008379 +13772 1 0.000208 1560.000000 0.002921 0.000621 0.008009 +13773 1 0.000201 1560.000000 -0.003020 -0.001048 0.003759 +13774 1 0.000247 1560.000000 0.001915 -0.002809 0.001823 +13775 1 0.000194 1560.000000 -0.002099 -0.000857 0.000921 +13776 1 0.000204 1560.000000 0.002741 -0.001417 0.002202 +13777 1 0.000203 1560.000000 0.001299 -0.002085 0.003740 +13778 1 0.000210 1560.000000 0.002163 0.001324 0.005530 +13779 1 0.000246 1560.000000 -0.003139 0.002088 0.001904 +13780 1 0.000243 1560.000000 -0.003266 -0.001807 0.005293 +13781 1 0.000202 1560.000000 -0.002812 -0.000066 0.008954 +13782 1 0.000213 1560.000000 -0.002467 -0.002952 0.001450 +13783 1 0.000210 1560.000000 0.000222 -0.000071 0.005314 +13784 1 0.000213 1560.000000 0.002828 -0.001909 0.000188 +13785 1 0.000205 1560.000000 0.003799 -0.000340 0.006958 +13786 1 0.000232 1560.000000 0.000595 -0.003338 0.000733 +13787 1 0.000197 1560.000000 -0.003052 -0.000074 0.006458 +13788 1 0.000212 1560.000000 0.002158 0.001659 0.003588 +13789 1 0.000195 1560.000000 -0.000400 0.002301 0.004549 +13790 1 0.000269 1560.000000 0.000733 0.001744 0.000397 +13791 1 0.000245 1560.000000 0.000630 0.003693 0.000184 +13792 1 0.000250 1560.000000 -0.000074 -0.000585 0.004060 +13793 1 0.000242 1560.000000 0.001085 0.002595 0.009815 +13794 1 0.000256 1560.000000 0.001624 0.002783 0.002862 +13795 1 0.000262 1560.000000 -0.000458 -0.003801 0.001030 +13796 1 0.000208 1560.000000 -0.001367 -0.001207 0.004225 +13797 1 0.000254 1560.000000 -0.002560 -0.002095 0.005271 +13798 1 0.000193 1560.000000 -0.000264 -0.003552 0.004172 +13799 1 0.000278 1560.000000 0.000369 -0.003727 0.007692 +13800 1 0.000238 1560.000000 0.002771 0.000344 0.006574 +13801 1 0.000230 1560.000000 -0.002268 -0.002479 0.004531 +13802 1 0.000219 1560.000000 0.000053 0.001428 0.001553 +13803 1 0.000281 1560.000000 -0.002253 0.002475 0.005469 +13804 1 0.000205 1560.000000 0.001244 0.000329 0.002716 +13805 1 0.000212 1560.000000 -0.002574 0.000696 0.009789 +13806 1 0.000200 1560.000000 0.000334 0.000866 0.009620 +13807 1 0.000205 1560.000000 0.002914 -0.002049 0.005601 +13808 1 0.000196 1560.000000 -0.001262 -0.000557 0.001730 +13809 1 0.000271 1560.000000 -0.001811 0.002257 0.001986 +13810 1 0.000288 1560.000000 0.000194 0.002595 0.002159 +13811 1 0.000214 1560.000000 -0.001106 -0.001413 0.002212 +13812 1 0.000262 1560.000000 -0.001017 -0.003637 0.000702 +13813 1 0.000233 1560.000000 0.002758 0.002670 0.008111 +13814 1 0.000198 1560.000000 0.001404 0.002430 0.006158 +13815 1 0.000244 1560.000000 0.001910 -0.001154 0.003865 +13816 1 0.000245 1560.000000 0.000895 -0.003578 0.008490 +13817 1 0.000257 1560.000000 0.000086 0.003220 0.009443 +13818 1 0.000197 1560.000000 0.001965 0.002399 0.006769 +13819 1 0.000251 1560.000000 -0.000677 -0.003279 0.002925 +13820 1 0.000272 1560.000000 -0.000383 -0.002346 0.000981 +13821 1 0.000263 1560.000000 -0.001961 -0.000851 0.001193 +13822 1 0.000211 1560.000000 -0.000518 -0.001529 0.006294 +13823 1 0.000260 1560.000000 -0.000474 -0.003753 0.003462 +13824 1 0.000241 1560.000000 -0.000310 -0.002770 0.004700 +13825 1 0.000205 1560.000000 0.002161 0.000998 0.001550 +13826 1 0.000235 1560.000000 -0.003638 -0.000207 0.009827 +13827 1 0.000230 1560.000000 0.002420 -0.000795 0.002370 +13828 1 0.000211 1560.000000 -0.000923 0.002662 0.003891 +13829 1 0.000199 1560.000000 0.001170 -0.000117 0.007744 +13830 1 0.000232 1560.000000 -0.000002 0.001478 0.002283 +13831 1 0.000234 1560.000000 -0.000693 0.000918 0.009530 +13832 1 0.000220 1560.000000 0.001447 -0.000799 0.002173 +13833 1 0.000226 1560.000000 0.000321 0.003771 0.006098 +13834 1 0.000207 1560.000000 -0.002576 -0.002586 0.003650 +13835 1 0.000241 1560.000000 0.002200 -0.001776 0.002641 +13836 1 0.000212 1560.000000 0.000048 0.003839 0.007947 +13837 1 0.000256 1560.000000 -0.002053 -0.001306 0.002803 +13838 1 0.000217 1560.000000 -0.003175 -0.001446 0.007587 +13839 1 0.000201 1560.000000 0.002637 0.000692 0.009261 +13840 1 0.000215 1560.000000 -0.000578 -0.000059 0.008681 +13841 1 0.000213 1560.000000 -0.001986 -0.001790 0.002164 +13842 1 0.000210 1560.000000 -0.003307 0.000141 0.007093 +13843 1 0.000195 1560.000000 0.003220 0.000029 0.002150 +13844 1 0.000254 1560.000000 -0.000477 0.002403 0.009166 +13845 1 0.000249 1560.000000 -0.001630 0.000510 0.002590 +13846 1 0.000226 1560.000000 0.003072 0.000131 0.009271 +13847 1 0.000203 1560.000000 -0.003663 0.000604 0.009394 +13848 1 0.000230 1560.000000 0.001957 -0.000027 0.007958 +13849 1 0.000205 1560.000000 -0.001132 0.003620 0.009010 +13850 1 0.000227 1560.000000 0.000861 -0.001221 0.002849 +13851 1 0.000248 1560.000000 -0.001032 0.003530 0.003184 +13852 1 0.000211 1560.000000 -0.002704 -0.000095 0.000215 +13853 1 0.000207 1560.000000 0.002120 0.001718 0.001704 +13854 1 0.000207 1560.000000 -0.000332 -0.000165 0.004891 +13855 1 0.000231 1560.000000 0.002061 0.001150 0.002259 +13856 1 0.000265 1560.000000 -0.001035 0.003660 0.007887 +13857 1 0.000199 1560.000000 -0.002440 0.001772 0.006042 +13858 1 0.000272 1560.000000 -0.002386 0.000124 0.009560 +13859 1 0.000219 1560.000000 0.001990 0.003098 0.003831 +13860 1 0.000222 1560.000000 -0.003620 -0.000676 0.003815 +13861 1 0.000241 1560.000000 0.001665 0.002229 0.006739 +13862 1 0.000202 1560.000000 0.002634 -0.000108 0.006067 +13863 1 0.000287 1560.000000 0.000106 0.003839 0.003150 +13864 1 0.000222 1560.000000 -0.001141 0.000077 0.001200 +13865 1 0.000240 1560.000000 0.001733 -0.002242 0.005704 +13866 1 0.000204 1560.000000 0.000857 0.001771 0.006754 +13867 1 0.000212 1560.000000 -0.003736 -0.000814 0.005035 +13868 1 0.000275 1560.000000 0.002235 0.000719 0.004749 +13869 1 0.000211 1560.000000 0.001313 -0.000093 0.004298 +13870 1 0.000245 1560.000000 0.000660 -0.001215 0.005604 +13871 1 0.000246 1560.000000 -0.000385 -0.003598 0.006250 +13872 1 0.000215 1560.000000 0.002394 0.000548 0.008451 +13873 1 0.000233 1560.000000 -0.002430 -0.000450 0.000951 +13874 1 0.000217 1560.000000 0.000679 -0.001354 0.005795 +13875 1 0.000264 1560.000000 -0.001289 0.003081 0.003588 +13876 1 0.000197 1560.000000 0.000266 -0.003579 0.008454 +13877 1 0.000265 1560.000000 -0.002035 0.003192 0.004410 +13878 1 0.000227 1560.000000 0.001580 0.001988 0.005719 +13879 1 0.000258 1560.000000 0.003203 -0.001395 0.004235 +13880 1 0.000254 1560.000000 0.000846 -0.003388 0.001954 +13881 1 0.000223 1560.000000 -0.001936 0.000148 0.002737 +13882 1 0.000276 1560.000000 -0.001621 -0.002296 0.008520 +13883 1 0.000203 1560.000000 -0.002432 -0.001141 0.009105 +13884 1 0.000198 1560.000000 -0.001892 -0.002140 0.004546 +13885 1 0.000254 1560.000000 0.001766 -0.000768 0.006192 +13886 1 0.000196 1560.000000 -0.000734 -0.003154 0.008786 +13887 1 0.000235 1560.000000 0.002618 -0.001152 0.004318 +13888 1 0.000264 1560.000000 -0.000577 -0.000923 0.003643 +13889 1 0.000275 1560.000000 0.002220 -0.002998 0.005972 +13890 1 0.000261 1560.000000 0.002783 -0.000424 0.005821 +13891 1 0.000284 1560.000000 -0.001816 -0.000920 0.007455 +13892 1 0.000269 1560.000000 0.003329 0.000363 0.008053 +13893 1 0.000209 1560.000000 -0.000746 0.001848 0.003108 +13894 1 0.000246 1560.000000 0.002980 -0.000196 0.007264 +13895 1 0.000203 1560.000000 0.002713 0.002127 0.000414 +13896 1 0.000241 1560.000000 0.000298 0.001381 0.009819 +13897 1 0.000206 1560.000000 -0.002163 0.000624 0.006012 +13898 1 0.000254 1560.000000 -0.003514 -0.001378 0.000470 +13899 1 0.000200 1560.000000 0.000770 0.002833 0.001779 +13900 1 0.000246 1560.000000 -0.001631 0.000489 0.003173 +13901 1 0.000230 1560.000000 0.001185 0.001043 0.004864 +13902 1 0.000274 1560.000000 0.001602 0.001078 0.001473 +13903 1 0.000233 1560.000000 0.003784 -0.000574 0.000352 +13904 1 0.000267 1560.000000 0.000875 -0.003043 0.004071 +13905 1 0.000205 1560.000000 -0.000302 -0.002676 0.007649 +13906 1 0.000215 1560.000000 -0.000143 -0.003788 0.009393 +13907 1 0.000237 1560.000000 0.001990 0.001176 0.009057 +13908 1 0.000224 1560.000000 -0.002874 -0.001577 0.003629 +13909 1 0.000198 1560.000000 -0.000405 -0.001956 0.006668 +13910 1 0.000261 1560.000000 0.000260 0.001910 0.005077 +13911 1 0.000287 1560.000000 0.003075 0.002261 0.002981 +13912 1 0.000205 1560.000000 0.003205 -0.000629 0.009384 +13913 1 0.000253 1560.000000 -0.003596 -0.001270 0.008874 +13914 1 0.000253 1560.000000 0.001880 0.002436 0.001106 +13915 1 0.000234 1560.000000 -0.001584 -0.003386 0.008991 +13916 1 0.000226 1560.000000 0.001862 0.003285 0.009615 +13917 1 0.000192 1560.000000 0.001424 -0.001173 0.006419 +13918 1 0.000255 1560.000000 -0.003552 -0.000965 0.001443 +13919 1 0.000248 1560.000000 -0.002307 0.000924 0.006073 +13920 1 0.000257 1560.000000 0.001485 0.003484 0.004841 +13921 1 0.000224 1560.000000 -0.001408 -0.001789 0.003431 +13922 1 0.000231 1560.000000 -0.002056 -0.000536 0.009286 +13923 1 0.000230 1560.000000 -0.001376 -0.000533 0.005544 +13924 1 0.000210 1560.000000 0.002956 0.001047 0.009408 +13925 1 0.000243 1560.000000 0.002510 0.000238 0.003655 +13926 1 0.000200 1560.000000 -0.000396 0.001487 0.001283 +13927 1 0.000288 1560.000000 0.003459 -0.000099 0.003479 +13928 1 0.000248 1560.000000 -0.001627 -0.002225 0.005951 +13929 1 0.000263 1560.000000 0.001962 0.002298 0.007809 +13930 1 0.000241 1560.000000 -0.002843 -0.000355 0.005521 +13931 1 0.000234 1560.000000 -0.001508 0.001592 0.006920 +13932 1 0.000233 1560.000000 -0.000237 -0.003820 0.004919 +13933 1 0.000202 1560.000000 0.001069 -0.000206 0.005436 +13934 1 0.000203 1560.000000 -0.002052 0.000215 0.006548 +13935 1 0.000219 1560.000000 0.002446 0.000152 0.000821 +13936 1 0.000236 1560.000000 -0.000115 -0.002934 0.006868 +13937 1 0.000254 1560.000000 -0.000511 -0.000059 0.006818 +13938 1 0.000224 1560.000000 -0.001058 0.001527 0.001765 +13939 1 0.000204 1560.000000 0.000120 -0.002581 0.009131 +13940 1 0.000238 1560.000000 -0.001984 -0.000378 0.000131 +13941 1 0.000195 1560.000000 -0.001971 -0.002911 0.000549 +13942 1 0.000267 1560.000000 -0.002114 0.000114 0.009039 +13943 1 0.000279 1560.000000 -0.001242 -0.002818 0.008260 +13944 1 0.000203 1560.000000 -0.002908 0.000463 0.004822 +13945 1 0.000214 1560.000000 -0.003264 -0.001540 0.001543 +13946 1 0.000198 1560.000000 -0.002898 0.002049 0.008674 +13947 1 0.000262 1560.000000 0.000833 -0.003507 0.004209 +13948 1 0.000208 1560.000000 0.000689 -0.003680 0.005489 +13949 1 0.000231 1560.000000 0.001949 0.001993 0.006831 +13950 1 0.000275 1560.000000 -0.000098 -0.002555 0.000161 +13951 1 0.000243 1560.000000 -0.000883 -0.002388 0.002288 +13952 1 0.000258 1560.000000 -0.000036 -0.000419 0.002142 +13953 1 0.000276 1560.000000 0.002512 0.002632 0.009705 +13954 1 0.000225 1560.000000 0.000373 -0.000486 0.001159 +13955 1 0.000213 1560.000000 0.001173 -0.002288 0.006064 +13956 1 0.000227 1560.000000 -0.000638 0.002800 0.000224 +13957 1 0.000231 1560.000000 -0.003458 -0.000874 0.008715 +13958 1 0.000223 1560.000000 0.001021 0.003574 0.008223 +13959 1 0.000239 1560.000000 -0.000974 0.001040 0.005192 +13960 1 0.000243 1560.000000 -0.001946 0.002538 0.006960 +13961 1 0.000196 1560.000000 -0.002098 -0.000811 0.006403 +13962 1 0.000213 1560.000000 0.003415 -0.000473 0.008153 +13963 1 0.000215 1560.000000 0.002281 -0.002316 0.006835 +13964 1 0.000205 1560.000000 -0.000648 0.003527 0.009582 +13965 1 0.000208 1560.000000 -0.001213 -0.001555 0.003058 +13966 1 0.000229 1560.000000 -0.002653 -0.001724 0.003809 +13967 1 0.000252 1560.000000 0.000565 0.002555 0.005522 +13968 1 0.000216 1560.000000 -0.002013 0.002773 0.000612 +13969 1 0.000217 1560.000000 -0.000254 0.003504 0.002123 +13970 1 0.000267 1560.000000 0.000937 0.003721 0.007811 +13971 1 0.000267 1560.000000 -0.000798 -0.001586 0.008216 +13972 1 0.000249 1560.000000 -0.002693 -0.001069 0.006801 +13973 1 0.000230 1560.000000 -0.000500 0.003057 0.005604 +13974 1 0.000262 1560.000000 -0.001491 0.002245 0.009604 +13975 1 0.000254 1560.000000 0.002170 0.001286 0.002794 +13976 1 0.000223 1560.000000 0.001383 0.002701 0.005200 +13977 1 0.000249 1560.000000 -0.001430 -0.000966 0.005730 +13978 1 0.000239 1560.000000 0.002291 -0.002566 0.001887 +13979 1 0.000193 1560.000000 -0.000287 0.000071 0.004602 +13980 1 0.000248 1560.000000 0.000485 -0.001057 0.002393 +13981 1 0.000246 1560.000000 -0.001287 0.001655 0.001562 +13982 1 0.000198 1560.000000 -0.001590 0.002753 0.009340 +13983 1 0.000259 1560.000000 -0.001581 0.001404 0.008020 +13984 1 0.000283 1560.000000 -0.001815 -0.002716 0.007157 +13985 1 0.000198 1560.000000 0.003429 0.000828 0.007447 +13986 1 0.000260 1560.000000 0.002149 0.001491 0.000244 +13987 1 0.000236 1560.000000 0.002290 -0.001846 0.002375 +13988 1 0.000215 1560.000000 -0.002270 0.001692 0.005943 +13989 1 0.000254 1560.000000 -0.001225 -0.002553 0.002954 +13990 1 0.000248 1560.000000 -0.001374 -0.003494 0.007044 +13991 1 0.000238 1560.000000 0.003006 -0.001062 0.001178 +13992 1 0.000251 1560.000000 0.000058 0.001479 0.008017 +13993 1 0.000200 1560.000000 -0.002792 0.000288 0.002794 +13994 1 0.000263 1560.000000 -0.003356 0.000746 0.002928 +13995 1 0.000271 1560.000000 -0.000690 -0.000805 0.006403 +13996 1 0.000202 1560.000000 0.000941 0.001074 0.003010 +13997 1 0.000203 1560.000000 0.001417 0.000698 0.001801 +13998 1 0.000214 1560.000000 0.002019 0.002900 0.006081 +13999 1 0.000239 1560.000000 -0.000804 0.003221 0.007852 +14000 1 0.000209 1560.000000 0.001272 -0.000686 0.002596 +14001 1 0.000198 1560.000000 -0.003017 -0.000036 0.003173 +14002 1 0.000283 1560.000000 0.003631 0.000895 0.004564 +14003 1 0.000197 1560.000000 -0.003034 -0.001559 0.004918 +14004 1 0.000213 1560.000000 -0.001584 0.002001 0.004512 +14005 1 0.000231 1560.000000 0.003419 0.001584 0.001805 +14006 1 0.000212 1560.000000 0.003152 0.000151 0.001731 +14007 1 0.000243 1560.000000 -0.000063 0.003617 0.007811 +14008 1 0.000231 1560.000000 -0.000794 -0.002066 0.007742 +14009 1 0.000199 1560.000000 0.003699 -0.000631 0.000811 +14010 1 0.000254 1560.000000 0.000313 0.000234 0.004611 +14011 1 0.000206 1560.000000 -0.003074 0.002216 0.005580 +14012 1 0.000243 1560.000000 0.001531 -0.000816 0.002961 +14013 1 0.000209 1560.000000 0.001355 0.002376 0.004505 +14014 1 0.000200 1560.000000 -0.003508 0.001524 0.003261 +14015 1 0.000201 1560.000000 -0.001015 -0.002641 0.008098 +14016 1 0.000218 1560.000000 -0.001090 -0.002607 0.003887 +14017 1 0.000223 1560.000000 0.001378 0.003101 0.006908 +14018 1 0.000258 1560.000000 -0.002697 0.002368 0.004114 +14019 1 0.000238 1560.000000 -0.002966 -0.001881 0.009145 +14020 1 0.000265 1560.000000 0.003497 0.001528 0.003783 +14021 1 0.000199 1560.000000 0.001190 -0.002760 0.007638 +14022 1 0.000251 1560.000000 0.002654 0.001868 0.009830 +14023 1 0.000196 1560.000000 -0.001911 -0.000554 0.004702 +14024 1 0.000276 1560.000000 0.001955 -0.003175 0.000259 +14025 1 0.000212 1560.000000 0.001932 0.000366 0.008569 +14026 1 0.000243 1560.000000 -0.003065 -0.002189 0.004970 +14027 1 0.000270 1560.000000 -0.001044 -0.001605 0.008032 +14028 1 0.000215 1560.000000 0.002815 0.001609 0.007462 +14029 1 0.000240 1560.000000 0.002317 -0.000866 0.005021 +14030 1 0.000195 1560.000000 -0.000872 -0.002727 0.005660 +14031 1 0.000195 1560.000000 -0.001588 -0.002992 0.001684 +14032 1 0.000207 1560.000000 0.003407 -0.000355 0.007381 +14033 1 0.000202 1560.000000 -0.000762 -0.002098 0.008846 +14034 1 0.000288 1560.000000 0.001632 -0.003465 0.001781 +14035 1 0.000193 1560.000000 0.001970 -0.002767 0.004175 +14036 1 0.000227 1560.000000 -0.002695 0.002031 0.002590 +14037 1 0.000211 1560.000000 0.002979 -0.000907 0.001586 +14038 1 0.000248 1560.000000 -0.002627 0.001235 0.008904 +14039 1 0.000214 1560.000000 -0.001391 -0.001880 0.008049 +14040 1 0.000224 1560.000000 -0.000051 -0.002078 0.009488 +14041 1 0.000203 1560.000000 -0.002743 0.000478 0.009440 +14042 1 0.000194 1560.000000 -0.000054 -0.001999 0.001224 +14043 1 0.000204 1560.000000 0.000695 -0.000965 0.007889 +14044 1 0.000196 1560.000000 -0.003251 -0.001583 0.000107 +14045 1 0.000201 1560.000000 -0.002544 -0.002727 0.007689 +14046 1 0.000232 1560.000000 -0.001647 0.002229 0.007622 +14047 1 0.000230 1560.000000 0.000378 -0.001377 0.004252 +14048 1 0.000205 1560.000000 -0.002015 0.000474 0.006852 +14049 1 0.000235 1560.000000 -0.000837 0.003063 0.006063 +14050 1 0.000246 1560.000000 0.002439 -0.001164 0.009277 +14051 1 0.000206 1560.000000 0.002149 -0.002919 0.009672 +14052 1 0.000220 1560.000000 -0.000953 -0.003368 0.006660 +14053 1 0.000240 1560.000000 -0.003530 -0.000473 0.005137 +14054 1 0.000209 1560.000000 -0.002570 0.000782 0.001439 +14055 1 0.000236 1560.000000 0.000968 -0.003186 0.000838 +14056 1 0.000216 1560.000000 -0.002255 -0.001800 0.003283 +14057 1 0.000237 1560.000000 0.001047 0.001388 0.004258 +14058 1 0.000271 1560.000000 0.002435 -0.002339 0.003226 +14059 1 0.000244 1560.000000 0.002276 0.001969 0.009807 +14060 1 0.000227 1560.000000 -0.000562 -0.000629 0.009136 +14061 1 0.000220 1560.000000 -0.002495 0.000737 0.008648 +14062 1 0.000211 1560.000000 0.003434 0.000738 0.002491 +14063 1 0.000276 1560.000000 0.002762 -0.000006 0.004585 +14064 1 0.000264 1560.000000 -0.003591 0.000155 0.001847 +14065 1 0.000233 1560.000000 -0.003492 0.000091 0.003431 +14066 1 0.000192 1560.000000 0.003249 -0.001732 0.009628 +14067 1 0.000241 1560.000000 -0.000180 0.002757 0.002556 +14068 1 0.000243 1560.000000 0.000105 -0.002820 0.003698 +14069 1 0.000208 1560.000000 0.001803 -0.001580 0.006215 +14070 1 0.000203 1560.000000 -0.001045 -0.000279 0.006080 +14071 1 0.000198 1560.000000 0.001059 0.000118 0.003512 +14072 1 0.000195 1560.000000 -0.000130 0.002110 0.003242 +14073 1 0.000220 1560.000000 -0.001389 0.000549 0.000449 +14074 1 0.000254 1560.000000 -0.000032 -0.003325 0.008145 +14075 1 0.000285 1560.000000 0.001199 -0.001336 0.008977 +14076 1 0.000216 1560.000000 0.002942 0.002357 0.005748 +14077 1 0.000216 1560.000000 -0.002743 0.000349 0.000819 +14078 1 0.000234 1560.000000 -0.003479 -0.000195 0.002094 +14079 1 0.000265 1560.000000 0.002342 0.002440 0.006179 +14080 1 0.000246 1560.000000 -0.001868 0.000172 0.006183 +14081 1 0.000217 1560.000000 0.000201 -0.002881 0.007417 +14082 1 0.000193 1560.000000 -0.001023 0.000249 0.006606 +14083 1 0.000224 1560.000000 -0.001451 -0.002616 0.007256 +14084 1 0.000229 1560.000000 0.003182 0.002125 0.009789 +14085 1 0.000255 1560.000000 -0.002672 -0.002406 0.002641 +14086 1 0.000232 1560.000000 0.001875 -0.001674 0.004154 +14087 1 0.000238 1560.000000 0.000720 0.002902 0.004314 +14088 1 0.000248 1560.000000 0.001272 -0.001336 0.000978 +14089 1 0.000247 1560.000000 -0.002757 0.002095 0.008289 +14090 1 0.000209 1560.000000 0.002315 -0.002000 0.004322 +14091 1 0.000236 1560.000000 0.002408 -0.000634 0.005545 +14092 1 0.000234 1560.000000 0.003007 -0.002372 0.007692 +14093 1 0.000210 1560.000000 -0.003391 0.001026 0.008904 +14094 1 0.000209 1560.000000 0.000884 -0.003716 0.004656 +14095 1 0.000247 1560.000000 -0.002338 -0.001280 0.002434 +14096 1 0.000196 1560.000000 0.000936 0.001305 0.005452 +14097 1 0.000269 1560.000000 0.001477 0.003324 0.007362 +14098 1 0.000249 1560.000000 0.003774 -0.000716 0.001240 +14099 1 0.000196 1560.000000 -0.001258 0.001291 0.007465 +14100 1 0.000216 1560.000000 0.001574 0.000726 0.002691 +14101 1 0.000205 1560.000000 0.002777 0.002629 0.003611 +14102 1 0.000226 1560.000000 0.000512 -0.002397 0.006304 +14103 1 0.000218 1560.000000 0.000784 0.003278 0.008963 +14104 1 0.000259 1560.000000 0.000340 -0.000612 0.004430 +14105 1 0.000205 1560.000000 0.001613 0.001864 0.003727 +14106 1 0.000195 1560.000000 -0.002579 -0.000805 0.008135 +14107 1 0.000223 1560.000000 -0.000183 0.003817 0.006195 +14108 1 0.000255 1560.000000 0.000669 -0.002656 0.003233 +14109 1 0.000201 1560.000000 -0.002067 -0.000567 0.008636 +14110 1 0.000277 1560.000000 0.002396 -0.002911 0.000363 +14111 1 0.000228 1560.000000 -0.003428 0.001275 0.007086 +14112 1 0.000230 1560.000000 -0.000060 0.001932 0.001067 +14113 1 0.000254 1560.000000 -0.001398 0.001281 0.006734 +14114 1 0.000196 1560.000000 0.002935 -0.001860 0.003761 +14115 1 0.000267 1560.000000 0.001730 0.003200 0.007785 +14116 1 0.000193 1560.000000 -0.002444 -0.001485 0.003637 +14117 1 0.000288 1560.000000 -0.002951 0.000141 0.006300 +14118 1 0.000204 1560.000000 0.001375 0.001970 0.003081 +14119 1 0.000265 1560.000000 -0.000198 0.002031 0.009830 +14120 1 0.000236 1560.000000 -0.002960 0.001306 0.001627 +14121 1 0.000246 1560.000000 0.003392 -0.000328 0.004522 +14122 1 0.000255 1560.000000 0.000299 -0.002039 0.005453 +14123 1 0.000193 1560.000000 0.002012 0.002592 0.007325 +14124 1 0.000202 1560.000000 -0.001104 -0.003364 0.004121 +14125 1 0.000274 1560.000000 -0.002681 0.001413 0.003087 +14126 1 0.000269 1560.000000 0.002392 0.002606 0.001423 +14127 1 0.000256 1560.000000 -0.002539 0.001259 0.008088 +14128 1 0.000252 1560.000000 -0.000437 0.002088 0.001970 +14129 1 0.000231 1560.000000 -0.003355 0.000015 0.008628 +14130 1 0.000224 1560.000000 0.000558 0.002424 0.001691 +14131 1 0.000201 1560.000000 0.002667 -0.002496 0.003731 +14132 1 0.000214 1560.000000 -0.000822 0.002244 0.006390 +14133 1 0.000270 1560.000000 0.002962 0.000301 0.009551 +14134 1 0.000201 1560.000000 -0.000867 -0.003665 0.009293 +14135 1 0.000218 1560.000000 -0.002042 -0.003084 0.005108 +14136 1 0.000237 1560.000000 -0.001803 -0.002702 0.000660 +14137 1 0.000267 1560.000000 -0.003090 -0.001955 0.005721 +14138 1 0.000231 1560.000000 0.000790 0.002621 0.003399 +14139 1 0.000202 1560.000000 -0.000570 -0.002568 0.008848 +14140 1 0.000217 1560.000000 -0.003121 0.001193 0.006434 +14141 1 0.000201 1560.000000 0.002301 -0.000770 0.004010 +14142 1 0.000274 1560.000000 0.001709 0.003146 0.006696 +14143 1 0.000279 1560.000000 -0.001065 -0.003513 0.000146 +14144 1 0.000264 1560.000000 -0.002011 -0.000777 0.009813 +14145 1 0.000203 1560.000000 0.001376 0.002272 0.009681 +14146 1 0.000219 1560.000000 0.001758 -0.002367 0.006388 +14147 1 0.000275 1560.000000 0.000535 -0.002063 0.007346 +14148 1 0.000219 1560.000000 -0.002472 -0.000325 0.007625 +14149 1 0.000236 1560.000000 0.003762 -0.000170 0.005062 +14150 1 0.000209 1560.000000 -0.001474 0.001865 0.004009 +14151 1 0.000232 1560.000000 -0.001976 -0.002387 0.006687 +14152 1 0.000233 1560.000000 0.002318 0.000932 0.006238 +14153 1 0.000241 1560.000000 -0.000983 0.001558 0.004734 +14154 1 0.000274 1560.000000 0.000918 0.001920 0.002121 +14155 1 0.000195 1560.000000 0.000176 -0.003063 0.004278 +14156 1 0.000263 1560.000000 -0.000430 -0.003607 0.007287 +14157 1 0.000226 1560.000000 -0.000566 0.000247 0.009793 +14158 1 0.000236 1560.000000 -0.001926 -0.002805 0.009770 +14159 1 0.000266 1560.000000 0.001911 -0.001200 0.009587 +14160 1 0.000288 1560.000000 -0.002325 -0.001363 0.009367 +14161 1 0.000253 1560.000000 -0.002407 -0.000772 0.004986 +14162 1 0.000193 1560.000000 -0.002323 -0.000971 0.006325 +14163 1 0.000227 1560.000000 -0.001151 -0.003128 0.002404 +14164 1 0.000277 1560.000000 0.001555 -0.002699 0.008302 +14165 1 0.000246 1560.000000 0.002869 0.000970 0.001211 +14166 1 0.000194 1560.000000 0.000423 0.000751 0.004491 +14167 1 0.000266 1560.000000 0.002751 0.002643 0.005271 +14168 1 0.000229 1560.000000 -0.001664 -0.002733 0.009125 +14169 1 0.000255 1560.000000 0.000631 0.000747 0.007848 +14170 1 0.000195 1560.000000 0.001346 -0.002396 0.002447 +14171 1 0.000270 1560.000000 0.002782 0.000310 0.000594 +14172 1 0.000266 1560.000000 -0.000126 0.001649 0.005125 +14173 1 0.000236 1560.000000 0.000117 0.001940 0.001817 +14174 1 0.000216 1560.000000 0.000046 0.002043 0.009516 +14175 1 0.000200 1560.000000 -0.003375 0.001791 0.009046 +14176 1 0.000203 1560.000000 -0.001493 0.000551 0.005794 +14177 1 0.000235 1560.000000 -0.000468 -0.002309 0.005158 +14178 1 0.000227 1560.000000 -0.001200 -0.002427 0.008346 +14179 1 0.000195 1560.000000 -0.000822 -0.001842 0.001838 +14180 1 0.000253 1560.000000 0.002508 -0.001134 0.005546 +14181 1 0.000252 1560.000000 -0.000241 0.001749 0.007237 +14182 1 0.000214 1560.000000 -0.002352 0.001181 0.001090 +14183 1 0.000244 1560.000000 0.002187 -0.000348 0.009211 +14184 1 0.000231 1560.000000 0.000199 -0.002246 0.003174 +14185 1 0.000253 1560.000000 0.003605 0.001221 0.007798 +14186 1 0.000221 1560.000000 -0.002881 -0.001190 0.009042 +14187 1 0.000193 1560.000000 0.001232 0.002850 0.000147 +14188 1 0.000193 1560.000000 -0.000620 0.000953 0.002746 +14189 1 0.000249 1560.000000 0.000363 -0.000674 0.002408 +14190 1 0.000261 1560.000000 -0.001749 -0.000375 0.003338 +14191 1 0.000241 1560.000000 0.000831 0.000445 0.006404 +14192 1 0.000216 1560.000000 -0.000659 0.000530 0.003958 +14193 1 0.000232 1560.000000 -0.000792 -0.003599 0.003992 +14194 1 0.000231 1560.000000 -0.000723 0.001926 0.008432 +14195 1 0.000205 1560.000000 0.000363 0.002982 0.008978 +14196 1 0.000223 1560.000000 -0.000081 0.001806 0.000622 +14197 1 0.000205 1560.000000 0.003397 0.001402 0.007595 +14198 1 0.000231 1560.000000 0.001184 0.003386 0.000196 +14199 1 0.000207 1560.000000 0.001567 -0.000661 0.005998 +14200 1 0.000276 1560.000000 0.003213 0.001098 0.008296 +14201 1 0.000197 1560.000000 -0.000690 0.001971 0.007491 +14202 1 0.000201 1560.000000 0.003211 -0.001532 0.001618 +14203 1 0.000212 1560.000000 0.001394 -0.001276 0.008135 +14204 1 0.000262 1560.000000 0.001307 -0.003563 0.001345 +14205 1 0.000245 1560.000000 -0.001603 0.003234 0.007672 +14206 1 0.000270 1560.000000 0.002813 0.001198 0.003046 +14207 1 0.000280 1560.000000 0.001282 0.000872 0.009298 +14208 1 0.000199 1560.000000 -0.000208 -0.000418 0.003784 +14209 1 0.000203 1560.000000 -0.001124 -0.000346 0.006753 +14210 1 0.000216 1560.000000 -0.000997 0.001989 0.005767 +14211 1 0.000219 1560.000000 0.001275 0.001730 0.003118 +14212 1 0.000263 1560.000000 -0.002519 0.001500 0.007546 +14213 1 0.000276 1560.000000 0.002403 0.002699 0.007715 +14214 1 0.000276 1560.000000 -0.001970 -0.000788 0.002678 +14215 1 0.000278 1560.000000 -0.003118 0.000761 0.009667 +14216 1 0.000226 1560.000000 0.002003 -0.003132 0.001740 +14217 1 0.000231 1560.000000 -0.001628 0.003405 0.002012 +14218 1 0.000226 1560.000000 -0.000966 -0.001534 0.003123 +14219 1 0.000205 1560.000000 -0.000304 -0.000103 0.009223 +14220 1 0.000288 1560.000000 0.001167 0.003586 0.002024 +14221 1 0.000204 1560.000000 0.001303 0.000529 0.009662 +14222 1 0.000279 1560.000000 -0.001880 -0.001855 0.001514 +14223 1 0.000256 1560.000000 0.000353 0.003804 0.006341 +14224 1 0.000268 1560.000000 -0.000043 0.002249 0.005739 +14225 1 0.000229 1560.000000 0.003756 0.000784 0.000981 +14226 1 0.000286 1560.000000 -0.001574 0.002721 0.008561 +14227 1 0.000252 1560.000000 0.003023 0.001741 0.003909 +14228 1 0.000202 1560.000000 -0.001525 0.003511 0.006120 +14229 1 0.000211 1560.000000 0.003377 -0.001823 0.000152 +14230 1 0.000195 1560.000000 -0.001120 0.000329 0.001764 +14231 1 0.000238 1560.000000 -0.001477 -0.000614 0.007714 +14232 1 0.000251 1560.000000 -0.002133 -0.003142 0.008224 +14233 1 0.000243 1560.000000 0.000189 0.000578 0.009045 +14234 1 0.000205 1560.000000 0.000397 0.000113 0.007071 +14235 1 0.000287 1560.000000 -0.001963 0.001275 0.004028 +14236 1 0.000267 1560.000000 -0.000577 -0.003120 0.009437 +14237 1 0.000219 1560.000000 -0.000940 0.000474 0.005530 +14238 1 0.000283 1560.000000 0.001146 0.002157 0.008234 +14239 1 0.000219 1560.000000 -0.000923 -0.000922 0.002466 +14240 1 0.000207 1560.000000 0.001106 -0.000886 0.007302 +14241 1 0.000218 1560.000000 -0.002851 -0.001325 0.005976 +14242 1 0.000203 1560.000000 -0.003182 0.000314 0.004223 +14243 1 0.000211 1560.000000 0.001512 0.002055 0.009647 +14244 1 0.000239 1560.000000 0.002037 -0.001704 0.003249 +14245 1 0.000254 1560.000000 0.003201 -0.000858 0.008708 +14246 1 0.000240 1560.000000 -0.000323 -0.000174 0.000461 +14247 1 0.000263 1560.000000 0.002142 -0.001854 0.001497 +14248 1 0.000204 1560.000000 0.000885 0.000134 0.005223 +14249 1 0.000206 1560.000000 0.001775 0.002808 0.000366 +14250 1 0.000220 1560.000000 -0.000915 -0.002428 0.003205 +14251 1 0.000287 1560.000000 -0.001831 -0.002186 0.007613 +14252 1 0.000227 1560.000000 -0.002380 -0.002063 0.007467 +14253 1 0.000257 1560.000000 0.000428 0.002704 0.004058 +14254 1 0.000228 1560.000000 -0.000913 0.002988 0.003248 +14255 1 0.000206 1560.000000 0.000699 0.001850 0.006054 +14256 1 0.000254 1560.000000 0.003591 0.000958 0.004948 +14257 1 0.000268 1560.000000 0.003207 -0.001515 0.009450 +14258 1 0.000240 1560.000000 0.002281 -0.001218 0.002229 +14259 1 0.000232 1560.000000 0.001578 0.000665 0.007843 +14260 1 0.000223 1560.000000 0.003558 0.000164 0.005506 +14261 1 0.000254 1560.000000 -0.002852 -0.001064 0.007514 +14262 1 0.000201 1560.000000 -0.001055 0.003385 0.002357 +14263 1 0.000197 1560.000000 0.001962 -0.001271 0.009347 +14264 1 0.000205 1560.000000 -0.000900 -0.002881 0.003777 +14265 1 0.000207 1560.000000 0.000870 0.000648 0.002798 +14266 1 0.000222 1560.000000 0.003777 -0.000245 0.001264 +14267 1 0.000236 1560.000000 0.003257 0.001216 0.009469 +14268 1 0.000246 1560.000000 0.000536 -0.000014 0.002397 +14269 1 0.000208 1560.000000 -0.002280 -0.002770 0.005262 +14270 1 0.000228 1560.000000 -0.001378 0.000773 0.001503 +14271 1 0.000254 1560.000000 0.000547 0.001656 0.007049 +14272 1 0.000229 1560.000000 0.000834 -0.002496 0.002076 +14273 1 0.000201 1560.000000 0.000292 0.001344 0.007851 +14274 1 0.000200 1560.000000 -0.001991 -0.002196 0.005358 +14275 1 0.000250 1560.000000 -0.003077 0.001556 0.002134 +14276 1 0.000242 1560.000000 0.003281 -0.001984 0.006318 +14277 1 0.000248 1560.000000 -0.003112 0.000296 0.008687 +14278 1 0.000225 1560.000000 0.000124 -0.003516 0.000925 +14279 1 0.000195 1560.000000 -0.002830 0.001833 0.003457 +14280 1 0.000210 1560.000000 0.000406 0.000117 0.003045 +14281 1 0.000202 1560.000000 0.001270 0.000168 0.003272 +14282 1 0.000224 1560.000000 0.001498 -0.000642 0.000188 +14283 1 0.000228 1560.000000 -0.001112 0.000912 0.004971 +14284 1 0.000273 1560.000000 0.002208 -0.000756 0.002195 +14285 1 0.000287 1560.000000 0.003326 0.001893 0.003132 +14286 1 0.000270 1560.000000 -0.002108 0.003094 0.001950 +14287 1 0.000197 1560.000000 0.001190 -0.002519 0.007729 +14288 1 0.000211 1560.000000 -0.002341 -0.003024 0.005602 +14289 1 0.000250 1560.000000 -0.003221 0.001399 0.008024 +14290 1 0.000267 1560.000000 0.000963 0.003582 0.006433 +14291 1 0.000217 1560.000000 0.002226 -0.001793 0.003986 +14292 1 0.000226 1560.000000 0.001129 -0.003169 0.003508 +14293 1 0.000286 1560.000000 0.003798 0.000054 0.005513 +14294 1 0.000225 1560.000000 0.001339 -0.000673 0.002001 +14295 1 0.000227 1560.000000 0.001260 -0.002727 0.000858 +14296 1 0.000199 1560.000000 0.000325 -0.000830 0.005344 +14297 1 0.000247 1560.000000 0.002239 0.002187 0.001656 +14298 1 0.000286 1560.000000 0.003558 0.000508 0.008357 +14299 1 0.000259 1560.000000 -0.000977 0.002533 0.005669 +14300 1 0.000198 1560.000000 -0.002354 -0.000763 0.000728 +14301 1 0.000237 1560.000000 0.001541 0.003504 0.006982 +14302 1 0.000205 1560.000000 0.002110 -0.000256 0.001859 +14303 1 0.000236 1560.000000 -0.003376 0.001740 0.008720 +14304 1 0.000256 1560.000000 -0.003304 0.001022 0.006787 +14305 1 0.000222 1560.000000 -0.001295 -0.003520 0.008926 +14306 1 0.000234 1560.000000 0.003492 0.000644 0.001702 +14307 1 0.000207 1560.000000 -0.001626 0.000980 0.005387 +14308 1 0.000217 1560.000000 -0.001309 -0.002986 0.002572 +14309 1 0.000218 1560.000000 -0.001258 -0.003065 0.002823 +14310 1 0.000230 1560.000000 -0.002048 0.000216 0.004203 +14311 1 0.000221 1560.000000 -0.002190 -0.001268 0.007138 +14312 1 0.000231 1560.000000 -0.002674 0.000488 0.000213 +14313 1 0.000205 1560.000000 -0.000713 -0.002935 0.007760 +14314 1 0.000248 1560.000000 -0.000925 -0.001915 0.000619 +14315 1 0.000222 1560.000000 0.003148 -0.001103 0.002535 +14316 1 0.000226 1560.000000 -0.001998 0.001861 0.000776 +14317 1 0.000260 1560.000000 0.001059 -0.003499 0.002555 +14318 1 0.000195 1560.000000 0.000668 0.001348 0.006764 +14319 1 0.000280 1560.000000 -0.000895 -0.002108 0.007989 +14320 1 0.000284 1560.000000 0.002231 -0.002096 0.004846 +14321 1 0.000221 1560.000000 0.000642 -0.003608 0.002959 +14322 1 0.000210 1560.000000 0.001825 -0.001657 0.007554 +14323 1 0.000281 1560.000000 -0.001547 0.002838 0.006323 +14324 1 0.000228 1560.000000 -0.000719 -0.000054 0.006695 +14325 1 0.000248 1560.000000 -0.001420 -0.002633 0.006194 +14326 1 0.000201 1560.000000 -0.000896 -0.001530 0.003797 +14327 1 0.000256 1560.000000 -0.000647 0.003788 0.002779 +14328 1 0.000236 1560.000000 -0.000544 0.002971 0.003772 +14329 1 0.000224 1560.000000 -0.001219 0.002434 0.007488 +14330 1 0.000226 1560.000000 0.002298 0.002138 0.004784 +14331 1 0.000266 1560.000000 -0.002905 0.001867 0.002319 +14332 1 0.000284 1560.000000 0.003471 0.000636 0.003353 +14333 1 0.000269 1560.000000 -0.002346 -0.000105 0.000671 +14334 1 0.000235 1560.000000 0.002075 -0.000897 0.007812 +14335 1 0.000201 1560.000000 -0.003542 0.001068 0.009475 +14336 1 0.000269 1560.000000 0.002059 -0.002254 0.005679 +14337 1 0.000203 1560.000000 -0.001300 -0.002871 0.001993 +14338 1 0.000211 1560.000000 -0.000855 0.002209 0.000361 +14339 1 0.000226 1560.000000 0.003259 0.001417 0.000284 +14340 1 0.000213 1560.000000 -0.002319 -0.002878 0.008426 +14341 1 0.000250 1560.000000 0.003563 0.000651 0.007067 +14342 1 0.000206 1560.000000 -0.002849 0.001207 0.006555 +14343 1 0.000235 1560.000000 -0.002355 0.001540 0.002685 +14344 1 0.000196 1560.000000 0.000226 -0.000115 0.007078 +14345 1 0.000232 1560.000000 -0.001199 -0.003362 0.008242 +14346 1 0.000245 1560.000000 -0.000833 0.002011 0.007795 +14347 1 0.000233 1560.000000 0.000453 0.003808 0.008902 +14348 1 0.000202 1560.000000 0.001951 -0.000999 0.002031 +14349 1 0.000198 1560.000000 0.000070 -0.000036 0.000365 +14350 1 0.000217 1560.000000 0.000812 -0.000648 0.005234 +14351 1 0.000205 1560.000000 0.002392 -0.002952 0.009142 +14352 1 0.000212 1560.000000 0.002654 0.001949 0.002672 +14353 1 0.000210 1560.000000 0.000470 -0.000689 0.006007 +14354 1 0.000256 1560.000000 -0.001964 -0.002073 0.009118 +14355 1 0.000231 1560.000000 0.000939 -0.003621 0.007719 +14356 1 0.000288 1560.000000 -0.001014 0.001896 0.006221 +14357 1 0.000255 1560.000000 0.000489 -0.000778 0.004675 +14358 1 0.000206 1560.000000 0.001899 0.001033 0.003886 +14359 1 0.000223 1560.000000 -0.001781 -0.002319 0.000316 +14360 1 0.000216 1560.000000 0.001165 0.000665 0.003284 +14361 1 0.000218 1560.000000 -0.000402 -0.003007 0.006842 +14362 1 0.000197 1560.000000 -0.002021 -0.001020 0.001535 +14363 1 0.000211 1560.000000 -0.003120 0.001139 0.008941 +14364 1 0.000197 1560.000000 0.001195 -0.002649 0.002811 +14365 1 0.000253 1560.000000 0.002068 0.002216 0.001262 +14366 1 0.000196 1560.000000 0.000114 0.001717 0.009766 +14367 1 0.000221 1560.000000 -0.003051 -0.000723 0.000966 +14368 1 0.000212 1560.000000 0.001423 0.002454 0.006414 +14369 1 0.000199 1560.000000 0.002448 -0.002268 0.008850 +14370 1 0.000253 1560.000000 0.001484 0.003248 0.009773 +14371 1 0.000207 1560.000000 0.000188 0.000086 0.006555 +14372 1 0.000213 1560.000000 0.003104 0.001732 0.002324 +14373 1 0.000225 1560.000000 -0.001848 -0.000535 0.009098 +14374 1 0.000218 1560.000000 0.000873 0.003167 0.006948 +14375 1 0.000210 1560.000000 0.003619 0.000030 0.006663 +14376 1 0.000246 1560.000000 -0.001665 0.001664 0.007945 +14377 1 0.000233 1560.000000 -0.001476 0.002352 0.002600 +14378 1 0.000248 1560.000000 -0.003057 0.001501 0.004533 +14379 1 0.000245 1560.000000 0.000970 -0.000944 0.008511 +14380 1 0.000222 1560.000000 0.001701 -0.000113 0.000645 +14381 1 0.000193 1560.000000 -0.002479 -0.001103 0.002006 +14382 1 0.000227 1560.000000 0.001348 -0.003557 0.007569 +14383 1 0.000241 1560.000000 0.002749 0.001042 0.000701 +14384 1 0.000195 1560.000000 -0.001064 -0.001326 0.005687 +14385 1 0.000196 1560.000000 -0.002404 0.002248 0.009312 +14386 1 0.000205 1560.000000 -0.002778 -0.000507 0.003699 +14387 1 0.000283 1560.000000 0.001517 -0.002627 0.006901 +14388 1 0.000252 1560.000000 -0.002479 0.001217 0.006240 +14389 1 0.000227 1560.000000 0.000930 -0.002808 0.005215 +14390 1 0.000285 1560.000000 0.003087 -0.001201 0.009235 +14391 1 0.000226 1560.000000 -0.002148 0.000727 0.001913 +14392 1 0.000256 1560.000000 0.000475 -0.003461 0.008794 +14393 1 0.000222 1560.000000 0.002152 -0.000847 0.000450 +14394 1 0.000239 1560.000000 -0.000174 0.001565 0.003329 +14395 1 0.000213 1560.000000 0.000177 -0.001664 0.008993 +14396 1 0.000203 1560.000000 -0.000567 -0.002047 0.002406 +14397 1 0.000249 1560.000000 -0.001996 0.001155 0.007005 +14398 1 0.000225 1560.000000 -0.001430 -0.002318 0.009734 +14399 1 0.000256 1560.000000 -0.001244 0.002851 0.008476 +14400 1 0.000257 1560.000000 0.000042 0.000989 0.008461 +14401 1 0.000262 1560.000000 0.002299 0.002083 0.003016 +14402 1 0.000219 1560.000000 -0.001697 -0.000589 0.000822 +14403 1 0.000266 1560.000000 -0.001056 -0.001655 0.009482 +14404 1 0.000199 1560.000000 0.001041 -0.000140 0.004344 +14405 1 0.000269 1560.000000 -0.002926 0.000549 0.000556 +14406 1 0.000193 1560.000000 0.002025 0.001598 0.000424 +14407 1 0.000243 1560.000000 -0.001946 0.001037 0.002090 +14408 1 0.000246 1560.000000 0.001314 0.001474 0.009480 +14409 1 0.000222 1560.000000 -0.000181 0.002575 0.001884 +14410 1 0.000276 1560.000000 -0.002752 0.001910 0.009173 +14411 1 0.000276 1560.000000 0.000897 0.002597 0.005402 +14412 1 0.000249 1560.000000 0.001314 -0.001534 0.002973 +14413 1 0.000224 1560.000000 -0.001698 -0.001289 0.000957 +14414 1 0.000217 1560.000000 0.001019 0.001579 0.006139 +14415 1 0.000207 1560.000000 0.000237 -0.001635 0.002086 +14416 1 0.000204 1560.000000 0.001948 0.001704 0.007429 +14417 1 0.000235 1560.000000 -0.001277 0.001100 0.001266 +14418 1 0.000238 1560.000000 -0.001483 -0.003440 0.008292 +14419 1 0.000209 1560.000000 0.001495 -0.002236 0.001399 +14420 1 0.000238 1560.000000 0.000377 0.001941 0.007484 +14421 1 0.000255 1560.000000 -0.000718 -0.002143 0.006994 +14422 1 0.000247 1560.000000 0.000815 0.003445 0.003443 +14423 1 0.000249 1560.000000 0.003196 -0.001075 0.009835 +14424 1 0.000229 1560.000000 0.001951 0.000929 0.007472 +14425 1 0.000231 1560.000000 0.000561 -0.002758 0.001807 +14426 1 0.000239 1560.000000 0.002931 -0.000810 0.001848 +14427 1 0.000196 1560.000000 -0.000440 -0.003255 0.004814 +14428 1 0.000287 1560.000000 0.003782 -0.000724 0.005080 +14429 1 0.000193 1560.000000 -0.001898 0.003210 0.007146 +14430 1 0.000244 1560.000000 -0.000809 0.003375 0.002014 +14431 1 0.000233 1560.000000 0.002035 -0.000112 0.007046 +14432 1 0.000218 1560.000000 -0.003365 0.001741 0.006787 +14433 1 0.000198 1560.000000 -0.002160 -0.001911 0.000220 +14434 1 0.000270 1560.000000 -0.002253 0.002602 0.009569 +14435 1 0.000240 1560.000000 -0.003775 -0.000596 0.003312 +14436 1 0.000197 1560.000000 0.003225 0.000252 0.008551 +14437 1 0.000193 1560.000000 -0.000776 -0.002166 0.002386 +14438 1 0.000253 1560.000000 0.002334 -0.003052 0.007243 +14439 1 0.000243 1560.000000 -0.001980 0.001408 0.000155 +14440 1 0.000200 1560.000000 0.000200 -0.000178 0.001177 +14441 1 0.000207 1560.000000 0.000166 -0.003339 0.006522 +14442 1 0.000248 1560.000000 0.001599 0.002744 0.005084 +14443 1 0.000233 1560.000000 0.002198 -0.002002 0.001169 +14444 1 0.000242 1560.000000 -0.002655 -0.001582 0.005483 +14445 1 0.000212 1560.000000 -0.001276 -0.003396 0.007760 +14446 1 0.000232 1560.000000 -0.003533 -0.001171 0.004795 +14447 1 0.000221 1560.000000 0.001319 0.001012 0.002167 +14448 1 0.000264 1560.000000 0.000753 0.000659 0.005380 +14449 1 0.000198 1560.000000 0.000179 0.000248 0.009129 +14450 1 0.000210 1560.000000 0.003454 0.000916 0.003830 +14451 1 0.000261 1560.000000 -0.002951 0.000791 0.005372 +14452 1 0.000223 1560.000000 -0.002785 -0.001679 0.002147 +14453 1 0.000265 1560.000000 0.001137 -0.002061 0.001448 +14454 1 0.000221 1560.000000 0.002371 0.002641 0.006520 +14455 1 0.000224 1560.000000 -0.002844 -0.001808 0.005835 +14456 1 0.000254 1560.000000 0.000046 0.001656 0.002104 +14457 1 0.000276 1560.000000 -0.001072 0.002716 0.009824 +14458 1 0.000266 1560.000000 -0.002459 -0.002845 0.003482 +14459 1 0.000277 1560.000000 -0.002683 -0.001908 0.008917 +14460 1 0.000214 1560.000000 0.001934 0.001300 0.008612 +14461 1 0.000206 1560.000000 0.001010 0.001170 0.003224 +14462 1 0.000257 1560.000000 0.002004 0.002603 0.006447 +14463 1 0.000233 1560.000000 -0.000741 -0.002388 0.005631 +14464 1 0.000204 1560.000000 0.001536 -0.000072 0.003210 +14465 1 0.000210 1560.000000 -0.002238 0.003058 0.001408 +14466 1 0.000207 1560.000000 0.002020 0.000057 0.000594 +14467 1 0.000275 1560.000000 0.002828 0.000210 0.003084 +14468 1 0.000232 1560.000000 0.000340 -0.001829 0.000776 +14469 1 0.000246 1560.000000 0.003468 0.001600 0.004097 +14470 1 0.000196 1560.000000 -0.001038 -0.001088 0.005806 +14471 1 0.000241 1560.000000 -0.002432 -0.001844 0.001536 +14472 1 0.000218 1560.000000 0.000514 0.001707 0.006759 +14473 1 0.000230 1560.000000 -0.001440 -0.001962 0.007150 +14474 1 0.000258 1560.000000 -0.002215 -0.000405 0.008168 +14475 1 0.000263 1560.000000 0.000841 -0.003549 0.000945 +14476 1 0.000241 1560.000000 -0.000729 -0.002855 0.005033 +14477 1 0.000284 1560.000000 0.001441 -0.003560 0.002963 +14478 1 0.000249 1560.000000 -0.001124 -0.002911 0.005396 +14479 1 0.000242 1560.000000 0.001439 0.001920 0.007646 +14480 1 0.000246 1560.000000 0.002021 0.000274 0.001670 +14481 1 0.000263 1560.000000 0.001679 0.002960 0.002618 +14482 1 0.000197 1560.000000 0.000717 0.000546 0.000738 +14483 1 0.000227 1560.000000 -0.001258 0.003181 0.004287 +14484 1 0.000272 1560.000000 0.001674 0.002111 0.009837 +14485 1 0.000210 1560.000000 0.001460 -0.001408 0.007953 +14486 1 0.000235 1560.000000 -0.001085 0.000807 0.003100 +14487 1 0.000248 1560.000000 0.002793 -0.001015 0.003571 +14488 1 0.000245 1560.000000 -0.003137 -0.000501 0.004681 +14489 1 0.000228 1560.000000 0.000118 -0.002906 0.009740 +14490 1 0.000211 1560.000000 -0.001091 -0.000597 0.002374 +14491 1 0.000226 1560.000000 0.001825 -0.002573 0.006745 +14492 1 0.000240 1560.000000 -0.002466 0.002090 0.001767 +14493 1 0.000205 1560.000000 0.000437 -0.002653 0.005528 +14494 1 0.000224 1560.000000 0.003018 0.000131 0.003250 +14495 1 0.000210 1560.000000 -0.002275 0.000552 0.009238 +14496 1 0.000211 1560.000000 -0.001566 -0.000549 0.009084 +14497 1 0.000208 1560.000000 0.001252 0.000414 0.000879 +14498 1 0.000244 1560.000000 0.002423 0.000345 0.004389 +14499 1 0.000217 1560.000000 0.000911 0.001219 0.001740 +14500 1 0.000197 1560.000000 -0.002016 -0.001244 0.003731 +14501 1 0.000277 1560.000000 0.003287 -0.000376 0.000157 +14502 1 0.000211 1560.000000 0.000843 0.002108 0.009629 +14503 1 0.000257 1560.000000 0.001208 -0.002308 0.005402 +14504 1 0.000213 1560.000000 -0.002705 -0.001342 0.003801 +14505 1 0.000240 1560.000000 0.002736 -0.001141 0.004973 +14506 1 0.000232 1560.000000 0.000753 -0.003498 0.005239 +14507 1 0.000213 1560.000000 0.002456 0.001812 0.001855 +14508 1 0.000265 1560.000000 -0.000023 0.003024 0.008206 +14509 1 0.000200 1560.000000 -0.002304 0.002341 0.008431 +14510 1 0.000255 1560.000000 0.001706 0.000520 0.005922 +14511 1 0.000199 1560.000000 -0.000968 -0.003640 0.008319 +14512 1 0.000269 1560.000000 0.002489 0.002834 0.007086 +14513 1 0.000193 1560.000000 0.000063 0.002618 0.000371 +14514 1 0.000258 1560.000000 0.003380 0.001781 0.003934 +14515 1 0.000208 1560.000000 0.001063 -0.000113 0.006576 +14516 1 0.000258 1560.000000 -0.000707 0.000194 0.000147 +14517 1 0.000231 1560.000000 -0.000631 -0.002169 0.001891 +14518 1 0.000203 1560.000000 -0.003217 -0.001286 0.003365 +14519 1 0.000234 1560.000000 -0.001778 0.000955 0.003775 +14520 1 0.000203 1560.000000 0.001620 0.001150 0.000167 +14521 1 0.000215 1560.000000 0.000224 0.001973 0.005615 +14522 1 0.000267 1560.000000 -0.001615 0.001960 0.006209 +14523 1 0.000216 1560.000000 -0.000904 -0.002922 0.009355 +14524 1 0.000273 1560.000000 0.001232 -0.003485 0.006263 +14525 1 0.000277 1560.000000 0.003817 -0.000267 0.002531 +14526 1 0.000253 1560.000000 -0.001264 -0.000910 0.006418 +14527 1 0.000243 1560.000000 0.001246 0.000699 0.004221 +14528 1 0.000264 1560.000000 0.002385 0.002403 0.009194 +14529 1 0.000231 1560.000000 -0.000718 0.003641 0.006167 +14530 1 0.000193 1560.000000 -0.001118 0.000198 0.009547 +14531 1 0.000279 1560.000000 0.003213 -0.001562 0.002921 +14532 1 0.000203 1560.000000 0.000848 0.001012 0.004534 +14533 1 0.000212 1560.000000 -0.000430 0.001521 0.009022 +14534 1 0.000194 1560.000000 0.000862 -0.000359 0.008751 +14535 1 0.000248 1560.000000 -0.001238 0.002708 0.001445 +14536 1 0.000246 1560.000000 -0.003164 -0.000377 0.008012 +14537 1 0.000258 1560.000000 0.003760 0.000132 0.008378 +14538 1 0.000217 1560.000000 0.001985 0.002016 0.009386 +14539 1 0.000285 1560.000000 0.003616 -0.001047 0.001605 +14540 1 0.000275 1560.000000 0.000738 0.000312 0.009354 +14541 1 0.000245 1560.000000 0.003127 -0.001574 0.008362 +14542 1 0.000241 1560.000000 -0.003320 0.000740 0.004631 +14543 1 0.000214 1560.000000 0.003526 -0.000341 0.004718 +14544 1 0.000243 1560.000000 -0.003253 -0.000637 0.007796 +14545 1 0.000194 1560.000000 -0.003841 0.000305 0.007363 +14546 1 0.000218 1560.000000 0.003180 -0.001059 0.009432 +14547 1 0.000273 1560.000000 0.002340 -0.002303 0.001536 +14548 1 0.000193 1560.000000 0.001187 -0.000203 0.008036 +14549 1 0.000276 1560.000000 -0.002028 -0.002908 0.005622 +14550 1 0.000198 1560.000000 -0.001403 0.002667 0.006646 +14551 1 0.000212 1560.000000 0.000051 -0.001201 0.007081 +14552 1 0.000221 1560.000000 0.001730 -0.001902 0.000456 +14553 1 0.000257 1560.000000 0.003768 -0.000490 0.008541 +14554 1 0.000218 1560.000000 -0.003113 -0.001929 0.008574 +14555 1 0.000218 1560.000000 -0.000065 -0.002611 0.009002 +14556 1 0.000230 1560.000000 0.002561 0.002292 0.008527 +14557 1 0.000196 1560.000000 0.000835 -0.000395 0.006008 +14558 1 0.000238 1560.000000 0.000268 -0.003236 0.005174 +14559 1 0.000252 1560.000000 0.001799 0.003395 0.008501 +14560 1 0.000194 1560.000000 0.002143 0.002224 0.004917 +14561 1 0.000279 1560.000000 -0.001833 0.002089 0.004249 +14562 1 0.000288 1560.000000 0.003835 -0.000045 0.003832 +14563 1 0.000275 1560.000000 0.000996 -0.003296 0.008313 +14564 1 0.000234 1560.000000 -0.002422 0.000083 0.004148 +14565 1 0.000201 1560.000000 0.002130 -0.003214 0.001441 +14566 1 0.000196 1560.000000 0.002194 -0.001529 0.002086 +14567 1 0.000199 1560.000000 0.000737 -0.001956 0.003510 +14568 1 0.000245 1560.000000 0.002263 0.001935 0.008818 +14569 1 0.000205 1560.000000 -0.002499 0.000587 0.000689 +14570 1 0.000219 1560.000000 -0.002584 0.002094 0.007931 +14571 1 0.000203 1560.000000 -0.001644 0.000868 0.000724 +14572 1 0.000201 1560.000000 -0.002452 -0.001312 0.005414 +14573 1 0.000272 1560.000000 -0.002552 0.001511 0.005546 +14574 1 0.000246 1560.000000 -0.003383 0.000835 0.005657 +14575 1 0.000217 1560.000000 -0.001411 0.003076 0.000215 +14576 1 0.000227 1560.000000 -0.002790 0.000708 0.004990 +14577 1 0.000197 1560.000000 0.003303 0.001106 0.006900 +14578 1 0.000226 1560.000000 -0.000724 -0.002411 0.004771 +14579 1 0.000287 1560.000000 -0.002142 -0.002957 0.000225 +14580 1 0.000241 1560.000000 -0.003230 -0.001849 0.004368 +14581 1 0.000247 1560.000000 0.003591 0.001061 0.001359 +14582 1 0.000261 1560.000000 -0.001208 -0.000650 0.004592 +14583 1 0.000274 1560.000000 -0.000654 0.003021 0.000554 +14584 1 0.000220 1560.000000 -0.002590 -0.001564 0.005720 +14585 1 0.000252 1560.000000 -0.000816 -0.002827 0.000428 +14586 1 0.000233 1560.000000 0.001979 -0.001623 0.008796 +14587 1 0.000261 1560.000000 -0.000358 0.001206 0.003066 +14588 1 0.000218 1560.000000 -0.000551 -0.002409 0.005802 +14589 1 0.000230 1560.000000 0.001298 -0.002900 0.001669 +14590 1 0.000192 1560.000000 -0.000794 0.000878 0.004475 +14591 1 0.000224 1560.000000 -0.002231 0.003028 0.004645 +14592 1 0.000259 1560.000000 -0.000146 0.000612 0.005010 +14593 1 0.000253 1560.000000 -0.001264 0.002710 0.006222 +14594 1 0.000272 1560.000000 0.001097 0.003647 0.002629 +14595 1 0.000287 1560.000000 0.001182 0.001961 0.002755 +14596 1 0.000253 1560.000000 -0.000394 -0.001358 0.000774 +14597 1 0.000259 1560.000000 0.002434 0.001279 0.005063 +14598 1 0.000219 1560.000000 0.002149 -0.001309 0.002712 +14599 1 0.000226 1560.000000 -0.002073 -0.002893 0.004354 +14600 1 0.000262 1560.000000 -0.002875 0.002393 0.005516 +14601 1 0.000229 1560.000000 0.001916 -0.002372 0.008815 +14602 1 0.000238 1560.000000 -0.001505 -0.002691 0.001160 +14603 1 0.000206 1560.000000 0.002081 0.002484 0.000213 +14604 1 0.000261 1560.000000 0.001061 0.003347 0.007903 +14605 1 0.000249 1560.000000 0.000767 -0.000720 0.003800 +14606 1 0.000255 1560.000000 -0.002734 -0.002598 0.000524 +14607 1 0.000224 1560.000000 0.001018 -0.001901 0.008858 +14608 1 0.000280 1560.000000 -0.002705 -0.001455 0.006219 +14609 1 0.000228 1560.000000 -0.000873 0.001862 0.000523 +14610 1 0.000197 1560.000000 0.000154 0.000892 0.006204 +14611 1 0.000233 1560.000000 -0.001602 -0.001099 0.007614 +14612 1 0.000204 1560.000000 -0.001199 -0.000348 0.000408 +14613 1 0.000262 1560.000000 -0.000455 0.001262 0.008368 +14614 1 0.000209 1560.000000 0.001967 0.002823 0.002779 +14615 1 0.000215 1560.000000 -0.000561 0.000096 0.007719 +14616 1 0.000210 1560.000000 -0.002695 0.000498 0.009801 +14617 1 0.000220 1560.000000 0.003357 0.000932 0.000144 +14618 1 0.000215 1560.000000 -0.003641 -0.001164 0.006768 +14619 1 0.000197 1560.000000 0.000718 0.003111 0.000780 +14620 1 0.000234 1560.000000 0.000126 0.003562 0.001962 +14621 1 0.000244 1560.000000 -0.002113 -0.003221 0.005385 +14622 1 0.000242 1560.000000 -0.002514 0.002295 0.002080 +14623 1 0.000237 1560.000000 -0.000705 0.003577 0.002161 +14624 1 0.000194 1560.000000 0.000644 0.002784 0.003963 +14625 1 0.000271 1560.000000 -0.003337 -0.000723 0.003904 +14626 1 0.000217 1560.000000 -0.000049 -0.002192 0.007977 +14627 1 0.000199 1560.000000 0.002918 0.002413 0.005509 +14628 1 0.000275 1560.000000 0.002178 0.001654 0.005076 +14629 1 0.000200 1560.000000 -0.001312 0.002051 0.008277 +14630 1 0.000202 1560.000000 -0.000705 0.002112 0.007983 +14631 1 0.000258 1560.000000 -0.001634 -0.002639 0.002351 +14632 1 0.000194 1560.000000 -0.000161 0.002918 0.001208 +14633 1 0.000254 1560.000000 0.003093 -0.001392 0.005022 +14634 1 0.000223 1560.000000 0.000457 0.002520 0.002736 +14635 1 0.000200 1560.000000 0.003060 -0.001400 0.000693 +14636 1 0.000206 1560.000000 -0.000349 -0.001532 0.003756 +14637 1 0.000202 1560.000000 -0.002908 -0.001290 0.006294 +14638 1 0.000268 1560.000000 -0.001373 0.002652 0.002421 +14639 1 0.000264 1560.000000 0.002504 -0.001678 0.008684 +14640 1 0.000277 1560.000000 -0.002261 -0.000424 0.006793 +14641 1 0.000195 1560.000000 -0.003711 0.000618 0.003066 +14642 1 0.000243 1560.000000 -0.000867 -0.001924 0.008374 +14643 1 0.000203 1560.000000 0.000972 0.003506 0.000401 +14644 1 0.000247 1560.000000 0.000622 -0.002732 0.008172 +14645 1 0.000213 1560.000000 0.002641 0.002020 0.005784 +14646 1 0.000209 1560.000000 -0.000471 0.002233 0.003104 +14647 1 0.000237 1560.000000 -0.000662 -0.002356 0.008807 +14648 1 0.000227 1560.000000 -0.001976 -0.002113 0.008867 +14649 1 0.000246 1560.000000 -0.000294 -0.001426 0.007770 +14650 1 0.000213 1560.000000 0.002504 0.000359 0.008764 +14651 1 0.000217 1560.000000 0.001502 0.000242 0.001277 +14652 1 0.000223 1560.000000 0.001786 -0.002345 0.003753 +14653 1 0.000250 1560.000000 -0.002831 0.001281 0.005975 +14654 1 0.000272 1560.000000 -0.001220 -0.003398 0.009792 +14655 1 0.000200 1560.000000 -0.000317 0.001800 0.009542 +14656 1 0.000226 1560.000000 0.000858 0.000235 0.005916 +14657 1 0.000194 1560.000000 0.001799 -0.001311 0.004696 +14658 1 0.000231 1560.000000 -0.001073 -0.003376 0.002716 +14659 1 0.000238 1560.000000 -0.001198 -0.000720 0.001295 +14660 1 0.000269 1560.000000 -0.000985 0.002627 0.008934 +14661 1 0.000230 1560.000000 -0.000056 -0.002727 0.005263 +14662 1 0.000258 1560.000000 -0.003247 -0.000143 0.005300 +14663 1 0.000231 1560.000000 0.001970 -0.001149 0.000816 +14664 1 0.000193 1560.000000 0.003377 0.000547 0.006018 +14665 1 0.000285 1560.000000 -0.001750 0.003324 0.009803 +14666 1 0.000267 1560.000000 -0.002221 -0.002665 0.003318 +14667 1 0.000253 1560.000000 0.001297 -0.003006 0.006910 +14668 1 0.000237 1560.000000 -0.002533 0.001760 0.007120 +14669 1 0.000260 1560.000000 -0.002566 0.002655 0.007867 +14670 1 0.000249 1560.000000 0.002972 -0.001251 0.006297 +14671 1 0.000214 1560.000000 -0.000682 0.000253 0.003398 +14672 1 0.000226 1560.000000 -0.003511 0.001573 0.006688 +14673 1 0.000244 1560.000000 -0.002287 0.001216 0.004887 +14674 1 0.000213 1560.000000 -0.003711 -0.000976 0.008139 +14675 1 0.000210 1560.000000 0.000558 0.002979 0.004798 +14676 1 0.000249 1560.000000 -0.001879 0.000616 0.008647 +14677 1 0.000240 1560.000000 -0.001156 0.000581 0.004933 +14678 1 0.000284 1560.000000 -0.002560 -0.002798 0.006238 +14679 1 0.000287 1560.000000 0.001242 0.001412 0.001595 +14680 1 0.000264 1560.000000 -0.002468 0.001948 0.004716 +14681 1 0.000281 1560.000000 -0.000017 -0.001032 0.007970 +14682 1 0.000279 1560.000000 0.001630 0.002378 0.008738 +14683 1 0.000220 1560.000000 0.000916 0.003709 0.001504 +14684 1 0.000248 1560.000000 0.002083 0.001754 0.001357 +14685 1 0.000277 1560.000000 0.002867 -0.002124 0.000736 +14686 1 0.000253 1560.000000 0.000268 -0.000732 0.000340 +14687 1 0.000198 1560.000000 -0.000490 -0.003110 0.005576 +14688 1 0.000277 1560.000000 0.001209 0.002537 0.006626 +14689 1 0.000220 1560.000000 -0.000317 0.003479 0.007674 +14690 1 0.000276 1560.000000 -0.001847 0.002271 0.003120 +14691 1 0.000265 1560.000000 0.000216 0.003828 0.005830 +14692 1 0.000232 1560.000000 0.000023 -0.003444 0.008678 +14693 1 0.000218 1560.000000 0.000990 0.000398 0.003344 +14694 1 0.000246 1560.000000 -0.000185 -0.003520 0.002813 +14695 1 0.000222 1560.000000 -0.000670 -0.001449 0.001799 +14696 1 0.000271 1560.000000 0.001202 0.003260 0.008408 +14697 1 0.000232 1560.000000 -0.001792 -0.002400 0.001881 +14698 1 0.000258 1560.000000 0.003253 -0.002012 0.000293 +14699 1 0.000210 1560.000000 -0.000019 0.003078 0.007472 +14700 1 0.000213 1560.000000 0.002680 0.000862 0.001459 +14701 1 0.000203 1560.000000 0.000278 0.000268 0.003973 +14702 1 0.000227 1560.000000 0.003298 -0.001854 0.003774 +14703 1 0.000263 1560.000000 0.000311 0.003794 0.002738 +14704 1 0.000206 1560.000000 0.001707 -0.003111 0.000426 +14705 1 0.000214 1560.000000 -0.003485 -0.001549 0.003626 +14706 1 0.000250 1560.000000 -0.001635 -0.003403 0.004998 +14707 1 0.000196 1560.000000 0.003405 0.000728 0.009366 +14708 1 0.000265 1560.000000 0.000527 0.002639 0.002239 +14709 1 0.000268 1560.000000 0.000214 0.001758 0.004491 +14710 1 0.000270 1560.000000 -0.003064 0.000814 0.005935 +14711 1 0.000227 1560.000000 0.000901 -0.003163 0.002593 +14712 1 0.000251 1560.000000 -0.002122 0.000091 0.008699 +14713 1 0.000288 1560.000000 -0.003544 0.001066 0.000995 +14714 1 0.000252 1560.000000 -0.003679 -0.000210 0.002649 +14715 1 0.000220 1560.000000 0.001640 -0.003063 0.004662 +14716 1 0.000251 1560.000000 0.001382 -0.000400 0.004229 +14717 1 0.000243 1560.000000 -0.000749 -0.003216 0.004303 +14718 1 0.000282 1560.000000 0.000163 -0.003126 0.003440 +14719 1 0.000259 1560.000000 0.003611 -0.000184 0.001681 +14720 1 0.000254 1560.000000 0.002210 -0.000688 0.004458 +14721 1 0.000206 1560.000000 0.001352 -0.002630 0.006342 +14722 1 0.000215 1560.000000 -0.003108 -0.001310 0.001488 +14723 1 0.000245 1560.000000 0.000620 -0.001825 0.003027 +14724 1 0.000220 1560.000000 -0.000677 0.001453 0.001848 +14725 1 0.000224 1560.000000 0.000736 -0.002247 0.001562 +14726 1 0.000231 1560.000000 0.001482 -0.002898 0.009709 +14727 1 0.000281 1560.000000 0.001338 -0.000755 0.009234 +14728 1 0.000256 1560.000000 0.003462 0.001151 0.009337 +14729 1 0.000231 1560.000000 -0.000261 0.003239 0.007520 +14730 1 0.000219 1560.000000 -0.001972 -0.002259 0.000730 +14731 1 0.000260 1560.000000 0.003318 -0.001041 0.005526 +14732 1 0.000212 1560.000000 -0.000163 -0.000907 0.008503 +14733 1 0.000205 1560.000000 0.001437 0.001284 0.008182 +14734 1 0.000280 1560.000000 -0.000188 -0.003108 0.005978 +14735 1 0.000194 1560.000000 0.001881 0.000195 0.003225 +14736 1 0.000257 1560.000000 0.003208 -0.000276 0.004337 +14737 1 0.000202 1560.000000 -0.002958 0.001375 0.005711 +14738 1 0.000240 1560.000000 -0.001956 0.003200 0.001471 +14739 1 0.000225 1560.000000 -0.001871 0.002798 0.009347 +14740 1 0.000216 1560.000000 0.000105 0.002148 0.008108 +14741 1 0.000206 1560.000000 0.003659 -0.000240 0.007082 +14742 1 0.000209 1560.000000 -0.000414 0.001919 0.003167 +14743 1 0.000279 1560.000000 0.002450 0.001372 0.009503 +14744 1 0.000222 1560.000000 -0.000537 0.002678 0.002845 +14745 1 0.000228 1560.000000 0.002169 0.003104 0.000735 +14746 1 0.000226 1560.000000 -0.002214 0.000565 0.007025 +14747 1 0.000252 1560.000000 0.002268 -0.001326 0.005573 +14748 1 0.000214 1560.000000 0.001348 0.001137 0.005486 +14749 1 0.000243 1560.000000 0.000309 0.002140 0.003993 +14750 1 0.000256 1560.000000 -0.003253 -0.001748 0.009787 +14751 1 0.000222 1560.000000 -0.000983 -0.003724 0.007894 +14752 1 0.000235 1560.000000 0.000990 0.001302 0.000163 +14753 1 0.000227 1560.000000 -0.002310 -0.003084 0.001155 +14754 1 0.000250 1560.000000 -0.000696 0.001157 0.005661 +14755 1 0.000242 1560.000000 -0.002181 0.001600 0.002015 +14756 1 0.000225 1560.000000 0.003068 -0.000849 0.007879 +14757 1 0.000278 1560.000000 -0.002927 0.000859 0.002173 +14758 1 0.000244 1560.000000 -0.000486 0.002085 0.005874 +14759 1 0.000222 1560.000000 0.000480 -0.001491 0.008420 +14760 1 0.000239 1560.000000 -0.001094 0.003232 0.001706 +14761 1 0.000238 1560.000000 -0.003552 0.001192 0.003413 +14762 1 0.000215 1560.000000 0.002348 0.000146 0.007627 +14763 1 0.000240 1560.000000 0.001399 -0.000204 0.000653 +14764 1 0.000198 1560.000000 -0.002266 -0.001630 0.001631 +14765 1 0.000250 1560.000000 0.002602 -0.000236 0.003509 +14766 1 0.000251 1560.000000 0.001004 0.003338 0.006711 +14767 1 0.000274 1560.000000 -0.000162 0.003233 0.003016 +14768 1 0.000251 1560.000000 -0.001043 -0.000478 0.001259 +14769 1 0.000251 1560.000000 -0.002658 0.002217 0.001383 +14770 1 0.000223 1560.000000 0.000995 0.002219 0.002130 +14771 1 0.000243 1560.000000 0.002925 0.002276 0.003234 +14772 1 0.000231 1560.000000 -0.003623 -0.001198 0.002004 +14773 1 0.000237 1560.000000 -0.001425 -0.000788 0.004347 +14774 1 0.000287 1560.000000 0.003439 -0.000085 0.003148 +14775 1 0.000213 1560.000000 -0.000036 0.000272 0.003723 +14776 1 0.000221 1560.000000 0.001407 0.001412 0.003720 +14777 1 0.000198 1560.000000 0.002533 0.001940 0.002898 +14778 1 0.000224 1560.000000 0.001732 0.000481 0.007124 +14779 1 0.000193 1560.000000 -0.002093 0.002932 0.002520 +14780 1 0.000203 1560.000000 0.001835 0.002310 0.000188 +14781 1 0.000254 1560.000000 0.000079 -0.000981 0.009262 +14782 1 0.000204 1560.000000 -0.002639 0.001723 0.004712 +14783 1 0.000220 1560.000000 0.002820 0.002170 0.006705 +14784 1 0.000262 1560.000000 -0.001980 -0.001151 0.004041 +14785 1 0.000212 1560.000000 -0.002502 -0.000082 0.005685 +14786 1 0.000270 1560.000000 -0.002811 -0.000795 0.008224 +14787 1 0.000278 1560.000000 0.001389 0.003510 0.005930 +14788 1 0.000218 1560.000000 -0.000684 -0.001044 0.008858 +14789 1 0.000227 1560.000000 0.002075 -0.001133 0.008860 +14790 1 0.000227 1560.000000 -0.000582 -0.003749 0.009718 +14791 1 0.000208 1560.000000 0.002314 0.001938 0.006666 +14792 1 0.000193 1560.000000 0.000251 -0.002161 0.003450 +14793 1 0.000226 1560.000000 -0.001264 -0.002310 0.003781 +14794 1 0.000192 1560.000000 0.001000 -0.003540 0.003627 +14795 1 0.000199 1560.000000 0.000423 0.000594 0.001669 +14796 1 0.000224 1560.000000 0.002574 -0.001663 0.003910 +14797 1 0.000227 1560.000000 -0.001647 0.003255 0.002557 +14798 1 0.000198 1560.000000 -0.000936 -0.003055 0.003170 +14799 1 0.000245 1560.000000 0.000429 0.001410 0.005979 +14800 1 0.000197 1560.000000 -0.002146 0.001096 0.006721 +14801 1 0.000194 1560.000000 0.000784 0.002368 0.000358 +14802 1 0.000221 1560.000000 -0.001425 -0.002543 0.008190 +14803 1 0.000201 1560.000000 0.001837 0.002138 0.007613 +14804 1 0.000224 1560.000000 0.001213 -0.000148 0.009517 +14805 1 0.000259 1560.000000 0.000656 0.003116 0.006176 +14806 1 0.000228 1560.000000 -0.002109 0.001589 0.009082 +14807 1 0.000220 1560.000000 -0.001616 -0.000954 0.006997 +14808 1 0.000223 1560.000000 0.001345 0.001740 0.003361 +14809 1 0.000218 1560.000000 0.003035 -0.002115 0.002471 +14810 1 0.000195 1560.000000 -0.000863 -0.002658 0.004820 +14811 1 0.000246 1560.000000 -0.000091 0.003622 0.003160 +14812 1 0.000261 1560.000000 -0.001032 -0.000971 0.007191 +14813 1 0.000246 1560.000000 0.001626 0.002293 0.009527 +14814 1 0.000206 1560.000000 0.003304 0.001336 0.008377 +14815 1 0.000240 1560.000000 -0.003006 -0.002382 0.003962 +14816 1 0.000232 1560.000000 -0.000894 0.003170 0.003029 +14817 1 0.000211 1560.000000 -0.001656 -0.002754 0.005352 +14818 1 0.000217 1560.000000 0.000082 -0.003076 0.001543 +14819 1 0.000267 1560.000000 -0.003401 -0.001758 0.004836 +14820 1 0.000202 1560.000000 0.002011 0.002997 0.008462 +14821 1 0.000228 1560.000000 0.000768 -0.002318 0.006853 +14822 1 0.000260 1560.000000 -0.002849 0.002246 0.005024 +14823 1 0.000212 1560.000000 0.003231 0.000596 0.007922 +14824 1 0.000202 1560.000000 -0.001074 0.001440 0.006558 +14825 1 0.000196 1560.000000 -0.001181 0.003427 0.004459 +14826 1 0.000208 1560.000000 0.003266 0.001064 0.003234 +14827 1 0.000247 1560.000000 0.002965 -0.000131 0.004250 +14828 1 0.000221 1560.000000 0.001847 0.000330 0.006061 +14829 1 0.000270 1560.000000 0.000147 0.001996 0.003391 +14830 1 0.000199 1560.000000 0.000176 0.001713 0.003452 +14831 1 0.000227 1560.000000 0.001530 0.000952 0.005481 +14832 1 0.000211 1560.000000 0.002258 0.002490 0.004906 +14833 1 0.000199 1560.000000 -0.000011 -0.001558 0.008478 +14834 1 0.000206 1560.000000 0.000910 -0.003269 0.001731 +14835 1 0.000254 1560.000000 0.001014 -0.001952 0.002998 +14836 1 0.000250 1560.000000 -0.001224 -0.001569 0.006416 +14837 1 0.000212 1560.000000 -0.000579 0.001427 0.002677 +14838 1 0.000256 1560.000000 -0.001238 0.002298 0.006297 +14839 1 0.000226 1560.000000 -0.000736 0.000925 0.001529 +14840 1 0.000206 1560.000000 0.001342 0.001539 0.005603 +14841 1 0.000196 1560.000000 -0.000874 0.003336 0.002559 +14842 1 0.000283 1560.000000 -0.000523 0.001163 0.004040 +14843 1 0.000230 1560.000000 -0.001504 -0.002141 0.004499 +14844 1 0.000241 1560.000000 0.001785 -0.000815 0.001544 +14845 1 0.000200 1560.000000 -0.002049 -0.002786 0.008509 +14846 1 0.000219 1560.000000 -0.002095 -0.000423 0.004769 +14847 1 0.000240 1560.000000 0.003004 -0.000481 0.000497 +14848 1 0.000233 1560.000000 0.001204 -0.001682 0.002120 +14849 1 0.000193 1560.000000 0.002995 -0.002325 0.009121 +14850 1 0.000200 1560.000000 0.000385 0.000821 0.008431 +14851 1 0.000249 1560.000000 0.002657 0.000544 0.000695 +14852 1 0.000194 1560.000000 -0.002488 -0.002813 0.002162 +14853 1 0.000210 1560.000000 -0.001466 0.000471 0.008079 +14854 1 0.000198 1560.000000 0.000971 0.000405 0.006058 +14855 1 0.000193 1560.000000 -0.002873 0.001727 0.005907 +14856 1 0.000256 1560.000000 -0.002191 0.001768 0.000502 +14857 1 0.000258 1560.000000 -0.000238 0.000319 0.007244 +14858 1 0.000215 1560.000000 0.002704 0.000276 0.006857 +14859 1 0.000258 1560.000000 0.001618 -0.003217 0.000659 +14860 1 0.000225 1560.000000 -0.001713 0.000422 0.007870 +14861 1 0.000202 1560.000000 0.002788 0.001005 0.002504 +14862 1 0.000196 1560.000000 0.000647 0.002463 0.001257 +14863 1 0.000226 1560.000000 -0.002150 0.001270 0.003802 +14864 1 0.000226 1560.000000 0.000123 -0.002961 0.005698 +14865 1 0.000223 1560.000000 0.002636 -0.002216 0.007727 +14866 1 0.000218 1560.000000 -0.000103 0.001094 0.009778 +14867 1 0.000206 1560.000000 -0.001455 0.000630 0.002913 +14868 1 0.000224 1560.000000 0.001300 -0.002395 0.006801 +14869 1 0.000264 1560.000000 -0.003168 0.000048 0.004135 +14870 1 0.000231 1560.000000 -0.001708 0.000403 0.006321 +14871 1 0.000238 1560.000000 -0.000764 0.001617 0.008154 +14872 1 0.000208 1560.000000 -0.001125 0.003536 0.006976 +14873 1 0.000225 1560.000000 0.001622 0.000210 0.000717 +14874 1 0.000259 1560.000000 -0.003359 0.001002 0.004797 +14875 1 0.000245 1560.000000 0.002136 0.000279 0.003007 +14876 1 0.000202 1560.000000 -0.001245 0.001671 0.002840 +14877 1 0.000196 1560.000000 0.000690 -0.000663 0.006697 +14878 1 0.000237 1560.000000 -0.000982 0.000462 0.003966 +14879 1 0.000262 1560.000000 0.002327 0.002845 0.009344 +14880 1 0.000215 1560.000000 0.002431 -0.000130 0.007012 +14881 1 0.000205 1560.000000 -0.001478 -0.001669 0.007170 +14882 1 0.000253 1560.000000 -0.001519 0.003017 0.008107 +14883 1 0.000279 1560.000000 0.001847 0.000657 0.009637 +14884 1 0.000208 1560.000000 0.000508 -0.001241 0.007627 +14885 1 0.000222 1560.000000 -0.002894 -0.001165 0.001663 +14886 1 0.000245 1560.000000 -0.002896 0.001535 0.009519 +14887 1 0.000198 1560.000000 -0.002118 0.000940 0.005220 +14888 1 0.000258 1560.000000 0.000262 0.002144 0.009007 +14889 1 0.000275 1560.000000 -0.002344 0.002028 0.001456 +14890 1 0.000210 1560.000000 -0.001968 -0.001537 0.009080 +14891 1 0.000212 1560.000000 -0.001736 0.000986 0.001800 +14892 1 0.000195 1560.000000 0.000101 -0.003222 0.001076 +14893 1 0.000221 1560.000000 -0.003381 0.000735 0.005032 +14894 1 0.000258 1560.000000 0.003576 0.001230 0.006467 +14895 1 0.000195 1560.000000 -0.003155 0.001184 0.007945 +14896 1 0.000208 1560.000000 -0.000294 0.001892 0.002124 +14897 1 0.000226 1560.000000 0.002448 -0.002959 0.000969 +14898 1 0.000253 1560.000000 0.000846 -0.002714 0.003807 +14899 1 0.000209 1560.000000 -0.000319 -0.002066 0.009393 +14900 1 0.000193 1560.000000 -0.003103 0.000634 0.003402 +14901 1 0.000218 1560.000000 0.003573 0.001197 0.006144 +14902 1 0.000204 1560.000000 -0.002133 -0.001706 0.007938 +14903 1 0.000216 1560.000000 -0.002814 0.002345 0.002531 +14904 1 0.000218 1560.000000 -0.001783 -0.000441 0.003684 +14905 1 0.000281 1560.000000 -0.001462 0.003160 0.009812 +14906 1 0.000211 1560.000000 -0.000990 -0.003082 0.001083 +14907 1 0.000252 1560.000000 0.001482 0.003157 0.002753 +14908 1 0.000219 1560.000000 0.000639 0.001047 0.004798 +14909 1 0.000218 1560.000000 -0.001418 -0.002644 0.004956 +14910 1 0.000254 1560.000000 0.002473 0.002393 0.007226 +14911 1 0.000241 1560.000000 -0.000458 0.003809 0.006641 +14912 1 0.000209 1560.000000 0.002929 0.002484 0.000151 +14913 1 0.000267 1560.000000 -0.001581 -0.001667 0.005767 +14914 1 0.000219 1560.000000 -0.001038 -0.001189 0.000603 +14915 1 0.000267 1560.000000 0.000779 0.002643 0.007826 +14916 1 0.000222 1560.000000 0.000667 0.001456 0.001864 +14917 1 0.000195 1560.000000 0.002452 -0.002847 0.006530 +14918 1 0.000226 1560.000000 -0.001225 -0.000391 0.004779 +14919 1 0.000278 1560.000000 0.003700 0.000610 0.007581 +14920 1 0.000195 1560.000000 -0.001846 0.002075 0.000614 +14921 1 0.000245 1560.000000 0.001723 0.000812 0.005523 +14922 1 0.000280 1560.000000 -0.003505 -0.000220 0.007973 +14923 1 0.000262 1560.000000 0.001429 0.002228 0.000138 +14924 1 0.000207 1560.000000 0.001068 0.003081 0.008886 +14925 1 0.000249 1560.000000 -0.000057 0.000910 0.002007 +14926 1 0.000193 1560.000000 -0.002341 0.001279 0.001316 +14927 1 0.000208 1560.000000 0.002621 -0.001713 0.002705 +14928 1 0.000200 1560.000000 0.001327 0.000610 0.008433 +14929 1 0.000280 1560.000000 0.003475 0.001555 0.008655 +14930 1 0.000201 1560.000000 0.003338 -0.001767 0.007013 +14931 1 0.000250 1560.000000 -0.000464 -0.002167 0.007449 +14932 1 0.000210 1560.000000 -0.001490 0.002041 0.003118 +14933 1 0.000217 1560.000000 0.000135 0.002487 0.004159 +14934 1 0.000193 1560.000000 0.001537 -0.001059 0.006638 +14935 1 0.000206 1560.000000 0.000591 0.000418 0.000996 +14936 1 0.000208 1560.000000 0.000515 -0.000432 0.008482 +14937 1 0.000233 1560.000000 -0.002652 -0.000693 0.001850 +14938 1 0.000254 1560.000000 0.002941 0.001120 0.004597 +14939 1 0.000201 1560.000000 -0.001322 -0.000431 0.008047 +14940 1 0.000255 1560.000000 0.000250 -0.003420 0.001269 +14941 1 0.000266 1560.000000 -0.000261 -0.003077 0.001459 +14942 1 0.000218 1560.000000 0.000168 -0.000108 0.007874 +14943 1 0.000262 1560.000000 0.003030 0.001707 0.009112 +14944 1 0.000264 1560.000000 0.000347 -0.003742 0.006629 +14945 1 0.000218 1560.000000 0.000481 0.001019 0.009809 +14946 1 0.000231 1560.000000 0.003181 0.001781 0.000804 +14947 1 0.000197 1560.000000 -0.002395 0.001428 0.009554 +14948 1 0.000240 1560.000000 -0.003134 -0.001988 0.008132 +14949 1 0.000278 1560.000000 -0.000810 0.002593 0.004131 +14950 1 0.000272 1560.000000 -0.003145 0.001758 0.001331 +14951 1 0.000248 1560.000000 -0.002517 -0.001753 0.008577 +14952 1 0.000257 1560.000000 -0.003050 -0.002264 0.004271 +14953 1 0.000282 1560.000000 -0.002610 -0.002216 0.006144 +14954 1 0.000221 1560.000000 -0.002106 -0.000622 0.004152 +14955 1 0.000255 1560.000000 -0.003070 -0.001058 0.003181 +14956 1 0.000210 1560.000000 0.000221 -0.001158 0.001937 +14957 1 0.000195 1560.000000 0.000825 0.003124 0.002764 +14958 1 0.000247 1560.000000 -0.002901 0.001757 0.000749 +14959 1 0.000281 1560.000000 0.001662 0.002664 0.008927 +14960 1 0.000262 1560.000000 0.000026 0.003679 0.007105 +14961 1 0.000207 1560.000000 -0.002138 0.002823 0.009524 +14962 1 0.000206 1560.000000 -0.002338 0.000164 0.008227 +14963 1 0.000245 1560.000000 0.000557 -0.003186 0.008827 +14964 1 0.000211 1560.000000 0.000171 0.002165 0.006364 +14965 1 0.000228 1560.000000 0.002898 0.001575 0.000932 +14966 1 0.000201 1560.000000 -0.000145 -0.003790 0.002171 +14967 1 0.000208 1560.000000 0.003154 -0.001701 0.007672 +14968 1 0.000282 1560.000000 0.003239 0.001424 0.007332 +14969 1 0.000213 1560.000000 -0.003168 -0.002037 0.004228 +14970 1 0.000262 1560.000000 0.000549 0.003536 0.003612 +14971 1 0.000215 1560.000000 -0.002760 -0.002405 0.009238 +14972 1 0.000192 1560.000000 -0.002550 0.002758 0.005466 +14973 1 0.000198 1560.000000 -0.000888 0.000894 0.009101 +14974 1 0.000283 1560.000000 0.001090 0.002973 0.001480 +14975 1 0.000201 1560.000000 0.002365 -0.002100 0.005544 +14976 1 0.000205 1560.000000 -0.000731 -0.001494 0.002672 +14977 1 0.000240 1560.000000 0.001133 -0.001229 0.003062 +14978 1 0.000266 1560.000000 -0.003221 0.001690 0.000769 +14979 1 0.000197 1560.000000 -0.000751 0.002916 0.006268 +14980 1 0.000288 1560.000000 0.000322 -0.003690 0.004171 +14981 1 0.000223 1560.000000 0.000242 0.002411 0.004364 +14982 1 0.000194 1560.000000 -0.001593 -0.003059 0.008577 +14983 1 0.000207 1560.000000 -0.001387 0.000001 0.004569 +14984 1 0.000259 1560.000000 0.001935 -0.000657 0.007965 +14985 1 0.000245 1560.000000 0.002057 0.001239 0.007760 +14986 1 0.000236 1560.000000 0.002386 -0.002848 0.003462 +14987 1 0.000201 1560.000000 -0.000239 0.001634 0.002157 +14988 1 0.000232 1560.000000 0.002372 0.001454 0.003865 +14989 1 0.000226 1560.000000 0.000815 -0.001922 0.008747 +14990 1 0.000277 1560.000000 -0.002684 0.001168 0.001005 +14991 1 0.000208 1560.000000 0.002929 -0.000299 0.008137 +14992 1 0.000279 1560.000000 -0.000975 0.002234 0.001382 +14993 1 0.000245 1560.000000 -0.000812 0.001416 0.008352 +14994 1 0.000211 1560.000000 -0.000110 0.001252 0.006842 +14995 1 0.000192 1560.000000 0.001116 -0.003599 0.002328 +14996 1 0.000207 1560.000000 -0.000585 -0.000933 0.001797 +14997 1 0.000221 1560.000000 -0.001026 0.001369 0.005377 +14998 1 0.000269 1560.000000 0.001073 0.003145 0.003979 +14999 1 0.000218 1560.000000 0.001647 0.000613 0.004335 +15000 1 0.000202 1560.000000 0.002589 0.001966 0.001600 +15001 1 0.000215 1560.000000 0.000156 0.003820 0.001839 +15002 1 0.000253 1560.000000 -0.002854 -0.002069 0.007618 +15003 1 0.000224 1560.000000 0.002147 0.001495 0.005829 +15004 1 0.000229 1560.000000 0.003412 0.001391 0.002992 +15005 1 0.000224 1560.000000 0.001255 -0.002987 0.002144 +15006 1 0.000238 1560.000000 0.002192 -0.000478 0.009636 +15007 1 0.000204 1560.000000 0.000926 0.001546 0.009112 +15008 1 0.000277 1560.000000 -0.001051 0.002286 0.004441 +15009 1 0.000207 1560.000000 0.002478 -0.000231 0.003831 +15010 1 0.000281 1560.000000 0.000502 -0.001401 0.002675 +15011 1 0.000195 1560.000000 -0.000836 0.000162 0.009010 +15012 1 0.000250 1560.000000 -0.002101 -0.001852 0.007378 +15013 1 0.000202 1560.000000 -0.002308 -0.001939 0.008069 +15014 1 0.000208 1560.000000 -0.001685 -0.002394 0.003345 +15015 1 0.000224 1560.000000 0.001433 -0.002908 0.008035 +15016 1 0.000197 1560.000000 -0.003204 0.001457 0.008986 +15017 1 0.000202 1560.000000 -0.000588 -0.000409 0.009233 +15018 1 0.000245 1560.000000 -0.003681 -0.000436 0.008885 +15019 1 0.000261 1560.000000 -0.001621 -0.001940 0.006374 +15020 1 0.000233 1560.000000 0.001639 -0.002003 0.005306 +15021 1 0.000242 1560.000000 -0.001377 -0.000406 0.007794 +15022 1 0.000282 1560.000000 0.001223 -0.003312 0.007557 +15023 1 0.000226 1560.000000 -0.002067 0.002955 0.006756 +15024 1 0.000285 1560.000000 0.003180 0.000926 0.009823 +15025 1 0.000193 1560.000000 0.000256 -0.003280 0.001641 +15026 1 0.000260 1560.000000 -0.002577 -0.002852 0.006760 +15027 1 0.000245 1560.000000 0.002724 0.002009 0.008790 +15028 1 0.000248 1560.000000 0.000707 -0.001422 0.002345 +15029 1 0.000267 1560.000000 -0.000007 0.003737 0.006038 +15030 1 0.000225 1560.000000 0.001597 -0.002557 0.004649 +15031 1 0.000230 1560.000000 -0.003078 -0.000605 0.005700 +15032 1 0.000213 1560.000000 -0.003657 0.001158 0.000164 +15033 1 0.000274 1560.000000 0.000966 0.002297 0.009237 +15034 1 0.000218 1560.000000 -0.001016 -0.001553 0.000964 +15035 1 0.000202 1560.000000 -0.000514 -0.000084 0.002774 +15036 1 0.000246 1560.000000 -0.001698 0.001308 0.006691 +15037 1 0.000265 1560.000000 0.000030 0.003018 0.005916 +15038 1 0.000205 1560.000000 0.000827 -0.003238 0.006367 +15039 1 0.000229 1560.000000 -0.002083 -0.000660 0.007487 +15040 1 0.000252 1560.000000 0.001655 -0.003378 0.003571 +15041 1 0.000245 1560.000000 0.000665 0.003713 0.000470 +15042 1 0.000279 1560.000000 0.000448 -0.003765 0.009792 +15043 1 0.000192 1560.000000 -0.000476 -0.002064 0.000143 +15044 1 0.000213 1560.000000 -0.000547 -0.003518 0.006027 +15045 1 0.000212 1560.000000 0.000593 0.000833 0.004625 +15046 1 0.000223 1560.000000 0.002019 -0.001867 0.005336 +15047 1 0.000229 1560.000000 -0.001769 0.002606 0.007700 +15048 1 0.000216 1560.000000 -0.003115 -0.000788 0.002839 +15049 1 0.000225 1560.000000 -0.002006 -0.000184 0.008070 +15050 1 0.000212 1560.000000 -0.002691 0.001156 0.002347 +15051 1 0.000203 1560.000000 -0.002591 -0.002124 0.009155 +15052 1 0.000208 1560.000000 0.001889 -0.001603 0.004463 +15053 1 0.000222 1560.000000 -0.000861 -0.001859 0.009482 +15054 1 0.000194 1560.000000 -0.000774 0.001360 0.003547 +15055 1 0.000229 1560.000000 -0.000923 -0.000772 0.004680 +15056 1 0.000270 1560.000000 -0.002696 0.002244 0.005835 +15057 1 0.000228 1560.000000 0.001972 0.002552 0.006141 +15058 1 0.000237 1560.000000 0.003303 0.001846 0.005675 +15059 1 0.000240 1560.000000 -0.003830 0.000267 0.001742 +15060 1 0.000277 1560.000000 0.002073 0.001266 0.000842 +15061 1 0.000230 1560.000000 -0.002603 -0.002824 0.007372 +15062 1 0.000208 1560.000000 0.001530 -0.000165 0.002666 +15063 1 0.000196 1560.000000 -0.002290 -0.001245 0.007999 +15064 1 0.000264 1560.000000 0.003361 0.000189 0.003009 +15065 1 0.000212 1560.000000 0.001418 0.002713 0.009393 +15066 1 0.000234 1560.000000 -0.000128 -0.003852 0.003165 +15067 1 0.000240 1560.000000 0.002742 0.001414 0.000199 +15068 1 0.000192 1560.000000 -0.001185 0.000101 0.004980 +15069 1 0.000195 1560.000000 0.001502 -0.002786 0.002865 +15070 1 0.000277 1560.000000 -0.002409 0.002550 0.002170 +15071 1 0.000269 1560.000000 0.002757 0.002620 0.009004 +15072 1 0.000211 1560.000000 -0.000972 -0.002246 0.005909 +15073 1 0.000229 1560.000000 -0.001603 -0.003373 0.001297 +15074 1 0.000268 1560.000000 -0.000357 0.002735 0.008402 +15075 1 0.000283 1560.000000 -0.002002 -0.002743 0.006797 +15076 1 0.000215 1560.000000 -0.000555 -0.003040 0.009741 +15077 1 0.000245 1560.000000 -0.000763 -0.003100 0.007260 +15078 1 0.000288 1560.000000 -0.001847 0.001607 0.004264 +15079 1 0.000204 1560.000000 0.002930 -0.002292 0.004263 +15080 1 0.000203 1560.000000 -0.000926 -0.001205 0.005441 +15081 1 0.000247 1560.000000 -0.002496 -0.002096 0.002091 +15082 1 0.000267 1560.000000 -0.001890 0.001279 0.001038 +15083 1 0.000209 1560.000000 0.002598 0.001233 0.003334 +15084 1 0.000209 1560.000000 -0.003773 0.000291 0.003214 +15085 1 0.000209 1560.000000 -0.000691 0.002394 0.001405 +15086 1 0.000235 1560.000000 -0.003768 -0.000696 0.008235 +15087 1 0.000224 1560.000000 0.003154 -0.002037 0.009715 +15088 1 0.000223 1560.000000 0.002050 0.000355 0.002555 +15089 1 0.000218 1560.000000 -0.000035 0.000118 0.006525 +15090 1 0.000261 1560.000000 0.000275 -0.000995 0.008464 +15091 1 0.000229 1560.000000 0.001230 0.001958 0.006436 +15092 1 0.000200 1560.000000 -0.000675 -0.000310 0.008072 +15093 1 0.000221 1560.000000 -0.000304 0.000763 0.004308 +15094 1 0.000281 1560.000000 -0.000876 -0.001641 0.009687 +15095 1 0.000222 1560.000000 -0.000196 -0.002243 0.005488 +15096 1 0.000243 1560.000000 0.001312 -0.000738 0.006298 +15097 1 0.000203 1560.000000 -0.002769 0.001721 0.003668 +15098 1 0.000277 1560.000000 -0.001623 -0.001355 0.005922 +15099 1 0.000207 1560.000000 0.001224 0.001565 0.000563 +15100 1 0.000261 1560.000000 0.001529 0.000152 0.006304 +15101 1 0.000251 1560.000000 -0.000896 0.002931 0.008675 +15102 1 0.000194 1560.000000 0.002686 0.001701 0.009631 +15103 1 0.000197 1560.000000 -0.000769 -0.002133 0.007378 +15104 1 0.000194 1560.000000 -0.002306 -0.002916 0.004438 +15105 1 0.000197 1560.000000 0.001733 -0.003181 0.001024 +15106 1 0.000276 1560.000000 -0.003368 0.001138 0.009176 +15107 1 0.000219 1560.000000 0.002934 0.001027 0.006059 +15108 1 0.000248 1560.000000 0.000602 -0.002418 0.004146 +15109 1 0.000203 1560.000000 0.001646 -0.001518 0.004574 +15110 1 0.000205 1560.000000 0.000656 0.001270 0.003851 +15111 1 0.000279 1560.000000 -0.001927 -0.001612 0.007207 +15112 1 0.000198 1560.000000 -0.001606 -0.003231 0.003592 +15113 1 0.000235 1560.000000 -0.003558 -0.000154 0.006663 +15114 1 0.000275 1560.000000 0.003071 -0.000693 0.003222 +15115 1 0.000267 1560.000000 -0.003843 0.000253 0.001042 +15116 1 0.000204 1560.000000 0.002202 0.000046 0.008584 +15117 1 0.000268 1560.000000 0.000839 0.002775 0.005678 +15118 1 0.000213 1560.000000 -0.002119 -0.002344 0.006330 +15119 1 0.000219 1560.000000 -0.003209 -0.001307 0.008504 +15120 1 0.000196 1560.000000 0.002794 -0.002588 0.005488 +15121 1 0.000197 1560.000000 0.002432 -0.000350 0.001848 +15122 1 0.000238 1560.000000 -0.002587 0.001490 0.000181 +15123 1 0.000246 1560.000000 -0.003152 0.000120 0.004517 +15124 1 0.000280 1560.000000 0.002956 0.000181 0.008136 +15125 1 0.000279 1560.000000 -0.001785 0.002533 0.001508 +15126 1 0.000242 1560.000000 -0.002732 0.001237 0.002629 +15127 1 0.000247 1560.000000 0.003844 0.000220 0.002298 +15128 1 0.000245 1560.000000 0.001574 -0.002272 0.001713 +15129 1 0.000194 1560.000000 0.000681 -0.000212 0.005200 +15130 1 0.000194 1560.000000 -0.001450 0.001643 0.007471 +15131 1 0.000206 1560.000000 -0.000037 -0.000693 0.005105 +15132 1 0.000199 1560.000000 0.002457 0.001420 0.008690 +15133 1 0.000279 1560.000000 0.003158 -0.002171 0.008262 +15134 1 0.000201 1560.000000 0.001350 0.000025 0.003650 +15135 1 0.000239 1560.000000 -0.001364 -0.003545 0.008020 +15136 1 0.000240 1560.000000 -0.002997 0.000786 0.001928 +15137 1 0.000226 1560.000000 0.000147 0.002242 0.000341 +15138 1 0.000228 1560.000000 0.001264 0.002909 0.004577 +15139 1 0.000264 1560.000000 -0.001088 -0.001360 0.005169 +15140 1 0.000220 1560.000000 -0.000333 0.001860 0.000541 +15141 1 0.000257 1560.000000 -0.003042 -0.000957 0.001643 +15142 1 0.000279 1560.000000 0.002030 0.000003 0.003225 +15143 1 0.000254 1560.000000 -0.001475 0.002604 0.004842 +15144 1 0.000225 1560.000000 -0.002817 -0.001952 0.003902 +15145 1 0.000216 1560.000000 0.002565 -0.001964 0.009379 +15146 1 0.000243 1560.000000 -0.001874 -0.000017 0.009589 +15147 1 0.000215 1560.000000 -0.003077 0.001751 0.002452 +15148 1 0.000204 1560.000000 0.001508 -0.001542 0.003414 +15149 1 0.000225 1560.000000 0.002195 0.000758 0.006864 +15150 1 0.000231 1560.000000 -0.003560 -0.001283 0.000720 +15151 1 0.000216 1560.000000 -0.000065 -0.002625 0.008728 +15152 1 0.000250 1560.000000 0.001282 0.001321 0.003923 +15153 1 0.000203 1560.000000 0.002100 -0.002223 0.003922 +15154 1 0.000212 1560.000000 0.002728 0.000025 0.008897 +15155 1 0.000267 1560.000000 0.003700 -0.000169 0.003276 +15156 1 0.000220 1560.000000 0.001423 0.001348 0.006290 +15157 1 0.000235 1560.000000 -0.001812 -0.003079 0.002263 +15158 1 0.000239 1560.000000 0.002374 -0.001192 0.002658 +15159 1 0.000253 1560.000000 0.002436 0.002891 0.009781 +15160 1 0.000195 1560.000000 -0.000829 0.003178 0.007471 +15161 1 0.000248 1560.000000 -0.000334 0.003722 0.002778 +15162 1 0.000196 1560.000000 -0.000443 0.002808 0.007740 +15163 1 0.000226 1560.000000 0.002747 -0.001718 0.001521 +15164 1 0.000222 1560.000000 0.000223 -0.000971 0.006412 +15165 1 0.000222 1560.000000 0.003012 -0.000948 0.008420 +15166 1 0.000218 1560.000000 0.000350 0.000934 0.004896 +15167 1 0.000219 1560.000000 0.003305 0.001492 0.001028 +15168 1 0.000257 1560.000000 0.003804 0.000533 0.008529 +15169 1 0.000288 1560.000000 0.001681 0.001984 0.002075 +15170 1 0.000227 1560.000000 0.001679 0.000482 0.003205 +15171 1 0.000272 1560.000000 -0.001350 0.001198 0.002917 +15172 1 0.000247 1560.000000 0.002912 0.000142 0.001545 +15173 1 0.000208 1560.000000 0.001216 0.000692 0.007490 +15174 1 0.000227 1560.000000 0.002383 -0.000792 0.007584 +15175 1 0.000259 1560.000000 0.003032 0.001377 0.001426 +15176 1 0.000255 1560.000000 -0.003033 0.000745 0.000216 +15177 1 0.000272 1560.000000 0.002448 -0.002414 0.003832 +15178 1 0.000280 1560.000000 0.000548 -0.001882 0.008158 +15179 1 0.000248 1560.000000 0.002617 -0.000183 0.001629 +15180 1 0.000287 1560.000000 -0.001675 0.001502 0.001141 +15181 1 0.000277 1560.000000 0.000228 0.002912 0.002644 +15182 1 0.000199 1560.000000 0.000766 0.001092 0.007232 +15183 1 0.000247 1560.000000 0.002052 0.000308 0.003552 +15184 1 0.000200 1560.000000 -0.003277 0.001959 0.009591 +15185 1 0.000276 1560.000000 0.003445 0.000739 0.007721 +15186 1 0.000234 1560.000000 -0.002497 0.001433 0.006898 +15187 1 0.000242 1560.000000 -0.000042 -0.003295 0.009538 +15188 1 0.000274 1560.000000 -0.001227 -0.002252 0.002323 +15189 1 0.000207 1560.000000 0.002600 -0.000201 0.000838 +15190 1 0.000216 1560.000000 -0.001727 0.001782 0.005297 +15191 1 0.000214 1560.000000 -0.003178 0.001873 0.009227 +15192 1 0.000241 1560.000000 0.000703 0.000840 0.000375 +15193 1 0.000209 1560.000000 0.001681 -0.000241 0.003633 +15194 1 0.000202 1560.000000 0.002310 0.003066 0.000949 +15195 1 0.000263 1560.000000 -0.002650 -0.000386 0.002836 +15196 1 0.000233 1560.000000 0.002034 -0.002689 0.009034 +15197 1 0.000202 1560.000000 0.001109 -0.001631 0.002922 +15198 1 0.000218 1560.000000 -0.001052 0.001015 0.005530 +15199 1 0.000205 1560.000000 -0.002332 -0.000379 0.005303 +15200 1 0.000242 1560.000000 0.002901 -0.001327 0.002707 +15201 1 0.000250 1560.000000 0.000196 0.002051 0.002022 +15202 1 0.000271 1560.000000 0.002266 -0.002402 0.000963 +15203 1 0.000265 1560.000000 0.000901 -0.003420 0.007488 +15204 1 0.000255 1560.000000 -0.003114 -0.000673 0.002511 +15205 1 0.000255 1560.000000 0.001451 0.001898 0.003563 +15206 1 0.000207 1560.000000 0.002677 -0.002350 0.007445 +15207 1 0.000233 1560.000000 -0.002440 0.000643 0.004060 +15208 1 0.000272 1560.000000 -0.000683 -0.002030 0.000325 +15209 1 0.000214 1560.000000 0.002997 -0.002222 0.009444 +15210 1 0.000193 1560.000000 -0.001428 -0.001761 0.000440 +15211 1 0.000217 1560.000000 0.002463 -0.000779 0.000407 +15212 1 0.000263 1560.000000 -0.000814 -0.002524 0.006740 +15213 1 0.000197 1560.000000 -0.001076 0.002507 0.002753 +15214 1 0.000220 1560.000000 0.002330 -0.000102 0.005552 +15215 1 0.000232 1560.000000 0.001069 -0.002190 0.003729 +15216 1 0.000203 1560.000000 -0.003012 -0.001526 0.006696 +15217 1 0.000230 1560.000000 0.001611 -0.001268 0.009173 +15218 1 0.000266 1560.000000 0.002084 -0.003235 0.007379 +15219 1 0.000246 1560.000000 -0.000637 -0.000434 0.000141 +15220 1 0.000199 1560.000000 0.001284 0.002078 0.001509 +15221 1 0.000222 1560.000000 -0.000537 -0.001626 0.009753 +15222 1 0.000201 1560.000000 -0.003343 -0.000943 0.007885 +15223 1 0.000217 1560.000000 -0.001380 0.001813 0.006847 +15224 1 0.000262 1560.000000 -0.000364 -0.003432 0.003277 +15225 1 0.000278 1560.000000 0.001722 0.002188 0.000520 +15226 1 0.000202 1560.000000 -0.000301 0.000057 0.002417 +15227 1 0.000286 1560.000000 0.002624 0.002802 0.001561 +15228 1 0.000229 1560.000000 0.002020 -0.002587 0.003764 +15229 1 0.000212 1560.000000 -0.000249 -0.002373 0.007741 +15230 1 0.000245 1560.000000 0.003677 -0.000985 0.000821 +15231 1 0.000280 1560.000000 -0.001726 0.000637 0.000264 +15232 1 0.000254 1560.000000 0.002359 -0.000194 0.004743 +15233 1 0.000252 1560.000000 0.001345 -0.002709 0.003333 +15234 1 0.000257 1560.000000 0.002667 -0.002169 0.003761 +15235 1 0.000229 1560.000000 0.000052 -0.001400 0.000864 +15236 1 0.000283 1560.000000 0.002987 0.002391 0.003939 +15237 1 0.000277 1560.000000 -0.001622 0.000804 0.004833 +15238 1 0.000206 1560.000000 0.000806 -0.003308 0.005865 +15239 1 0.000268 1560.000000 -0.000762 -0.003250 0.005267 +15240 1 0.000198 1560.000000 -0.002254 0.003060 0.006077 +15241 1 0.000229 1560.000000 0.002551 0.002012 0.004574 +15242 1 0.000207 1560.000000 0.002524 0.001588 0.001898 +15243 1 0.000248 1560.000000 -0.001474 -0.002521 0.006511 +15244 1 0.000215 1560.000000 0.003477 0.001545 0.005884 +15245 1 0.000228 1560.000000 -0.002252 -0.000639 0.002205 +15246 1 0.000207 1560.000000 0.000733 -0.001138 0.006050 +15247 1 0.000259 1560.000000 0.000007 -0.001947 0.008939 +15248 1 0.000225 1560.000000 0.001100 -0.001152 0.000711 +15249 1 0.000264 1560.000000 0.001457 -0.001586 0.005306 +15250 1 0.000253 1560.000000 0.001169 0.000265 0.004099 +15251 1 0.000200 1560.000000 0.003656 0.001085 0.003123 +15252 1 0.000197 1560.000000 -0.001688 -0.001612 0.008142 +15253 1 0.000194 1560.000000 -0.002606 -0.001288 0.001148 +15254 1 0.000204 1560.000000 -0.002997 -0.001126 0.005482 +15255 1 0.000228 1560.000000 -0.001748 -0.002471 0.004481 +15256 1 0.000217 1560.000000 -0.001763 -0.002334 0.009587 +15257 1 0.000262 1560.000000 -0.000941 0.003251 0.004725 +15258 1 0.000204 1560.000000 -0.001242 -0.000981 0.001800 +15259 1 0.000224 1560.000000 -0.001724 0.001299 0.001651 +15260 1 0.000265 1560.000000 -0.003223 -0.000656 0.003547 +15261 1 0.000197 1560.000000 0.000383 0.000721 0.005764 +15262 1 0.000281 1560.000000 0.003049 0.001583 0.005491 +15263 1 0.000238 1560.000000 0.000971 -0.000082 0.006200 +15264 1 0.000204 1560.000000 0.002513 0.002352 0.001676 +15265 1 0.000281 1560.000000 -0.001259 -0.002324 0.002753 +15266 1 0.000209 1560.000000 -0.001662 -0.000207 0.005556 +15267 1 0.000233 1560.000000 0.001817 -0.001853 0.003032 +15268 1 0.000250 1560.000000 -0.001812 -0.001254 0.006082 +15269 1 0.000227 1560.000000 0.003383 -0.000224 0.007097 +15270 1 0.000271 1560.000000 0.000449 0.001960 0.005260 +15271 1 0.000281 1560.000000 -0.000383 -0.003706 0.006554 +15272 1 0.000255 1560.000000 -0.003332 0.001362 0.004694 +15273 1 0.000198 1560.000000 -0.001210 -0.002142 0.007366 +15274 1 0.000246 1560.000000 0.003391 -0.001679 0.001303 +15275 1 0.000217 1560.000000 0.002033 -0.001431 0.005707 +15276 1 0.000268 1560.000000 0.000544 -0.002904 0.000751 +15277 1 0.000193 1560.000000 -0.002578 -0.001618 0.007552 +15278 1 0.000220 1560.000000 0.003367 -0.000800 0.007090 +15279 1 0.000280 1560.000000 -0.001520 0.002726 0.000646 +15280 1 0.000248 1560.000000 -0.000903 0.003024 0.001339 +15281 1 0.000193 1560.000000 0.003272 0.000273 0.009494 +15282 1 0.000205 1560.000000 0.003095 0.001782 0.000390 +15283 1 0.000228 1560.000000 -0.002631 -0.001283 0.002549 +15284 1 0.000243 1560.000000 0.002365 -0.000555 0.002304 +15285 1 0.000212 1560.000000 0.001687 0.002396 0.005667 +15286 1 0.000232 1560.000000 -0.001464 0.002188 0.004558 +15287 1 0.000230 1560.000000 -0.003305 -0.001878 0.004089 +15288 1 0.000282 1560.000000 -0.002635 -0.000980 0.003079 +15289 1 0.000200 1560.000000 0.001855 -0.002841 0.000518 +15290 1 0.000205 1560.000000 0.002418 -0.002612 0.000859 +15291 1 0.000209 1560.000000 0.001620 -0.003385 0.009080 +15292 1 0.000270 1560.000000 -0.002627 0.002768 0.000958 +15293 1 0.000224 1560.000000 0.000636 -0.000273 0.005964 +15294 1 0.000210 1560.000000 0.001328 0.002496 0.001581 +15295 1 0.000245 1560.000000 0.001992 -0.002870 0.006445 +15296 1 0.000214 1560.000000 0.001023 0.002926 0.002616 +15297 1 0.000248 1560.000000 -0.002666 -0.001883 0.002546 +15298 1 0.000218 1560.000000 0.003014 0.001106 0.004270 +15299 1 0.000199 1560.000000 -0.002635 0.001888 0.001604 +15300 1 0.000207 1560.000000 0.000831 -0.002485 0.004263 +15301 1 0.000220 1560.000000 -0.002661 -0.000834 0.006729 +15302 1 0.000200 1560.000000 -0.000127 -0.003247 0.006233 +15303 1 0.000222 1560.000000 -0.000981 -0.000340 0.004614 +15304 1 0.000215 1560.000000 0.001336 0.000607 0.007899 +15305 1 0.000209 1560.000000 0.001747 -0.002212 0.002000 +15306 1 0.000233 1560.000000 -0.001687 0.003416 0.002769 +15307 1 0.000204 1560.000000 -0.002032 0.000796 0.002634 +15308 1 0.000247 1560.000000 0.000941 0.001906 0.005676 +15309 1 0.000239 1560.000000 0.002821 -0.000238 0.004423 +15310 1 0.000205 1560.000000 -0.001152 0.001900 0.003035 +15311 1 0.000231 1560.000000 -0.001926 -0.002967 0.009588 +15312 1 0.000272 1560.000000 0.001672 -0.000723 0.004088 +15313 1 0.000224 1560.000000 0.002111 0.002286 0.008963 +15314 1 0.000231 1560.000000 0.001323 -0.003544 0.009428 +15315 1 0.000222 1560.000000 -0.001725 -0.000770 0.001093 +15316 1 0.000219 1560.000000 0.001497 -0.002134 0.003928 +15317 1 0.000252 1560.000000 0.002681 -0.002549 0.007032 +15318 1 0.000214 1560.000000 0.003330 -0.000391 0.007665 +15319 1 0.000208 1560.000000 -0.000623 0.000830 0.004609 +15320 1 0.000273 1560.000000 0.002269 0.002507 0.009501 +15321 1 0.000207 1560.000000 0.003743 0.000782 0.000231 +15322 1 0.000203 1560.000000 -0.002767 -0.002674 0.005495 +15323 1 0.000261 1560.000000 0.002882 -0.002477 0.005810 +15324 1 0.000201 1560.000000 0.001521 0.002022 0.000980 +15325 1 0.000209 1560.000000 -0.000362 -0.003652 0.003972 +15326 1 0.000245 1560.000000 -0.002998 -0.000740 0.004382 +15327 1 0.000213 1560.000000 -0.000896 -0.001433 0.007027 +15328 1 0.000274 1560.000000 0.003799 0.000519 0.003146 +15329 1 0.000227 1560.000000 0.001644 0.003180 0.004407 +15330 1 0.000215 1560.000000 0.000468 -0.002312 0.007217 +15331 1 0.000210 1560.000000 -0.002606 -0.002416 0.005497 +15332 1 0.000220 1560.000000 0.001003 0.001312 0.001444 +15333 1 0.000199 1560.000000 0.000235 0.002728 0.006404 +15334 1 0.000287 1560.000000 -0.000647 -0.003463 0.004908 +15335 1 0.000254 1560.000000 0.000614 0.001903 0.007833 +15336 1 0.000205 1560.000000 0.002190 -0.000430 0.005427 +15337 1 0.000192 1560.000000 -0.001852 0.001461 0.002114 +15338 1 0.000225 1560.000000 -0.000547 -0.000986 0.000333 +15339 1 0.000258 1560.000000 0.001850 0.001483 0.002153 +15340 1 0.000211 1560.000000 -0.003274 -0.000050 0.002409 +15341 1 0.000202 1560.000000 -0.001452 0.001546 0.009751 +15342 1 0.000239 1560.000000 -0.003384 -0.001481 0.005454 +15343 1 0.000205 1560.000000 0.000214 0.000915 0.003827 +15344 1 0.000224 1560.000000 -0.000914 0.003649 0.003472 +15345 1 0.000285 1560.000000 -0.000565 -0.001860 0.001324 +15346 1 0.000281 1560.000000 0.000503 0.000951 0.002045 +15347 1 0.000257 1560.000000 -0.001710 0.002370 0.005607 +15348 1 0.000256 1560.000000 0.003386 -0.000309 0.009543 +15349 1 0.000214 1560.000000 0.001530 -0.000573 0.008417 +15350 1 0.000219 1560.000000 0.001033 0.001144 0.006041 +15351 1 0.000247 1560.000000 -0.002440 0.002500 0.009094 +15352 1 0.000199 1560.000000 -0.002738 0.000213 0.003474 +15353 1 0.000210 1560.000000 0.003343 0.001326 0.006820 +15354 1 0.000250 1560.000000 -0.000623 -0.001435 0.008399 +15355 1 0.000198 1560.000000 -0.003351 0.001174 0.009499 +15356 1 0.000210 1560.000000 -0.000403 -0.003060 0.009112 +15357 1 0.000223 1560.000000 0.003498 -0.001287 0.008099 +15358 1 0.000260 1560.000000 -0.000356 0.003135 0.005157 +15359 1 0.000238 1560.000000 -0.001375 0.003533 0.007101 +15360 1 0.000268 1560.000000 -0.002723 0.001315 0.004908 +15361 1 0.000256 1560.000000 0.001243 -0.002288 0.007917 +15362 1 0.000244 1560.000000 0.002034 0.002200 0.008038 +15363 1 0.000237 1560.000000 0.000271 0.003435 0.003942 +15364 1 0.000210 1560.000000 -0.001537 0.000797 0.008790 +15365 1 0.000194 1560.000000 0.001354 0.003117 0.004042 +15366 1 0.000248 1560.000000 0.002117 -0.000853 0.000777 +15367 1 0.000207 1560.000000 0.003399 -0.000540 0.007844 +15368 1 0.000246 1560.000000 -0.002358 0.001098 0.007530 +15369 1 0.000230 1560.000000 0.002873 0.000822 0.000442 +15370 1 0.000201 1560.000000 -0.001979 0.002959 0.004752 +15371 1 0.000223 1560.000000 -0.003434 0.000200 0.005783 +15372 1 0.000225 1560.000000 -0.000750 -0.002455 0.002549 +15373 1 0.000204 1560.000000 0.002452 -0.001115 0.004050 +15374 1 0.000238 1560.000000 -0.000855 -0.001032 0.009084 +15375 1 0.000265 1560.000000 -0.000837 0.001190 0.006745 +15376 1 0.000211 1560.000000 0.001856 0.001285 0.003011 +15377 1 0.000246 1560.000000 -0.001674 -0.003027 0.006009 +15378 1 0.000252 1560.000000 -0.002690 -0.002214 0.000251 +15379 1 0.000224 1560.000000 0.001896 0.000501 0.004154 +15380 1 0.000234 1560.000000 0.000690 -0.001338 0.004286 +15381 1 0.000269 1560.000000 0.003507 -0.000329 0.008740 +15382 1 0.000225 1560.000000 -0.002016 0.000313 0.003487 +15383 1 0.000200 1560.000000 0.000832 0.002647 0.004373 +15384 1 0.000274 1560.000000 -0.000756 -0.001408 0.000151 +15385 1 0.000240 1560.000000 -0.001560 0.002933 0.001689 +15386 1 0.000197 1560.000000 -0.000985 -0.003200 0.000889 +15387 1 0.000225 1560.000000 -0.000804 -0.000122 0.003832 +15388 1 0.000196 1560.000000 0.000090 0.001790 0.008655 +15389 1 0.000245 1560.000000 -0.001866 -0.001599 0.004540 +15390 1 0.000262 1560.000000 0.000575 -0.000655 0.005738 +15391 1 0.000235 1560.000000 -0.002435 -0.001122 0.004611 +15392 1 0.000256 1560.000000 0.002713 -0.000597 0.007918 +15393 1 0.000217 1560.000000 0.002807 0.001933 0.005184 +15394 1 0.000192 1560.000000 -0.003066 -0.001317 0.005160 +15395 1 0.000200 1560.000000 -0.001159 0.001102 0.003463 +15396 1 0.000211 1560.000000 0.000302 -0.001819 0.002263 +15397 1 0.000207 1560.000000 -0.002209 -0.000701 0.000445 +15398 1 0.000286 1560.000000 0.002202 -0.000033 0.008071 +15399 1 0.000244 1560.000000 -0.001683 -0.000292 0.008674 +15400 1 0.000194 1560.000000 -0.002492 0.001327 0.005753 +15401 1 0.000267 1560.000000 -0.001294 0.002560 0.006469 +15402 1 0.000221 1560.000000 -0.003130 0.002116 0.000250 +15403 1 0.000212 1560.000000 0.000495 0.002053 0.002873 +15404 1 0.000268 1560.000000 0.000965 0.002210 0.006313 +15405 1 0.000260 1560.000000 0.002658 0.002256 0.002889 +15406 1 0.000217 1560.000000 -0.001134 -0.000408 0.008179 +15407 1 0.000222 1560.000000 0.002909 0.001938 0.008613 +15408 1 0.000215 1560.000000 -0.001673 0.001281 0.003563 +15409 1 0.000221 1560.000000 -0.000446 -0.001582 0.000160 +15410 1 0.000200 1560.000000 0.000485 0.001111 0.009245 +15411 1 0.000216 1560.000000 0.003176 -0.001563 0.001009 +15412 1 0.000197 1560.000000 0.001194 0.002852 0.003242 +15413 1 0.000231 1560.000000 -0.003255 -0.001690 0.008538 +15414 1 0.000225 1560.000000 0.001872 0.002474 0.001348 +15415 1 0.000248 1560.000000 0.003404 0.000058 0.002408 +15416 1 0.000206 1560.000000 0.002116 0.001824 0.004084 +15417 1 0.000210 1560.000000 0.003668 -0.000912 0.009603 +15418 1 0.000215 1560.000000 -0.003466 -0.000442 0.001177 +15419 1 0.000217 1560.000000 -0.001698 0.001810 0.000163 +15420 1 0.000213 1560.000000 -0.002045 0.003053 0.008175 +15421 1 0.000277 1560.000000 -0.002814 -0.001371 0.002260 +15422 1 0.000196 1560.000000 0.003409 0.000815 0.009120 +15423 1 0.000203 1560.000000 -0.002660 -0.000810 0.002427 +15424 1 0.000252 1560.000000 0.003619 0.001054 0.005712 +15425 1 0.000197 1560.000000 0.001511 -0.002395 0.003298 +15426 1 0.000266 1560.000000 0.003318 -0.001013 0.003635 +15427 1 0.000288 1560.000000 0.002554 0.002414 0.006933 +15428 1 0.000223 1560.000000 0.002651 -0.001151 0.002761 +15429 1 0.000225 1560.000000 0.003078 -0.000466 0.008592 +15430 1 0.000223 1560.000000 0.001331 0.001962 0.004864 +15431 1 0.000230 1560.000000 -0.000165 0.000652 0.000534 +15432 1 0.000245 1560.000000 -0.000013 0.002174 0.000750 +15433 1 0.000223 1560.000000 0.001748 -0.002809 0.004927 +15434 1 0.000267 1560.000000 0.001840 -0.002214 0.004410 +15435 1 0.000218 1560.000000 -0.002362 0.001643 0.009415 +15436 1 0.000208 1560.000000 -0.001120 0.002688 0.004097 +15437 1 0.000243 1560.000000 -0.001391 0.001801 0.007911 +15438 1 0.000278 1560.000000 0.002885 -0.000584 0.008316 +15439 1 0.000229 1560.000000 0.000260 -0.003349 0.005792 +15440 1 0.000212 1560.000000 0.000433 0.003401 0.002756 +15441 1 0.000218 1560.000000 -0.002397 -0.001468 0.001997 +15442 1 0.000268 1560.000000 -0.000912 -0.001611 0.002829 +15443 1 0.000239 1560.000000 0.001318 -0.000022 0.001739 +15444 1 0.000214 1560.000000 0.001599 0.000724 0.000895 +15445 1 0.000235 1560.000000 0.003073 -0.000346 0.006979 +15446 1 0.000259 1560.000000 0.003407 -0.001777 0.002934 +15447 1 0.000239 1560.000000 -0.002358 0.001099 0.004382 +15448 1 0.000229 1560.000000 -0.002698 0.001700 0.000895 +15449 1 0.000257 1560.000000 -0.000825 0.003755 0.005631 +15450 1 0.000281 1560.000000 -0.002684 -0.002043 0.006691 +15451 1 0.000228 1560.000000 -0.000722 -0.002243 0.006262 +15452 1 0.000209 1560.000000 0.002824 -0.001199 0.004211 +15453 1 0.000208 1560.000000 0.002125 0.001269 0.000112 +15454 1 0.000201 1560.000000 -0.000071 0.002315 0.002915 +15455 1 0.000254 1560.000000 -0.003088 0.000006 0.007172 +15456 1 0.000208 1560.000000 0.002307 0.001217 0.007280 +15457 1 0.000200 1560.000000 -0.001267 0.002400 0.003165 +15458 1 0.000241 1560.000000 -0.000413 0.002392 0.005261 +15459 1 0.000200 1560.000000 -0.000375 0.003452 0.000124 +15460 1 0.000222 1560.000000 0.001067 0.002453 0.002180 +15461 1 0.000202 1560.000000 0.000563 -0.002966 0.005411 +15462 1 0.000199 1560.000000 -0.001305 -0.001878 0.003132 +15463 1 0.000229 1560.000000 0.001707 0.001188 0.003999 +15464 1 0.000276 1560.000000 0.000270 -0.002048 0.004619 +15465 1 0.000250 1560.000000 0.000290 0.002374 0.009824 +15466 1 0.000219 1560.000000 0.000267 -0.003336 0.009747 +15467 1 0.000209 1560.000000 0.001621 0.002820 0.004204 +15468 1 0.000275 1560.000000 -0.000122 -0.003509 0.000195 +15469 1 0.000212 1560.000000 -0.001572 -0.003276 0.006466 +15470 1 0.000206 1560.000000 -0.002096 0.000866 0.000119 +15471 1 0.000225 1560.000000 -0.001254 0.001193 0.009069 +15472 1 0.000267 1560.000000 -0.000825 0.002484 0.008246 +15473 1 0.000286 1560.000000 0.003385 0.000956 0.008596 +15474 1 0.000195 1560.000000 -0.003490 -0.001449 0.003146 +15475 1 0.000195 1560.000000 -0.002029 -0.001201 0.000651 +15476 1 0.000213 1560.000000 0.001098 -0.001220 0.000318 +15477 1 0.000257 1560.000000 0.000075 0.001264 0.002614 +15478 1 0.000255 1560.000000 -0.000626 -0.001195 0.003245 +15479 1 0.000261 1560.000000 0.002630 -0.001571 0.007729 +15480 1 0.000193 1560.000000 0.002970 -0.000365 0.004081 +15481 1 0.000211 1560.000000 0.000099 0.003320 0.003541 +15482 1 0.000239 1560.000000 -0.002336 -0.001838 0.005397 +15483 1 0.000236 1560.000000 -0.003021 0.002307 0.008688 +15484 1 0.000246 1560.000000 0.001160 -0.002838 0.008719 +15485 1 0.000211 1560.000000 0.001799 -0.001936 0.007421 +15486 1 0.000195 1560.000000 -0.000190 -0.000457 0.004490 +15487 1 0.000199 1560.000000 -0.003152 -0.001349 0.009745 +15488 1 0.000222 1560.000000 0.001270 0.003093 0.004763 +15489 1 0.000240 1560.000000 0.000528 -0.002606 0.001346 +15490 1 0.000286 1560.000000 0.001971 0.001423 0.003435 +15491 1 0.000272 1560.000000 -0.001316 -0.001680 0.003640 +15492 1 0.000245 1560.000000 -0.003176 0.000211 0.006082 +15493 1 0.000200 1560.000000 0.002413 -0.000293 0.002238 +15494 1 0.000241 1560.000000 -0.001167 0.002315 0.007826 +15495 1 0.000225 1560.000000 -0.003370 -0.000914 0.004758 +15496 1 0.000258 1560.000000 -0.002283 -0.002461 0.007294 +15497 1 0.000230 1560.000000 -0.000014 -0.003158 0.002190 +15498 1 0.000252 1560.000000 -0.001586 -0.003482 0.005367 +15499 1 0.000235 1560.000000 0.001062 -0.000452 0.003141 +15500 1 0.000213 1560.000000 -0.000428 0.000032 0.005627 +15501 1 0.000259 1560.000000 -0.001976 0.000895 0.006663 +15502 1 0.000235 1560.000000 0.001187 0.000198 0.002119 +15503 1 0.000256 1560.000000 -0.000380 0.001766 0.006661 +15504 1 0.000243 1560.000000 -0.002414 -0.001526 0.002807 +15505 1 0.000288 1560.000000 0.001012 -0.003658 0.006224 +15506 1 0.000231 1560.000000 -0.003008 0.002109 0.008490 +15507 1 0.000261 1560.000000 0.001167 0.000267 0.008326 +15508 1 0.000220 1560.000000 0.001151 0.000590 0.005826 +15509 1 0.000281 1560.000000 -0.001614 -0.002579 0.009814 +15510 1 0.000198 1560.000000 0.001175 0.001735 0.006055 +15511 1 0.000196 1560.000000 0.002287 0.000578 0.006987 +15512 1 0.000197 1560.000000 0.000836 -0.000337 0.001295 +15513 1 0.000201 1560.000000 -0.000463 0.003271 0.004736 +15514 1 0.000265 1560.000000 -0.003195 -0.001860 0.003244 +15515 1 0.000248 1560.000000 -0.000363 0.002829 0.001341 +15516 1 0.000211 1560.000000 0.002489 0.000892 0.003579 +15517 1 0.000197 1560.000000 -0.000871 -0.003109 0.008434 +15518 1 0.000261 1560.000000 0.000472 -0.003061 0.006652 +15519 1 0.000284 1560.000000 0.003463 0.000120 0.004439 +15520 1 0.000209 1560.000000 -0.000176 -0.002994 0.007668 +15521 1 0.000269 1560.000000 -0.001655 0.001137 0.009254 +15522 1 0.000211 1560.000000 0.000431 0.000611 0.005284 +15523 1 0.000234 1560.000000 -0.000149 0.003852 0.002990 +15524 1 0.000216 1560.000000 0.000743 0.000618 0.008656 +15525 1 0.000266 1560.000000 -0.000996 -0.002445 0.004771 +15526 1 0.000236 1560.000000 -0.000781 -0.003739 0.007773 +15527 1 0.000195 1560.000000 -0.000453 0.003799 0.001471 +15528 1 0.000208 1560.000000 0.000863 -0.002908 0.009759 +15529 1 0.000198 1560.000000 -0.000648 -0.001795 0.007363 +15530 1 0.000244 1560.000000 -0.001261 0.002847 0.007692 +15531 1 0.000257 1560.000000 0.002522 -0.001567 0.008422 +15532 1 0.000268 1560.000000 -0.003590 0.001359 0.004980 +15533 1 0.000205 1560.000000 0.003283 -0.000111 0.008822 +15534 1 0.000220 1560.000000 -0.003643 -0.000398 0.001352 +15535 1 0.000202 1560.000000 0.001769 0.000187 0.004112 +15536 1 0.000198 1560.000000 -0.000315 -0.000409 0.007231 +15537 1 0.000194 1560.000000 0.000960 -0.002633 0.002291 +15538 1 0.000202 1560.000000 0.002225 0.000545 0.002939 +15539 1 0.000193 1560.000000 -0.000973 -0.001164 0.006263 +15540 1 0.000203 1560.000000 0.002223 0.001238 0.008581 +15541 1 0.000219 1560.000000 0.001353 -0.001470 0.006725 +15542 1 0.000248 1560.000000 -0.000963 0.000604 0.008712 +15543 1 0.000242 1560.000000 0.002161 0.003151 0.001466 +15544 1 0.000273 1560.000000 0.000223 0.002971 0.005411 +15545 1 0.000233 1560.000000 -0.002173 -0.001951 0.004588 +15546 1 0.000252 1560.000000 -0.003514 0.001545 0.000325 +15547 1 0.000245 1560.000000 0.003488 -0.000012 0.007080 +15548 1 0.000216 1560.000000 0.000824 -0.001582 0.008423 +15549 1 0.000202 1560.000000 -0.001403 -0.002237 0.005086 +15550 1 0.000255 1560.000000 0.003047 0.002314 0.006559 +15551 1 0.000215 1560.000000 -0.001510 0.000082 0.006932 +15552 1 0.000195 1560.000000 0.002541 -0.002817 0.002690 +15553 1 0.000222 1560.000000 -0.001641 -0.000910 0.002261 +15554 1 0.000244 1560.000000 -0.002219 -0.002110 0.003139 +15555 1 0.000209 1560.000000 -0.000566 -0.001278 0.002592 +15556 1 0.000199 1560.000000 -0.000666 -0.002686 0.005924 +15557 1 0.000244 1560.000000 -0.000506 0.003778 0.005903 +15558 1 0.000193 1560.000000 -0.001353 -0.001107 0.002960 +15559 1 0.000281 1560.000000 0.001405 -0.000147 0.001286 +15560 1 0.000250 1560.000000 0.000006 -0.002322 0.001166 +15561 1 0.000204 1560.000000 -0.000108 0.001210 0.004548 +15562 1 0.000247 1560.000000 -0.001292 -0.001307 0.003383 +15563 1 0.000218 1560.000000 0.003147 -0.000589 0.000864 +15564 1 0.000263 1560.000000 0.001496 -0.003507 0.000821 +15565 1 0.000254 1560.000000 0.003087 -0.002060 0.004537 +15566 1 0.000228 1560.000000 -0.001631 -0.001851 0.001231 +15567 1 0.000279 1560.000000 -0.000923 -0.002332 0.003445 +15568 1 0.000275 1560.000000 -0.002941 0.001997 0.004153 +15569 1 0.000213 1560.000000 -0.001568 0.001715 0.001747 +15570 1 0.000262 1560.000000 -0.001200 0.002458 0.003716 +15571 1 0.000228 1560.000000 0.000321 0.003239 0.005968 +15572 1 0.000194 1560.000000 0.000031 0.003327 0.002046 +15573 1 0.000204 1560.000000 0.002553 0.001497 0.009218 +15574 1 0.000200 1560.000000 0.002012 -0.002987 0.004905 +15575 1 0.000265 1560.000000 0.002048 -0.001765 0.001225 +15576 1 0.000241 1560.000000 -0.002284 0.002538 0.008151 +15577 1 0.000217 1560.000000 0.003775 -0.000455 0.008262 +15578 1 0.000278 1560.000000 -0.003370 0.000529 0.002299 +15579 1 0.000213 1560.000000 -0.000017 -0.001500 0.006680 +15580 1 0.000227 1560.000000 -0.001118 -0.003301 0.003800 +15581 1 0.000205 1560.000000 0.002721 -0.002630 0.002323 +15582 1 0.000210 1560.000000 -0.000657 -0.003587 0.002922 +15583 1 0.000205 1560.000000 -0.001320 -0.001287 0.002261 +15584 1 0.000262 1560.000000 0.001544 -0.000533 0.009239 +15585 1 0.000203 1560.000000 -0.001189 -0.000026 0.003529 +15586 1 0.000201 1560.000000 0.000764 -0.001544 0.001015 +15587 1 0.000216 1560.000000 0.000507 0.002109 0.007773 +15588 1 0.000220 1560.000000 -0.002047 -0.000378 0.003012 +15589 1 0.000226 1560.000000 0.000338 -0.001026 0.005775 +15590 1 0.000206 1560.000000 -0.002640 0.001868 0.005269 +15591 1 0.000203 1560.000000 -0.002422 0.001896 0.003284 +15592 1 0.000239 1560.000000 0.001455 -0.000877 0.006447 +15593 1 0.000238 1560.000000 -0.001730 0.002683 0.007157 +15594 1 0.000249 1560.000000 -0.000874 -0.001713 0.003407 +15595 1 0.000219 1560.000000 0.001603 0.001232 0.004528 +15596 1 0.000196 1560.000000 -0.002996 0.002320 0.002385 +15597 1 0.000235 1560.000000 0.000281 0.001984 0.007788 +15598 1 0.000212 1560.000000 0.000933 -0.000228 0.001531 +15599 1 0.000269 1560.000000 -0.003796 0.000072 0.003817 +15600 1 0.000204 1560.000000 -0.003774 -0.000769 0.000925 +15601 1 0.000204 1560.000000 -0.003070 -0.002289 0.008652 +15602 1 0.000208 1560.000000 -0.000795 0.001352 0.000978 +15603 1 0.000198 1560.000000 -0.000353 -0.000532 0.004913 +15604 1 0.000229 1560.000000 0.001647 0.000589 0.007409 +15605 1 0.000261 1560.000000 0.000671 0.001289 0.008668 +15606 1 0.000255 1560.000000 -0.001270 -0.001458 0.002457 +15607 1 0.000236 1560.000000 -0.003348 -0.001175 0.003586 +15608 1 0.000273 1560.000000 -0.002503 -0.002743 0.001919 +15609 1 0.000228 1560.000000 0.000442 0.002793 0.003681 +15610 1 0.000266 1560.000000 0.003426 0.000477 0.008833 +15611 1 0.000197 1560.000000 -0.000092 0.000787 0.008523 +15612 1 0.000254 1560.000000 -0.001104 -0.000992 0.009837 +15613 1 0.000208 1560.000000 -0.001306 -0.000355 0.001737 +15614 1 0.000256 1560.000000 -0.002321 0.001459 0.009049 +15615 1 0.000208 1560.000000 0.001632 0.002246 0.003925 +15616 1 0.000208 1560.000000 0.002092 -0.000061 0.005627 +15617 1 0.000195 1560.000000 -0.000346 0.000074 0.005413 +15618 1 0.000195 1560.000000 -0.001366 -0.003538 0.007382 +15619 1 0.000204 1560.000000 0.000328 0.002197 0.000840 +15620 1 0.000249 1560.000000 -0.001643 0.002977 0.000162 +15621 1 0.000219 1560.000000 0.000412 -0.002644 0.003254 +15622 1 0.000195 1560.000000 -0.000942 -0.001442 0.004376 +15623 1 0.000198 1560.000000 -0.000782 0.003473 0.005608 +15624 1 0.000263 1560.000000 0.002004 0.002981 0.006791 +15625 1 0.000206 1560.000000 0.000656 0.000340 0.002188 +15626 1 0.000203 1560.000000 -0.000556 -0.002413 0.004366 +15627 1 0.000270 1560.000000 -0.002215 -0.000330 0.001086 +15628 1 0.000241 1560.000000 0.001729 -0.001487 0.005457 +15629 1 0.000209 1560.000000 0.003061 -0.001866 0.007146 +15630 1 0.000192 1560.000000 -0.002955 -0.000276 0.003708 +15631 1 0.000225 1560.000000 -0.002529 0.000022 0.009273 +15632 1 0.000274 1560.000000 -0.001994 0.003275 0.008658 +15633 1 0.000238 1560.000000 0.000367 0.002493 0.006470 +15634 1 0.000285 1560.000000 -0.003635 0.000698 0.000768 +15635 1 0.000267 1560.000000 -0.003785 -0.000231 0.003723 +15636 1 0.000227 1560.000000 -0.000262 -0.001078 0.002337 +15637 1 0.000194 1560.000000 0.002258 0.001162 0.005936 +15638 1 0.000204 1560.000000 -0.002313 -0.000729 0.001361 +15639 1 0.000208 1560.000000 0.002700 0.000255 0.005884 +15640 1 0.000225 1560.000000 0.002736 0.000668 0.009821 +15641 1 0.000234 1560.000000 0.000212 -0.003329 0.003254 +15642 1 0.000197 1560.000000 -0.000409 -0.001683 0.000734 +15643 1 0.000194 1560.000000 0.001141 0.000237 0.007105 +15644 1 0.000220 1560.000000 0.000296 0.002210 0.008015 +15645 1 0.000231 1560.000000 0.001572 -0.001847 0.000881 +15646 1 0.000229 1560.000000 -0.003523 0.001532 0.004594 +15647 1 0.000260 1560.000000 0.000934 0.003737 0.006889 +15648 1 0.000247 1560.000000 0.000318 0.001047 0.000509 +15649 1 0.000200 1560.000000 0.001410 0.000927 0.008825 +15650 1 0.000202 1560.000000 0.000409 -0.003818 0.003048 +15651 1 0.000214 1560.000000 0.000660 0.001707 0.008744 +15652 1 0.000230 1560.000000 -0.002419 -0.001621 0.007003 +15653 1 0.000266 1560.000000 0.003146 -0.000941 0.002849 +15654 1 0.000285 1560.000000 0.000355 -0.003068 0.006336 +15655 1 0.000242 1560.000000 0.003155 0.000458 0.008720 +15656 1 0.000253 1560.000000 0.003181 -0.000377 0.005715 +15657 1 0.000198 1560.000000 0.000445 0.001475 0.004213 +15658 1 0.000258 1560.000000 0.002337 0.002370 0.008077 +15659 1 0.000210 1560.000000 -0.000259 -0.002924 0.003401 +15660 1 0.000221 1560.000000 -0.000494 -0.002936 0.004657 +15661 1 0.000274 1560.000000 -0.000986 -0.000131 0.007533 +15662 1 0.000248 1560.000000 -0.001341 -0.000901 0.003771 +15663 1 0.000223 1560.000000 0.002264 0.000602 0.009426 +15664 1 0.000267 1560.000000 -0.001525 0.002467 0.002024 +15665 1 0.000223 1560.000000 0.002385 -0.001100 0.003761 +15666 1 0.000203 1560.000000 -0.000514 0.001748 0.001346 +15667 1 0.000227 1560.000000 -0.001602 -0.001564 0.006917 +15668 1 0.000201 1560.000000 0.000951 0.002650 0.000751 +15669 1 0.000206 1560.000000 0.001217 0.002286 0.006194 +15670 1 0.000233 1560.000000 -0.002211 0.002464 0.000608 +15671 1 0.000196 1560.000000 -0.003425 0.001472 0.001375 +15672 1 0.000248 1560.000000 -0.000952 0.003136 0.008267 +15673 1 0.000193 1560.000000 -0.000313 -0.002984 0.007520 +15674 1 0.000214 1560.000000 0.000383 -0.001669 0.002669 +15675 1 0.000221 1560.000000 -0.000858 0.000463 0.006046 +15676 1 0.000241 1560.000000 0.002219 -0.002234 0.002719 +15677 1 0.000220 1560.000000 0.001277 0.001013 0.009615 +15678 1 0.000288 1560.000000 -0.003417 -0.001742 0.002167 +15679 1 0.000244 1560.000000 -0.001354 -0.002853 0.002817 +15680 1 0.000286 1560.000000 0.003753 -0.000722 0.001922 +15681 1 0.000257 1560.000000 0.002064 -0.001436 0.001257 +15682 1 0.000206 1560.000000 -0.003054 -0.001638 0.008394 +15683 1 0.000264 1560.000000 0.001007 0.002055 0.007830 +15684 1 0.000215 1560.000000 -0.000092 0.003073 0.000604 +15685 1 0.000193 1560.000000 -0.003017 0.000615 0.002608 +15686 1 0.000250 1560.000000 -0.000421 -0.000936 0.004473 +15687 1 0.000195 1560.000000 -0.000585 -0.000117 0.005635 +15688 1 0.000199 1560.000000 0.000712 0.000677 0.003320 +15689 1 0.000210 1560.000000 0.000287 -0.001282 0.009073 +15690 1 0.000217 1560.000000 -0.001678 -0.003465 0.001798 +15691 1 0.000252 1560.000000 -0.001239 -0.003641 0.009146 +15692 1 0.000286 1560.000000 0.003327 -0.001842 0.007949 +15693 1 0.000207 1560.000000 0.001297 0.002877 0.005079 +15694 1 0.000212 1560.000000 -0.001096 -0.002501 0.005314 +15695 1 0.000218 1560.000000 0.003256 -0.000587 0.001863 +15696 1 0.000231 1560.000000 0.000120 0.001642 0.006355 +15697 1 0.000274 1560.000000 -0.000430 -0.002524 0.003501 +15698 1 0.000257 1560.000000 -0.000720 0.000363 0.001573 +15699 1 0.000287 1560.000000 -0.002663 -0.001690 0.006424 +15700 1 0.000270 1560.000000 -0.001249 0.002796 0.000731 +15701 1 0.000274 1560.000000 -0.001123 0.000398 0.000689 +15702 1 0.000195 1560.000000 0.003227 -0.001300 0.005511 +15703 1 0.000255 1560.000000 -0.000660 0.003626 0.008559 +15704 1 0.000249 1560.000000 -0.002120 0.000675 0.005332 +15705 1 0.000199 1560.000000 -0.001734 -0.003306 0.008030 +15706 1 0.000288 1560.000000 0.002937 -0.001531 0.007083 +15707 1 0.000248 1560.000000 -0.001770 0.002127 0.001048 +15708 1 0.000229 1560.000000 -0.001587 0.000560 0.003848 +15709 1 0.000263 1560.000000 0.000966 -0.003579 0.009571 +15710 1 0.000225 1560.000000 0.000724 0.000131 0.004572 +15711 1 0.000221 1560.000000 -0.001103 -0.003245 0.000375 +15712 1 0.000246 1560.000000 0.002646 -0.002190 0.003352 +15713 1 0.000230 1560.000000 0.003301 -0.000618 0.003936 +15714 1 0.000285 1560.000000 -0.003300 0.000886 0.003402 +15715 1 0.000211 1560.000000 0.001695 -0.003216 0.005544 +15716 1 0.000281 1560.000000 0.003123 0.001486 0.009241 +15717 1 0.000244 1560.000000 -0.001138 -0.000365 0.009427 +15718 1 0.000200 1560.000000 -0.000178 -0.001163 0.001503 +15719 1 0.000206 1560.000000 -0.001556 -0.001286 0.004275 +15720 1 0.000220 1560.000000 0.002229 -0.002833 0.000143 +15721 1 0.000208 1560.000000 0.002701 0.002465 0.007279 +15722 1 0.000209 1560.000000 -0.002886 0.002147 0.009059 +15723 1 0.000199 1560.000000 -0.000123 0.001912 0.009444 +15724 1 0.000266 1560.000000 -0.002799 0.001697 0.008112 +15725 1 0.000196 1560.000000 0.000420 0.001451 0.006748 +15726 1 0.000215 1560.000000 0.000038 0.002499 0.005304 +15727 1 0.000228 1560.000000 -0.000472 -0.000325 0.000656 +15728 1 0.000211 1560.000000 -0.001726 -0.001974 0.000497 +15729 1 0.000287 1560.000000 -0.000669 0.002727 0.001438 +15730 1 0.000278 1560.000000 0.002246 0.001265 0.001802 +15731 1 0.000193 1560.000000 -0.000503 0.000273 0.005982 +15732 1 0.000196 1560.000000 -0.001700 -0.000921 0.003352 +15733 1 0.000195 1560.000000 -0.002328 -0.000538 0.002518 +15734 1 0.000235 1560.000000 -0.001760 -0.001453 0.001629 +15735 1 0.000271 1560.000000 0.001434 0.000635 0.008779 +15736 1 0.000224 1560.000000 0.002426 -0.001446 0.002715 +15737 1 0.000194 1560.000000 -0.000457 0.001582 0.002089 +15738 1 0.000283 1560.000000 -0.003484 0.001624 0.001893 +15739 1 0.000255 1560.000000 0.000593 0.002744 0.004900 +15740 1 0.000207 1560.000000 -0.001659 0.000789 0.004442 +15741 1 0.000227 1560.000000 0.002377 0.002199 0.004160 +15742 1 0.000277 1560.000000 0.002327 0.000163 0.009731 +15743 1 0.000194 1560.000000 -0.001069 0.002527 0.000826 +15744 1 0.000220 1560.000000 -0.000412 -0.003732 0.001276 +15745 1 0.000200 1560.000000 0.001062 0.002073 0.004266 +15746 1 0.000219 1560.000000 0.000502 0.000316 0.008782 +15747 1 0.000247 1560.000000 -0.001909 -0.002997 0.006230 +15748 1 0.000219 1560.000000 -0.002757 0.001819 0.006637 +15749 1 0.000213 1560.000000 -0.001876 -0.001376 0.008064 +15750 1 0.000233 1560.000000 0.002994 0.001971 0.003800 +15751 1 0.000273 1560.000000 0.001419 0.002982 0.005292 +15752 1 0.000210 1560.000000 0.000871 -0.001462 0.008949 +15753 1 0.000253 1560.000000 -0.003384 -0.001100 0.006030 +15754 1 0.000210 1560.000000 0.002533 0.000455 0.004146 +15755 1 0.000261 1560.000000 0.002373 -0.001851 0.006253 +15756 1 0.000192 1560.000000 0.003268 0.000494 0.005136 +15757 1 0.000207 1560.000000 0.002111 -0.001501 0.007503 +15758 1 0.000270 1560.000000 -0.002569 -0.001826 0.006841 +15759 1 0.000233 1560.000000 0.002857 0.001900 0.006892 +15760 1 0.000245 1560.000000 0.002659 -0.001814 0.008452 +15761 1 0.000211 1560.000000 -0.002123 -0.000911 0.003434 +15762 1 0.000213 1560.000000 -0.000002 -0.001728 0.004089 +15763 1 0.000259 1560.000000 -0.001075 0.003617 0.000152 +15764 1 0.000210 1560.000000 -0.001162 0.000603 0.001962 +15765 1 0.000288 1560.000000 0.001569 0.001669 0.007508 +15766 1 0.000216 1560.000000 -0.001420 -0.002999 0.006890 +15767 1 0.000258 1560.000000 0.002244 0.001182 0.000339 +15768 1 0.000199 1560.000000 0.001876 -0.002826 0.009610 +15769 1 0.000195 1560.000000 -0.001848 0.001070 0.000643 +15770 1 0.000204 1560.000000 0.000108 -0.000649 0.005436 +15771 1 0.000268 1560.000000 0.000734 0.000982 0.003733 +15772 1 0.000231 1560.000000 -0.000307 0.003470 0.001368 +15773 1 0.000248 1560.000000 -0.000434 -0.000724 0.009802 +15774 1 0.000223 1560.000000 -0.002413 -0.000903 0.003358 +15775 1 0.000198 1560.000000 -0.001886 -0.002564 0.001221 +15776 1 0.000231 1560.000000 0.002710 0.001308 0.005126 +15777 1 0.000248 1560.000000 0.001189 0.002437 0.004079 +15778 1 0.000230 1560.000000 -0.001208 -0.001201 0.009734 +15779 1 0.000251 1560.000000 -0.001331 0.000113 0.003024 +15780 1 0.000201 1560.000000 0.003014 -0.000872 0.002312 +15781 1 0.000227 1560.000000 0.000887 0.000448 0.002338 +15782 1 0.000283 1560.000000 0.001938 0.003060 0.002554 +15783 1 0.000217 1560.000000 -0.000756 0.002306 0.004722 +15784 1 0.000259 1560.000000 -0.003386 0.000256 0.006707 +15785 1 0.000272 1560.000000 -0.002042 0.001702 0.009378 +15786 1 0.000213 1560.000000 0.001014 0.001096 0.003759 +15787 1 0.000247 1560.000000 -0.002667 0.000270 0.006872 +15788 1 0.000288 1560.000000 -0.002062 0.002957 0.009840 +15789 1 0.000198 1560.000000 -0.001785 0.000288 0.003077 +15790 1 0.000239 1560.000000 0.002092 0.001616 0.008080 +15791 1 0.000239 1560.000000 0.003037 -0.000614 0.006935 +15792 1 0.000251 1560.000000 -0.003204 0.001304 0.003947 +15793 1 0.000215 1560.000000 0.001727 -0.003327 0.008287 +15794 1 0.000274 1560.000000 0.003023 -0.002284 0.007440 +15795 1 0.000212 1560.000000 -0.002038 0.002135 0.009249 +15796 1 0.000248 1560.000000 -0.002146 0.000101 0.006065 +15797 1 0.000261 1560.000000 0.002208 0.002839 0.007148 +15798 1 0.000210 1560.000000 -0.001586 -0.000433 0.002958 +15799 1 0.000204 1560.000000 0.001137 0.001311 0.000689 +15800 1 0.000196 1560.000000 0.003067 0.000817 0.005268 +15801 1 0.000271 1560.000000 -0.000923 -0.002127 0.000990 +15802 1 0.000270 1560.000000 -0.003251 -0.001952 0.009099 +15803 1 0.000272 1560.000000 -0.001954 -0.002987 0.007442 +15804 1 0.000196 1560.000000 -0.002413 -0.000975 0.000485 +15805 1 0.000228 1560.000000 0.000689 0.002885 0.001340 +15806 1 0.000199 1560.000000 -0.001788 0.002686 0.005523 +15807 1 0.000204 1560.000000 0.003773 -0.000236 0.008124 +15808 1 0.000251 1560.000000 -0.000488 0.002514 0.008511 +15809 1 0.000208 1560.000000 0.000789 0.002044 0.006999 +15810 1 0.000209 1560.000000 -0.000361 -0.000911 0.002631 +15811 1 0.000232 1560.000000 -0.000145 0.000740 0.009501 +15812 1 0.000223 1560.000000 0.003389 0.001252 0.003458 +15813 1 0.000219 1560.000000 0.001284 -0.001570 0.007100 +15814 1 0.000242 1560.000000 -0.002828 -0.001849 0.002898 +15815 1 0.000201 1560.000000 -0.001187 0.000835 0.001941 +15816 1 0.000268 1560.000000 -0.002371 -0.001399 0.004588 +15817 1 0.000253 1560.000000 -0.001874 0.001831 0.001227 +15818 1 0.000223 1560.000000 -0.001431 -0.003391 0.001997 +15819 1 0.000203 1560.000000 -0.003558 0.001181 0.004145 +15820 1 0.000224 1560.000000 -0.000705 -0.001572 0.003119 +15821 1 0.000280 1560.000000 -0.001351 0.001841 0.007605 +15822 1 0.000213 1560.000000 -0.001183 0.003492 0.004951 +15823 1 0.000273 1560.000000 -0.001852 -0.002123 0.004840 +15824 1 0.000232 1560.000000 0.001617 0.003489 0.001937 +15825 1 0.000224 1560.000000 -0.001325 0.001176 0.000537 +15826 1 0.000203 1560.000000 0.001306 0.001285 0.002010 +15827 1 0.000224 1560.000000 -0.000215 -0.002347 0.000731 +15828 1 0.000251 1560.000000 0.002188 0.003100 0.006371 +15829 1 0.000198 1560.000000 0.001991 -0.002615 0.001495 +15830 1 0.000272 1560.000000 0.002333 -0.001776 0.009806 +15831 1 0.000235 1560.000000 0.000575 -0.000580 0.003591 +15832 1 0.000221 1560.000000 -0.002745 0.000227 0.006172 +15833 1 0.000259 1560.000000 0.003052 -0.000857 0.005987 +15834 1 0.000207 1560.000000 -0.002498 -0.000380 0.002613 +15835 1 0.000242 1560.000000 0.002126 0.002400 0.004199 +15836 1 0.000212 1560.000000 0.000333 -0.003779 0.000125 +15837 1 0.000270 1560.000000 -0.001047 0.001439 0.007111 +15838 1 0.000251 1560.000000 0.000907 -0.003703 0.002375 +15839 1 0.000276 1560.000000 -0.003024 -0.000893 0.009046 +15840 1 0.000209 1560.000000 0.002599 0.002200 0.006561 +15841 1 0.000198 1560.000000 -0.000225 0.003648 0.005561 +15842 1 0.000193 1560.000000 -0.001952 -0.001151 0.007208 +15843 1 0.000242 1560.000000 -0.001922 0.002925 0.005358 +15844 1 0.000259 1560.000000 0.002719 -0.001342 0.006988 +15845 1 0.000214 1560.000000 -0.001384 0.001275 0.003830 +15846 1 0.000241 1560.000000 0.000647 0.002545 0.000319 +15847 1 0.000267 1560.000000 -0.000968 -0.003148 0.009824 +15848 1 0.000197 1560.000000 -0.002430 -0.002991 0.000178 +15849 1 0.000231 1560.000000 -0.001076 -0.003372 0.008007 +15850 1 0.000265 1560.000000 0.000375 -0.002760 0.000932 +15851 1 0.000260 1560.000000 -0.003702 0.000780 0.005673 +15852 1 0.000206 1560.000000 0.002981 -0.000560 0.005118 +15853 1 0.000195 1560.000000 -0.000899 -0.000063 0.004304 +15854 1 0.000261 1560.000000 -0.001847 -0.001348 0.005181 +15855 1 0.000215 1560.000000 -0.003074 0.001526 0.009185 +15856 1 0.000258 1560.000000 0.003769 0.000630 0.005670 +15857 1 0.000219 1560.000000 -0.001752 0.002175 0.009051 +15858 1 0.000210 1560.000000 -0.000387 -0.000793 0.008527 +15859 1 0.000249 1560.000000 0.003027 -0.000569 0.005812 +15860 1 0.000212 1560.000000 0.000895 -0.001202 0.003637 +15861 1 0.000199 1560.000000 0.000028 0.001433 0.001968 +15862 1 0.000247 1560.000000 -0.000975 -0.002717 0.006803 +15863 1 0.000238 1560.000000 0.001133 -0.000594 0.004439 +15864 1 0.000263 1560.000000 0.000603 -0.003271 0.007189 +15865 1 0.000211 1560.000000 0.000045 -0.003594 0.005290 +15866 1 0.000274 1560.000000 0.002836 -0.002519 0.000618 +15867 1 0.000225 1560.000000 0.000907 0.000868 0.008274 +15868 1 0.000246 1560.000000 0.001191 -0.002239 0.002544 +15869 1 0.000236 1560.000000 -0.002641 -0.001429 0.002757 +15870 1 0.000213 1560.000000 -0.002006 0.002893 0.007432 +15871 1 0.000245 1560.000000 -0.001231 0.002311 0.009339 +15872 1 0.000205 1560.000000 0.001395 -0.001880 0.005931 +15873 1 0.000194 1560.000000 0.002343 0.000426 0.003953 +15874 1 0.000211 1560.000000 -0.001499 -0.000981 0.001019 +15875 1 0.000198 1560.000000 -0.000905 -0.002974 0.002076 +15876 1 0.000238 1560.000000 -0.000077 0.001660 0.004818 +15877 1 0.000212 1560.000000 0.000366 -0.003818 0.008160 +15878 1 0.000239 1560.000000 -0.003223 -0.001986 0.003625 +15879 1 0.000218 1560.000000 -0.001823 -0.000332 0.006060 +15880 1 0.000259 1560.000000 -0.001941 -0.001029 0.006488 +15881 1 0.000264 1560.000000 0.001177 -0.001817 0.000256 +15882 1 0.000194 1560.000000 0.003127 -0.000306 0.001900 +15883 1 0.000194 1560.000000 -0.000076 0.000313 0.004816 +15884 1 0.000256 1560.000000 0.001414 -0.001787 0.003396 +15885 1 0.000194 1560.000000 0.000356 0.003379 0.006288 +15886 1 0.000240 1560.000000 -0.002502 -0.002076 0.009365 +15887 1 0.000211 1560.000000 0.001677 -0.002479 0.001974 +15888 1 0.000278 1560.000000 0.001924 0.002805 0.003343 +15889 1 0.000207 1560.000000 -0.001387 0.003115 0.008532 +15890 1 0.000234 1560.000000 -0.000225 0.002945 0.009334 +15891 1 0.000204 1560.000000 -0.002127 0.002953 0.002988 +15892 1 0.000250 1560.000000 -0.001284 0.002834 0.008081 +15893 1 0.000279 1560.000000 0.002934 -0.001470 0.008812 +15894 1 0.000263 1560.000000 0.003430 0.000054 0.005718 +15895 1 0.000260 1560.000000 -0.001723 -0.003410 0.000690 +15896 1 0.000287 1560.000000 0.000540 0.002737 0.009247 +15897 1 0.000277 1560.000000 -0.003097 -0.001739 0.001943 +15898 1 0.000233 1560.000000 0.002656 -0.002649 0.004556 +15899 1 0.000193 1560.000000 -0.002507 0.001032 0.008450 +15900 1 0.000239 1560.000000 0.000876 -0.003200 0.002114 +15901 1 0.000225 1560.000000 0.002766 0.002170 0.004909 +15902 1 0.000221 1560.000000 0.002608 -0.001796 0.005905 +15903 1 0.000262 1560.000000 -0.000339 -0.001686 0.002956 +15904 1 0.000204 1560.000000 0.001695 0.000028 0.008720 +15905 1 0.000227 1560.000000 0.000538 -0.002204 0.005358 +15906 1 0.000214 1560.000000 0.000973 0.001435 0.009528 +15907 1 0.000203 1560.000000 -0.002062 0.000497 0.006150 +15908 1 0.000216 1560.000000 0.003403 0.000095 0.008527 +15909 1 0.000197 1560.000000 0.000928 0.002747 0.004855 +15910 1 0.000201 1560.000000 0.002515 -0.001664 0.004586 +15911 1 0.000193 1560.000000 0.000725 0.002953 0.003357 +15912 1 0.000276 1560.000000 0.000304 0.001550 0.000742 +15913 1 0.000231 1560.000000 0.001717 -0.000535 0.005766 +15914 1 0.000241 1560.000000 0.000793 -0.001963 0.002212 +15915 1 0.000231 1560.000000 -0.003444 0.001566 0.005389 +15916 1 0.000222 1560.000000 0.000278 0.003150 0.006208 +15917 1 0.000244 1560.000000 -0.000717 0.003199 0.000126 +15918 1 0.000241 1560.000000 -0.000345 -0.001929 0.003446 +15919 1 0.000276 1560.000000 -0.000225 0.003815 0.009801 +15920 1 0.000212 1560.000000 0.000485 -0.000189 0.000327 +15921 1 0.000223 1560.000000 0.000111 -0.002106 0.000700 +15922 1 0.000225 1560.000000 -0.001563 -0.002803 0.000584 +15923 1 0.000243 1560.000000 -0.000011 0.001954 0.005173 +15924 1 0.000206 1560.000000 0.000102 0.001227 0.008325 +15925 1 0.000217 1560.000000 0.002056 0.002025 0.004270 +15926 1 0.000195 1560.000000 -0.000121 0.003406 0.003633 +15927 1 0.000253 1560.000000 -0.000288 -0.001938 0.002777 +15928 1 0.000224 1560.000000 -0.000451 0.002926 0.006275 +15929 1 0.000228 1560.000000 -0.001491 -0.000166 0.005269 +15930 1 0.000257 1560.000000 -0.000577 0.003074 0.001369 +15931 1 0.000216 1560.000000 0.003334 -0.000041 0.001762 +15932 1 0.000203 1560.000000 -0.001747 -0.001758 0.006871 +15933 1 0.000274 1560.000000 -0.002513 0.002822 0.008966 +15934 1 0.000276 1560.000000 0.002235 0.002774 0.003650 +15935 1 0.000239 1560.000000 -0.001543 0.003195 0.002764 +15936 1 0.000196 1560.000000 -0.002630 0.001003 0.007487 +15937 1 0.000210 1560.000000 0.000500 0.000084 0.002691 +15938 1 0.000199 1560.000000 -0.000117 -0.000414 0.002831 +15939 1 0.000207 1560.000000 -0.000998 0.001813 0.002917 +15940 1 0.000210 1560.000000 -0.000719 -0.002388 0.002130 +15941 1 0.000198 1560.000000 0.000015 0.002982 0.004111 +15942 1 0.000253 1560.000000 0.002801 0.001109 0.009044 +15943 1 0.000230 1560.000000 0.002449 0.000079 0.005693 +15944 1 0.000202 1560.000000 -0.002401 0.000178 0.008587 +15945 1 0.000263 1560.000000 0.003179 0.000906 0.002552 +15946 1 0.000202 1560.000000 0.001640 -0.001047 0.004324 +15947 1 0.000242 1560.000000 -0.001213 -0.001127 0.008828 +15948 1 0.000220 1560.000000 0.003245 -0.002067 0.000830 +15949 1 0.000247 1560.000000 -0.000232 -0.003476 0.005431 +15950 1 0.000205 1560.000000 -0.000459 -0.002109 0.003131 +15951 1 0.000195 1560.000000 -0.000751 -0.003049 0.003994 +15952 1 0.000265 1560.000000 0.000797 0.002771 0.007591 +15953 1 0.000228 1560.000000 0.001787 -0.000135 0.006093 +15954 1 0.000232 1560.000000 -0.002340 -0.001978 0.004990 +15955 1 0.000201 1560.000000 -0.001423 0.001131 0.007769 +15956 1 0.000227 1560.000000 -0.000247 0.000291 0.000847 +15957 1 0.000211 1560.000000 0.002337 0.000040 0.002008 +15958 1 0.000288 1560.000000 -0.003824 -0.000213 0.006459 +15959 1 0.000241 1560.000000 0.003469 -0.000703 0.005289 +15960 1 0.000283 1560.000000 -0.001838 -0.003052 0.008123 +15961 1 0.000198 1560.000000 -0.000271 -0.003347 0.003761 +15962 1 0.000198 1560.000000 0.000591 -0.003188 0.003919 +15963 1 0.000201 1560.000000 -0.003125 -0.001197 0.002330 +15964 1 0.000241 1560.000000 -0.001997 0.001657 0.003026 +15965 1 0.000239 1560.000000 -0.000032 0.000931 0.001320 +15966 1 0.000232 1560.000000 -0.003428 0.001684 0.007719 +15967 1 0.000253 1560.000000 0.001076 -0.003035 0.002753 +15968 1 0.000272 1560.000000 -0.002018 0.000583 0.003868 +15969 1 0.000260 1560.000000 -0.001574 0.000860 0.000185 +15970 1 0.000269 1560.000000 -0.000484 0.002206 0.000162 +15971 1 0.000223 1560.000000 -0.001100 0.002162 0.000181 +15972 1 0.000264 1560.000000 0.003374 0.000798 0.004530 +15973 1 0.000281 1560.000000 0.000406 0.003103 0.004307 +15974 1 0.000196 1560.000000 -0.000750 0.003616 0.004478 +15975 1 0.000205 1560.000000 0.002659 0.002654 0.000666 +15976 1 0.000236 1560.000000 -0.002967 -0.001142 0.003970 +15977 1 0.000235 1560.000000 -0.002618 -0.001270 0.003572 +15978 1 0.000263 1560.000000 -0.000548 -0.000939 0.002229 +15979 1 0.000250 1560.000000 0.002983 0.000762 0.004180 +15980 1 0.000207 1560.000000 -0.001560 -0.000053 0.008188 +15981 1 0.000248 1560.000000 0.002232 -0.003027 0.004215 +15982 1 0.000268 1560.000000 0.002148 -0.000721 0.007104 +15983 1 0.000231 1560.000000 -0.002245 0.000536 0.004711 +15984 1 0.000238 1560.000000 -0.001688 -0.003370 0.002866 +15985 1 0.000250 1560.000000 -0.003137 0.001793 0.003187 +15986 1 0.000270 1560.000000 0.000183 -0.002076 0.005948 +15987 1 0.000222 1560.000000 -0.000111 -0.003750 0.007690 +15988 1 0.000267 1560.000000 0.002266 0.000930 0.002163 +15989 1 0.000265 1560.000000 0.000785 -0.003758 0.001120 +15990 1 0.000264 1560.000000 -0.002716 0.000974 0.001607 +15991 1 0.000216 1560.000000 -0.001053 0.003330 0.009082 +15992 1 0.000199 1560.000000 0.003017 -0.001694 0.004995 +15993 1 0.000283 1560.000000 0.003748 0.000121 0.006341 +15994 1 0.000207 1560.000000 -0.001988 0.000284 0.003886 +15995 1 0.000200 1560.000000 -0.001388 -0.000779 0.001800 +15996 1 0.000288 1560.000000 0.001620 0.003338 0.003284 +15997 1 0.000258 1560.000000 -0.002946 0.000403 0.006425 +15998 1 0.000287 1560.000000 -0.001829 -0.000968 0.005505 +15999 1 0.000275 1560.000000 0.003480 -0.001511 0.001887 +16000 1 0.000213 1560.000000 -0.000150 0.003408 0.001771 +16001 1 0.000217 1560.000000 -0.001501 0.003544 0.003216 +16002 1 0.000207 1560.000000 -0.001820 0.000608 0.004503 +16003 1 0.000234 1560.000000 -0.000706 0.000013 0.001039 +16004 1 0.000195 1560.000000 -0.000851 0.002319 0.003777 +16005 1 0.000272 1560.000000 0.001463 -0.003559 0.003681 +16006 1 0.000253 1560.000000 -0.001816 0.002964 0.001196 +16007 1 0.000215 1560.000000 -0.000938 -0.000868 0.006736 +16008 1 0.000202 1560.000000 0.003024 0.001196 0.004994 +16009 1 0.000236 1560.000000 -0.001043 0.000133 0.005839 +16010 1 0.000264 1560.000000 0.003055 -0.001294 0.004583 +16011 1 0.000235 1560.000000 0.000607 0.003794 0.006931 +16012 1 0.000233 1560.000000 0.002666 -0.002092 0.003035 +16013 1 0.000252 1560.000000 -0.002103 0.001486 0.002707 +16014 1 0.000281 1560.000000 -0.001575 0.002458 0.005825 +16015 1 0.000206 1560.000000 -0.002474 0.000014 0.002403 +16016 1 0.000231 1560.000000 -0.003672 -0.000663 0.000278 +16017 1 0.000247 1560.000000 -0.002787 -0.001254 0.007670 +16018 1 0.000210 1560.000000 0.000848 -0.003252 0.009382 +16019 1 0.000223 1560.000000 -0.001791 -0.001870 0.005486 +16020 1 0.000235 1560.000000 -0.001261 0.002424 0.001063 +16021 1 0.000267 1560.000000 -0.002814 0.002267 0.007057 +16022 1 0.000225 1560.000000 0.001243 -0.001397 0.009428 +16023 1 0.000226 1560.000000 0.002262 0.000921 0.003306 +16024 1 0.000252 1560.000000 0.001725 0.003055 0.000405 +16025 1 0.000224 1560.000000 -0.002934 0.001382 0.006419 +16026 1 0.000205 1560.000000 -0.001590 -0.000157 0.003472 +16027 1 0.000251 1560.000000 -0.002242 0.001260 0.007330 +16028 1 0.000247 1560.000000 0.001808 0.002479 0.003129 +16029 1 0.000234 1560.000000 0.000917 0.000108 0.002561 +16030 1 0.000252 1560.000000 0.002167 0.003044 0.004111 +16031 1 0.000278 1560.000000 0.002320 -0.002736 0.009825 +16032 1 0.000268 1560.000000 0.002662 -0.001705 0.000217 +16033 1 0.000238 1560.000000 -0.003460 0.001200 0.002746 +16034 1 0.000245 1560.000000 0.000754 -0.001374 0.007199 +16035 1 0.000276 1560.000000 -0.002059 -0.001953 0.005700 +16036 1 0.000207 1560.000000 -0.002584 0.000293 0.008652 +16037 1 0.000227 1560.000000 -0.002025 -0.000085 0.003814 +16038 1 0.000219 1560.000000 -0.003584 0.000696 0.005195 +16039 1 0.000241 1560.000000 -0.002805 0.001642 0.002837 +16040 1 0.000253 1560.000000 0.002818 0.000081 0.003426 +16041 1 0.000201 1560.000000 -0.002364 0.000782 0.001120 +16042 1 0.000269 1560.000000 0.002334 -0.002636 0.005503 +16043 1 0.000193 1560.000000 0.001173 -0.002288 0.009590 +16044 1 0.000204 1560.000000 0.001543 0.002668 0.001255 +16045 1 0.000258 1560.000000 0.001070 -0.000599 0.001299 +16046 1 0.000195 1560.000000 -0.003017 0.001926 0.000882 +16047 1 0.000216 1560.000000 0.001986 0.000029 0.002928 +16048 1 0.000244 1560.000000 -0.000334 -0.002937 0.007301 +16049 1 0.000197 1560.000000 0.001112 0.003299 0.007300 +16050 1 0.000277 1560.000000 0.000302 -0.002981 0.008512 +16051 1 0.000197 1560.000000 0.002210 0.002292 0.000366 +16052 1 0.000288 1560.000000 0.003482 0.000489 0.004123 +16053 1 0.000214 1560.000000 0.002289 -0.002113 0.002304 +16054 1 0.000205 1560.000000 0.000395 0.000396 0.000458 +16055 1 0.000211 1560.000000 0.001930 -0.001408 0.004863 +16056 1 0.000217 1560.000000 -0.000956 0.002693 0.000731 +16057 1 0.000257 1560.000000 0.003270 0.001655 0.007490 +16058 1 0.000201 1560.000000 -0.001094 0.000887 0.002707 +16059 1 0.000212 1560.000000 0.002061 -0.002399 0.006674 +16060 1 0.000197 1560.000000 0.000259 0.000267 0.006994 +16061 1 0.000213 1560.000000 -0.002649 -0.001586 0.007031 +16062 1 0.000236 1560.000000 0.001778 0.002178 0.001507 +16063 1 0.000216 1560.000000 -0.002934 0.001680 0.007332 +16064 1 0.000235 1560.000000 -0.001449 -0.003185 0.007695 +16065 1 0.000227 1560.000000 0.003025 0.000114 0.004123 +16066 1 0.000200 1560.000000 0.001118 -0.002520 0.004942 +16067 1 0.000215 1560.000000 -0.001043 0.002878 0.007439 +16068 1 0.000253 1560.000000 0.000240 0.002672 0.004462 +16069 1 0.000203 1560.000000 0.000386 -0.002547 0.004428 +16070 1 0.000239 1560.000000 -0.002166 0.000696 0.008004 +16071 1 0.000219 1560.000000 -0.003503 -0.000701 0.007522 +16072 1 0.000234 1560.000000 -0.001548 0.000702 0.007487 +16073 1 0.000206 1560.000000 -0.001964 0.002893 0.008822 +16074 1 0.000207 1560.000000 0.000093 -0.002226 0.006161 +16075 1 0.000204 1560.000000 -0.002491 -0.002943 0.001102 +16076 1 0.000240 1560.000000 -0.001963 0.000508 0.001942 +16077 1 0.000267 1560.000000 -0.001569 -0.001036 0.004424 +16078 1 0.000254 1560.000000 0.002736 0.001708 0.008222 +16079 1 0.000204 1560.000000 -0.002034 0.002737 0.000212 +16080 1 0.000256 1560.000000 -0.001570 0.002363 0.003110 +16081 1 0.000250 1560.000000 -0.002580 -0.002328 0.007924 +16082 1 0.000236 1560.000000 0.002988 0.001531 0.006073 +16083 1 0.000255 1560.000000 0.001705 -0.000694 0.009806 +16084 1 0.000238 1560.000000 0.000415 -0.000835 0.006826 +16085 1 0.000249 1560.000000 -0.003699 -0.000312 0.000654 +16086 1 0.000233 1560.000000 -0.000691 0.002200 0.003667 +16087 1 0.000213 1560.000000 0.000827 0.002094 0.001947 +16088 1 0.000194 1560.000000 -0.001039 -0.001458 0.004857 +16089 1 0.000264 1560.000000 0.000026 0.002827 0.007711 +16090 1 0.000216 1560.000000 0.000718 0.002221 0.004226 +16091 1 0.000258 1560.000000 0.000839 0.002781 0.008589 +16092 1 0.000208 1560.000000 -0.003701 -0.000717 0.009431 +16093 1 0.000255 1560.000000 -0.003203 0.001700 0.005712 +16094 1 0.000207 1560.000000 0.001641 0.001683 0.004645 +16095 1 0.000231 1560.000000 -0.003137 -0.000751 0.004773 +16096 1 0.000232 1560.000000 -0.003250 0.001311 0.002525 +16097 1 0.000278 1560.000000 0.000662 -0.002971 0.005054 +16098 1 0.000274 1560.000000 -0.000280 0.000854 0.008692 +16099 1 0.000246 1560.000000 0.001601 -0.000210 0.005414 +16100 1 0.000261 1560.000000 0.002338 0.000739 0.005403 +16101 1 0.000263 1560.000000 0.003827 0.000385 0.007197 +16102 1 0.000286 1560.000000 -0.000583 0.003733 0.001174 +16103 1 0.000246 1560.000000 -0.001874 -0.000637 0.006403 +16104 1 0.000225 1560.000000 0.001007 -0.000094 0.008007 +16105 1 0.000266 1560.000000 0.001664 0.003236 0.009351 +16106 1 0.000238 1560.000000 -0.002933 -0.002425 0.001413 +16107 1 0.000272 1560.000000 0.003179 0.001943 0.009137 +16108 1 0.000199 1560.000000 -0.001911 0.000136 0.001284 +16109 1 0.000223 1560.000000 -0.002717 0.000002 0.002118 +16110 1 0.000235 1560.000000 -0.001445 0.002818 0.005313 +16111 1 0.000208 1560.000000 0.000516 -0.002174 0.007881 +16112 1 0.000224 1560.000000 0.000924 -0.002345 0.004022 +16113 1 0.000272 1560.000000 -0.000149 -0.003796 0.004054 +16114 1 0.000258 1560.000000 -0.003424 0.000096 0.002780 +16115 1 0.000248 1560.000000 0.003050 0.001111 0.005838 +16116 1 0.000203 1560.000000 -0.001147 -0.000825 0.004911 +16117 1 0.000250 1560.000000 -0.001471 -0.003011 0.000152 +16118 1 0.000231 1560.000000 -0.000200 -0.000414 0.009108 +16119 1 0.000194 1560.000000 0.003246 -0.002048 0.004211 +16120 1 0.000248 1560.000000 0.001000 -0.001299 0.006585 +16121 1 0.000209 1560.000000 0.000244 -0.001546 0.003044 +16122 1 0.000285 1560.000000 0.003837 0.000299 0.009675 +16123 1 0.000202 1560.000000 0.001579 -0.000054 0.007062 +16124 1 0.000250 1560.000000 0.003139 0.001856 0.008213 +16125 1 0.000238 1560.000000 -0.001699 0.003035 0.007449 +16126 1 0.000208 1560.000000 0.003208 0.001082 0.004167 +16127 1 0.000212 1560.000000 -0.003074 -0.001431 0.006243 +16128 1 0.000215 1560.000000 0.001391 -0.000324 0.000245 +16129 1 0.000237 1560.000000 -0.000424 -0.003081 0.004006 +16130 1 0.000201 1560.000000 0.000430 0.001041 0.006877 +16131 1 0.000218 1560.000000 0.003430 -0.000238 0.004257 +16132 1 0.000281 1560.000000 0.000535 0.003751 0.004038 +16133 1 0.000216 1560.000000 -0.003831 0.000117 0.009110 +16134 1 0.000195 1560.000000 -0.001816 -0.003190 0.009807 +16135 1 0.000222 1560.000000 -0.002158 0.001283 0.002399 +16136 1 0.000238 1560.000000 -0.002254 -0.000838 0.005847 +16137 1 0.000266 1560.000000 -0.002686 0.002716 0.008116 +16138 1 0.000270 1560.000000 -0.002314 0.002295 0.000802 +16139 1 0.000278 1560.000000 0.001608 -0.002368 0.007091 +16140 1 0.000277 1560.000000 0.001700 0.001239 0.002283 +16141 1 0.000277 1560.000000 0.001925 0.003282 0.003679 +16142 1 0.000194 1560.000000 -0.001372 0.002127 0.006135 +16143 1 0.000251 1560.000000 0.002738 0.000451 0.002648 +16144 1 0.000246 1560.000000 -0.001217 0.003656 0.006076 +16145 1 0.000281 1560.000000 0.001131 -0.002275 0.007274 +16146 1 0.000237 1560.000000 0.003131 -0.002232 0.007866 +16147 1 0.000231 1560.000000 -0.000783 0.000389 0.001992 +16148 1 0.000215 1560.000000 -0.003832 0.000010 0.006885 +16149 1 0.000217 1560.000000 0.003444 -0.000407 0.002896 +16150 1 0.000274 1560.000000 0.000781 0.003112 0.005626 +16151 1 0.000268 1560.000000 0.001546 -0.002045 0.009399 +16152 1 0.000229 1560.000000 0.003270 0.000417 0.004282 +16153 1 0.000250 1560.000000 -0.000590 -0.003288 0.006055 +16154 1 0.000284 1560.000000 -0.001164 0.002726 0.009155 +16155 1 0.000237 1560.000000 -0.002380 0.000952 0.002887 +16156 1 0.000211 1560.000000 0.000595 0.003692 0.001968 +16157 1 0.000224 1560.000000 0.001068 -0.001450 0.008526 +16158 1 0.000283 1560.000000 0.002209 0.002370 0.008487 +16159 1 0.000246 1560.000000 -0.002594 -0.000450 0.008764 +16160 1 0.000201 1560.000000 0.002251 0.000028 0.002482 +16161 1 0.000242 1560.000000 -0.000338 0.003126 0.003805 +16162 1 0.000241 1560.000000 0.000760 0.001800 0.007120 +16163 1 0.000216 1560.000000 0.001713 -0.002797 0.008038 +16164 1 0.000201 1560.000000 0.001753 0.001836 0.002815 +16165 1 0.000195 1560.000000 0.002253 0.000095 0.006545 +16166 1 0.000206 1560.000000 -0.002454 -0.000645 0.002967 +16167 1 0.000198 1560.000000 0.000519 0.003636 0.007124 +16168 1 0.000233 1560.000000 -0.000570 -0.002237 0.003755 +16169 1 0.000218 1560.000000 0.002286 0.002155 0.007451 +16170 1 0.000248 1560.000000 0.000598 -0.001906 0.005897 +16171 1 0.000246 1560.000000 -0.003208 0.002021 0.008383 +16172 1 0.000256 1560.000000 0.003836 0.000031 0.007283 +16173 1 0.000249 1560.000000 -0.002098 -0.002711 0.005915 +16174 1 0.000246 1560.000000 -0.001028 0.003341 0.002928 +16175 1 0.000196 1560.000000 -0.002012 -0.000411 0.006333 +16176 1 0.000254 1560.000000 0.002834 0.000502 0.009321 +16177 1 0.000211 1560.000000 -0.002424 -0.002919 0.005304 +16178 1 0.000215 1560.000000 -0.000241 0.003464 0.008633 +16179 1 0.000283 1560.000000 0.000938 -0.002443 0.000591 +16180 1 0.000236 1560.000000 -0.003049 -0.000727 0.005222 +16181 1 0.000198 1560.000000 0.001227 -0.001191 0.002450 +16182 1 0.000215 1560.000000 0.003831 0.000127 0.004975 +16183 1 0.000196 1560.000000 0.003299 0.001188 0.001271 +16184 1 0.000251 1560.000000 0.000311 -0.003291 0.008675 +16185 1 0.000195 1560.000000 -0.001337 0.001774 0.008404 +16186 1 0.000236 1560.000000 0.002584 -0.000620 0.006641 +16187 1 0.000259 1560.000000 -0.001103 -0.001843 0.006236 +16188 1 0.000262 1560.000000 -0.000972 -0.000805 0.004129 +16189 1 0.000254 1560.000000 0.001567 -0.001044 0.004935 +16190 1 0.000199 1560.000000 0.000800 -0.001669 0.002268 +16191 1 0.000237 1560.000000 -0.000830 -0.000689 0.006930 +16192 1 0.000229 1560.000000 0.000131 0.001726 0.002343 +16193 1 0.000225 1560.000000 -0.002526 -0.001158 0.000257 +16194 1 0.000264 1560.000000 -0.000758 -0.002097 0.005938 +16195 1 0.000279 1560.000000 -0.000041 -0.002059 0.005715 +16196 1 0.000231 1560.000000 0.000355 -0.002816 0.005815 +16197 1 0.000193 1560.000000 -0.000173 0.000688 0.008863 +16198 1 0.000248 1560.000000 -0.002083 -0.000113 0.002857 +16199 1 0.000196 1560.000000 0.000209 0.001809 0.004866 +16200 1 0.000208 1560.000000 -0.002418 -0.001687 0.008947 +16201 1 0.000232 1560.000000 0.001470 0.002944 0.002338 +16202 1 0.000270 1560.000000 0.003706 -0.000741 0.000155 +16203 1 0.000208 1560.000000 -0.001311 -0.002552 0.007463 +16204 1 0.000212 1560.000000 0.001388 0.001696 0.008771 +16205 1 0.000203 1560.000000 0.002499 -0.000330 0.004308 +16206 1 0.000210 1560.000000 -0.001765 0.000818 0.007141 +16207 1 0.000204 1560.000000 -0.003112 -0.000049 0.007469 +16208 1 0.000236 1560.000000 -0.001902 0.000501 0.005471 +16209 1 0.000273 1560.000000 -0.001361 -0.001505 0.000162 +16210 1 0.000228 1560.000000 0.000744 0.001464 0.004383 +16211 1 0.000238 1560.000000 0.003136 -0.001041 0.004915 +16212 1 0.000217 1560.000000 -0.001104 0.001344 0.000617 +16213 1 0.000201 1560.000000 0.000885 0.001583 0.004503 +16214 1 0.000209 1560.000000 0.002621 -0.000841 0.004545 +16215 1 0.000210 1560.000000 0.001543 0.003525 0.003716 +16216 1 0.000207 1560.000000 0.002992 0.000450 0.002027 +16217 1 0.000216 1560.000000 -0.001390 0.001632 0.006424 +16218 1 0.000258 1560.000000 -0.000075 0.003205 0.009074 +16219 1 0.000213 1560.000000 -0.003712 0.000482 0.007629 +16220 1 0.000201 1560.000000 -0.000087 -0.001834 0.001566 +16221 1 0.000208 1560.000000 0.001718 0.003360 0.006993 +16222 1 0.000265 1560.000000 0.001116 0.002629 0.000138 +16223 1 0.000271 1560.000000 -0.001515 0.003163 0.006805 +16224 1 0.000272 1560.000000 0.002088 -0.000267 0.008790 +16225 1 0.000244 1560.000000 0.001661 -0.002824 0.006127 +16226 1 0.000246 1560.000000 0.001953 -0.002408 0.000955 +16227 1 0.000201 1560.000000 -0.001743 -0.002071 0.001859 +16228 1 0.000239 1560.000000 0.003049 0.000239 0.002262 +16229 1 0.000202 1560.000000 0.000538 -0.000995 0.003986 +16230 1 0.000255 1560.000000 -0.003161 -0.000118 0.001610 +16231 1 0.000211 1560.000000 0.000120 -0.002470 0.002874 +16232 1 0.000272 1560.000000 -0.000797 -0.002546 0.000641 +16233 1 0.000208 1560.000000 -0.002468 0.001324 0.007796 +16234 1 0.000263 1560.000000 -0.003284 0.001395 0.000465 +16235 1 0.000225 1560.000000 -0.002372 0.001070 0.006495 +16236 1 0.000284 1560.000000 -0.002945 -0.002066 0.002331 +16237 1 0.000257 1560.000000 0.001107 -0.002609 0.005337 +16238 1 0.000197 1560.000000 -0.000693 -0.001393 0.005141 +16239 1 0.000230 1560.000000 -0.001194 -0.003646 0.007173 +16240 1 0.000251 1560.000000 0.000522 0.000017 0.001984 +16241 1 0.000255 1560.000000 0.001152 -0.003668 0.005874 +16242 1 0.000231 1560.000000 0.002616 0.000313 0.000842 +16243 1 0.000217 1560.000000 0.002314 0.000753 0.005699 +16244 1 0.000244 1560.000000 0.001263 0.001715 0.007737 +16245 1 0.000217 1560.000000 0.001987 -0.003246 0.008360 +16246 1 0.000264 1560.000000 -0.000386 0.002574 0.000361 +16247 1 0.000288 1560.000000 0.002539 0.000460 0.001383 +16248 1 0.000208 1560.000000 0.000242 -0.000660 0.008879 +16249 1 0.000261 1560.000000 -0.001170 0.000816 0.007085 +16250 1 0.000221 1560.000000 -0.002959 0.001620 0.004853 +16251 1 0.000217 1560.000000 0.000394 0.000430 0.004172 +16252 1 0.000218 1560.000000 0.002228 0.000935 0.002936 +16253 1 0.000275 1560.000000 0.002897 0.001186 0.004020 +16254 1 0.000249 1560.000000 -0.001280 0.001731 0.004934 +16255 1 0.000217 1560.000000 0.000339 0.003678 0.002128 +16256 1 0.000244 1560.000000 0.001092 -0.001657 0.003648 +16257 1 0.000273 1560.000000 -0.000801 0.000528 0.001175 +16258 1 0.000193 1560.000000 -0.001380 0.000839 0.009109 +16259 1 0.000272 1560.000000 0.003221 -0.001497 0.009759 +16260 1 0.000215 1560.000000 -0.001291 -0.001988 0.005095 +16261 1 0.000216 1560.000000 0.002597 -0.000282 0.008612 +16262 1 0.000222 1560.000000 0.002306 -0.001178 0.008890 +16263 1 0.000260 1560.000000 0.003694 -0.001036 0.007033 +16264 1 0.000200 1560.000000 -0.000802 -0.002402 0.006387 +16265 1 0.000278 1560.000000 0.002338 -0.001688 0.001623 +16266 1 0.000275 1560.000000 0.002317 -0.001771 0.000802 +16267 1 0.000281 1560.000000 0.000419 -0.003091 0.002510 +16268 1 0.000223 1560.000000 -0.002978 0.002096 0.003752 +16269 1 0.000202 1560.000000 0.000490 0.001881 0.009618 +16270 1 0.000252 1560.000000 -0.001691 -0.001240 0.008451 +16271 1 0.000200 1560.000000 -0.003244 -0.000348 0.001086 +16272 1 0.000215 1560.000000 0.003488 0.000246 0.001828 +16273 1 0.000192 1560.000000 0.000689 -0.000708 0.000169 +16274 1 0.000250 1560.000000 -0.000288 0.003693 0.007516 +16275 1 0.000245 1560.000000 -0.000729 0.001723 0.007327 +16276 1 0.000221 1560.000000 0.000680 -0.003410 0.004553 +16277 1 0.000204 1560.000000 -0.001499 0.002052 0.005312 +16278 1 0.000199 1560.000000 -0.003049 0.001968 0.005157 +16279 1 0.000200 1560.000000 0.001969 0.000051 0.005312 +16280 1 0.000233 1560.000000 0.002075 -0.000724 0.005453 +16281 1 0.000227 1560.000000 0.000585 -0.000770 0.008900 +16282 1 0.000205 1560.000000 -0.002158 -0.002794 0.007220 +16283 1 0.000194 1560.000000 0.002150 0.002126 0.008524 +16284 1 0.000239 1560.000000 -0.001399 -0.003538 0.007622 +16285 1 0.000274 1560.000000 -0.003230 -0.000915 0.003373 +16286 1 0.000229 1560.000000 -0.003244 -0.000936 0.005860 +16287 1 0.000237 1560.000000 0.002370 0.001660 0.001671 +16288 1 0.000215 1560.000000 0.001896 0.002640 0.004230 +16289 1 0.000280 1560.000000 0.002178 -0.000259 0.003302 +16290 1 0.000218 1560.000000 -0.000501 -0.001324 0.009279 +16291 1 0.000195 1560.000000 -0.000765 -0.002331 0.005983 +16292 1 0.000201 1560.000000 0.001387 0.002662 0.005837 +16293 1 0.000221 1560.000000 -0.001182 0.000173 0.003936 +16294 1 0.000216 1560.000000 0.000390 0.000615 0.008100 +16295 1 0.000230 1560.000000 0.002438 0.000236 0.005952 +16296 1 0.000286 1560.000000 -0.000828 0.002986 0.009173 +16297 1 0.000234 1560.000000 -0.000383 -0.003331 0.006887 +16298 1 0.000268 1560.000000 -0.003041 -0.002345 0.007780 +16299 1 0.000239 1560.000000 -0.000988 0.003039 0.002840 +16300 1 0.000263 1560.000000 -0.001976 -0.001474 0.008750 +16301 1 0.000274 1560.000000 -0.001575 -0.002011 0.004965 +16302 1 0.000216 1560.000000 -0.001809 -0.000165 0.004925 +16303 1 0.000199 1560.000000 0.000736 0.000951 0.005778 +16304 1 0.000217 1560.000000 -0.001948 -0.002139 0.003215 +16305 1 0.000266 1560.000000 -0.002385 -0.000132 0.007164 +16306 1 0.000258 1560.000000 0.002231 0.001696 0.007318 +16307 1 0.000279 1560.000000 -0.000438 -0.003739 0.004726 +16308 1 0.000193 1560.000000 -0.001268 0.001457 0.007765 +16309 1 0.000274 1560.000000 -0.002208 -0.001030 0.009511 +16310 1 0.000227 1560.000000 -0.002389 0.001382 0.006596 +16311 1 0.000223 1560.000000 0.001951 0.002374 0.009804 +16312 1 0.000269 1560.000000 -0.000665 -0.003429 0.001842 +16313 1 0.000228 1560.000000 0.000011 -0.002912 0.003366 +16314 1 0.000252 1560.000000 -0.001664 -0.002513 0.009017 +16315 1 0.000268 1560.000000 -0.002168 0.001869 0.003055 +16316 1 0.000266 1560.000000 -0.002086 0.001938 0.006693 +16317 1 0.000274 1560.000000 0.002667 -0.000848 0.004194 +16318 1 0.000194 1560.000000 0.001808 -0.001248 0.000389 +16319 1 0.000234 1560.000000 -0.000935 -0.002169 0.004063 +16320 1 0.000202 1560.000000 -0.000089 0.003815 0.008248 +16321 1 0.000203 1560.000000 -0.000363 0.001041 0.001468 +16322 1 0.000284 1560.000000 -0.002407 0.002605 0.004554 +16323 1 0.000284 1560.000000 -0.003459 0.000681 0.001440 +16324 1 0.000287 1560.000000 0.000544 0.003339 0.000773 +16325 1 0.000233 1560.000000 0.000738 -0.001224 0.000498 +16326 1 0.000231 1560.000000 -0.001700 -0.002862 0.003243 +16327 1 0.000242 1560.000000 -0.000570 0.001776 0.000427 +16328 1 0.000208 1560.000000 -0.000991 0.000025 0.005451 +16329 1 0.000196 1560.000000 0.003266 0.001832 0.007754 +16330 1 0.000243 1560.000000 0.002690 -0.001057 0.009654 +16331 1 0.000251 1560.000000 0.001781 -0.003117 0.008906 +16332 1 0.000266 1560.000000 -0.003434 -0.001381 0.005145 +16333 1 0.000194 1560.000000 -0.001848 0.001084 0.002767 +16334 1 0.000226 1560.000000 -0.001882 0.002924 0.005986 +16335 1 0.000207 1560.000000 0.002918 -0.001823 0.003485 +16336 1 0.000210 1560.000000 -0.001202 -0.001505 0.007342 +16337 1 0.000207 1560.000000 -0.000539 -0.000642 0.004423 +16338 1 0.000245 1560.000000 0.002229 -0.002586 0.003899 +16339 1 0.000230 1560.000000 -0.001239 0.003296 0.000564 +16340 1 0.000204 1560.000000 0.001479 -0.003203 0.004732 +16341 1 0.000212 1560.000000 0.000698 0.002740 0.000170 +16342 1 0.000196 1560.000000 0.002241 -0.000392 0.006298 +16343 1 0.000263 1560.000000 0.000160 -0.003694 0.009749 +16344 1 0.000235 1560.000000 -0.001338 -0.002599 0.008989 +16345 1 0.000234 1560.000000 0.002188 0.000537 0.004567 +16346 1 0.000219 1560.000000 -0.002517 -0.000279 0.003231 +16347 1 0.000264 1560.000000 -0.002759 -0.001991 0.005420 +16348 1 0.000234 1560.000000 0.001211 -0.000805 0.008038 +16349 1 0.000212 1560.000000 -0.003104 0.001052 0.001622 +16350 1 0.000194 1560.000000 0.001497 0.001944 0.006651 +16351 1 0.000244 1560.000000 0.000631 0.003410 0.005691 +16352 1 0.000259 1560.000000 -0.000650 0.002970 0.007724 +16353 1 0.000205 1560.000000 0.000543 0.002699 0.007750 +16354 1 0.000197 1560.000000 0.001327 0.002292 0.001541 +16355 1 0.000230 1560.000000 0.000809 -0.002568 0.006884 +16356 1 0.000285 1560.000000 0.002506 -0.001187 0.005193 +16357 1 0.000255 1560.000000 0.000647 0.003151 0.001065 +16358 1 0.000224 1560.000000 -0.000456 0.002594 0.003512 +16359 1 0.000266 1560.000000 0.002306 0.001478 0.003233 +16360 1 0.000197 1560.000000 0.000765 -0.000365 0.006910 +16361 1 0.000229 1560.000000 0.002848 -0.001852 0.006971 +16362 1 0.000219 1560.000000 0.002472 -0.002934 0.003050 +16363 1 0.000214 1560.000000 0.001074 0.001242 0.004006 +16364 1 0.000287 1560.000000 -0.001992 0.000058 0.007834 +16365 1 0.000202 1560.000000 -0.000237 -0.003523 0.003065 +16366 1 0.000199 1560.000000 0.001987 -0.000107 0.008611 +16367 1 0.000217 1560.000000 -0.001883 0.000930 0.003162 +16368 1 0.000195 1560.000000 0.000723 -0.001811 0.000105 +16369 1 0.000195 1560.000000 0.000963 -0.000091 0.008481 +16370 1 0.000205 1560.000000 -0.001245 -0.003260 0.004480 +16371 1 0.000219 1560.000000 -0.000093 -0.001716 0.005418 +16372 1 0.000231 1560.000000 -0.002221 0.001363 0.003046 +16373 1 0.000243 1560.000000 0.001968 0.002448 0.002925 +16374 1 0.000265 1560.000000 0.001728 0.001690 0.009363 +16375 1 0.000207 1560.000000 0.002924 0.001899 0.007929 +16376 1 0.000262 1560.000000 0.002658 0.001972 0.006517 +16377 1 0.000232 1560.000000 0.001731 0.001405 0.003801 +16378 1 0.000215 1560.000000 0.002558 0.000683 0.008370 +16379 1 0.000210 1560.000000 0.003268 0.001800 0.002644 +16380 1 0.000226 1560.000000 -0.002034 0.002475 0.003035 +16381 1 0.000236 1560.000000 0.000048 0.001450 0.005279 +16382 1 0.000210 1560.000000 -0.003843 0.000014 0.000204 +16383 1 0.000222 1560.000000 0.000706 0.000554 0.002192 +16384 1 0.000198 1560.000000 0.000881 -0.002113 0.008237 +16385 1 0.000253 1560.000000 -0.001305 0.002841 0.004785 +16386 1 0.000232 1560.000000 0.001713 -0.000048 0.004011 +16387 1 0.000237 1560.000000 -0.000764 -0.003725 0.000252 +16388 1 0.000251 1560.000000 -0.002831 0.001792 0.009559 +16389 1 0.000283 1560.000000 0.003275 0.000631 0.007139 +16390 1 0.000283 1560.000000 -0.002990 -0.002034 0.002750 +16391 1 0.000208 1560.000000 -0.000389 -0.002198 0.008785 +16392 1 0.000249 1560.000000 -0.002819 0.002623 0.006370 +16393 1 0.000216 1560.000000 0.001173 0.001073 0.000235 +16394 1 0.000226 1560.000000 0.000593 -0.000249 0.001081 +16395 1 0.000202 1560.000000 0.001342 -0.000697 0.004677 +16396 1 0.000217 1560.000000 0.000431 0.002908 0.007271 +16397 1 0.000233 1560.000000 0.000097 -0.000846 0.005279 +16398 1 0.000234 1560.000000 0.000940 -0.000858 0.004271 +16399 1 0.000262 1560.000000 -0.001792 -0.002344 0.002794 +16400 1 0.000266 1560.000000 -0.000409 -0.003376 0.000408 +16401 1 0.000217 1560.000000 0.001231 -0.000866 0.001009 +16402 1 0.000246 1560.000000 -0.002477 0.002712 0.006507 +16403 1 0.000197 1560.000000 0.000834 -0.002414 0.002723 +16404 1 0.000259 1560.000000 0.001121 -0.003450 0.004138 +16405 1 0.000254 1560.000000 -0.000582 0.002945 0.004708 +16406 1 0.000258 1560.000000 -0.001182 -0.001547 0.004497 +16407 1 0.000215 1560.000000 0.003232 0.000308 0.007335 +16408 1 0.000287 1560.000000 -0.002325 -0.003066 0.009034 +16409 1 0.000235 1560.000000 0.000469 0.003228 0.009456 +16410 1 0.000216 1560.000000 -0.000455 -0.000320 0.000304 +16411 1 0.000262 1560.000000 0.000615 -0.002087 0.002687 +16412 1 0.000205 1560.000000 0.002927 -0.002450 0.008741 +16413 1 0.000205 1560.000000 -0.001990 -0.003262 0.006446 +16414 1 0.000211 1560.000000 -0.001466 0.001377 0.004720 +16415 1 0.000276 1560.000000 0.001520 0.000355 0.007818 +16416 1 0.000266 1560.000000 -0.000523 -0.002027 0.004725 +16417 1 0.000262 1560.000000 -0.001122 0.003495 0.008100 +16418 1 0.000264 1560.000000 0.001973 0.001859 0.003491 +16419 1 0.000196 1560.000000 -0.003380 -0.001426 0.003319 +16420 1 0.000269 1560.000000 0.000293 -0.002419 0.000645 +16421 1 0.000210 1560.000000 -0.000010 0.001461 0.009143 +16422 1 0.000284 1560.000000 -0.001427 -0.002362 0.000182 +16423 1 0.000251 1560.000000 0.001217 0.000691 0.002709 +16424 1 0.000197 1560.000000 0.001479 -0.003138 0.008170 +16425 1 0.000214 1560.000000 0.001533 0.003148 0.000880 +16426 1 0.000272 1560.000000 -0.001999 -0.001848 0.004069 +16427 1 0.000213 1560.000000 -0.003384 0.001094 0.004298 +16428 1 0.000210 1560.000000 0.001408 0.001157 0.001232 +16429 1 0.000205 1560.000000 -0.001873 -0.001253 0.009344 +16430 1 0.000204 1560.000000 0.002823 -0.000086 0.005289 +16431 1 0.000239 1560.000000 -0.002627 0.002749 0.001621 +16432 1 0.000208 1560.000000 0.001672 -0.001333 0.006844 +16433 1 0.000286 1560.000000 0.001961 0.003101 0.000905 +16434 1 0.000209 1560.000000 0.000068 0.001699 0.005900 +16435 1 0.000235 1560.000000 0.000657 0.002673 0.003103 +16436 1 0.000245 1560.000000 -0.000920 -0.000482 0.000468 +16437 1 0.000220 1560.000000 0.001573 0.000735 0.007589 +16438 1 0.000220 1560.000000 -0.002722 -0.002644 0.004715 +16439 1 0.000219 1560.000000 -0.000419 -0.001688 0.006060 +16440 1 0.000213 1560.000000 -0.000845 -0.001060 0.004191 +16441 1 0.000195 1560.000000 -0.002998 0.001674 0.007851 +16442 1 0.000234 1560.000000 -0.000340 0.001446 0.003509 +16443 1 0.000274 1560.000000 -0.003571 0.000997 0.003686 +16444 1 0.000218 1560.000000 -0.001688 0.002597 0.008047 +16445 1 0.000222 1560.000000 0.002257 -0.000553 0.004155 +16446 1 0.000285 1560.000000 -0.001886 -0.002769 0.002409 +16447 1 0.000196 1560.000000 0.001822 0.002989 0.007683 +16448 1 0.000284 1560.000000 -0.000264 -0.003373 0.002546 +16449 1 0.000218 1560.000000 0.003351 0.000959 0.005778 +16450 1 0.000221 1560.000000 -0.003835 -0.000292 0.001622 +16451 1 0.000235 1560.000000 -0.002356 0.001656 0.004695 +16452 1 0.000257 1560.000000 -0.002565 0.002470 0.001882 +16453 1 0.000222 1560.000000 0.002029 -0.003261 0.005637 +16454 1 0.000263 1560.000000 -0.002282 0.000550 0.000395 +16455 1 0.000235 1560.000000 0.002543 0.002891 0.000586 +16456 1 0.000198 1560.000000 0.000330 -0.000588 0.000520 +16457 1 0.000250 1560.000000 -0.002823 0.000032 0.000427 +16458 1 0.000205 1560.000000 -0.001589 0.001913 0.009443 +16459 1 0.000281 1560.000000 0.002807 -0.000418 0.004673 +16460 1 0.000193 1560.000000 0.002340 -0.001448 0.000106 +16461 1 0.000238 1560.000000 -0.002538 -0.000184 0.009383 +16462 1 0.000251 1560.000000 0.001259 0.002411 0.007529 +16463 1 0.000262 1560.000000 0.001180 -0.001833 0.007997 +16464 1 0.000235 1560.000000 0.000535 0.002382 0.007481 +16465 1 0.000254 1560.000000 0.002425 -0.000181 0.008020 +16466 1 0.000266 1560.000000 -0.001293 0.003619 0.002710 +16467 1 0.000201 1560.000000 -0.003702 -0.000062 0.003990 +16468 1 0.000285 1560.000000 -0.002057 0.001833 0.008013 +16469 1 0.000223 1560.000000 -0.001285 -0.001702 0.008158 +16470 1 0.000272 1560.000000 0.002805 0.002546 0.006729 +16471 1 0.000219 1560.000000 0.001736 0.002118 0.005492 +16472 1 0.000248 1560.000000 0.002250 0.000144 0.000183 +16473 1 0.000288 1560.000000 -0.002138 0.001754 0.005519 +16474 1 0.000215 1560.000000 -0.000873 0.003112 0.001659 +16475 1 0.000236 1560.000000 -0.001488 0.001823 0.003436 +16476 1 0.000195 1560.000000 0.000616 -0.003226 0.008543 +16477 1 0.000214 1560.000000 0.001108 -0.001610 0.001336 +16478 1 0.000220 1560.000000 -0.001391 -0.002187 0.000766 +16479 1 0.000195 1560.000000 0.001422 -0.000269 0.001983 +16480 1 0.000231 1560.000000 -0.001916 0.002845 0.006560 +16481 1 0.000275 1560.000000 -0.001045 0.000177 0.000149 +16482 1 0.000270 1560.000000 -0.003308 0.001899 0.009835 +16483 1 0.000231 1560.000000 -0.002214 -0.000599 0.005302 +16484 1 0.000231 1560.000000 -0.003037 -0.000158 0.005996 +16485 1 0.000276 1560.000000 -0.000068 0.002723 0.008387 +16486 1 0.000196 1560.000000 -0.000496 -0.003654 0.008826 +16487 1 0.000214 1560.000000 0.002785 0.001394 0.002000 +16488 1 0.000258 1560.000000 -0.003394 0.000559 0.000738 +16489 1 0.000244 1560.000000 0.002117 -0.002625 0.001084 +16490 1 0.000212 1560.000000 -0.000678 -0.002537 0.007507 +16491 1 0.000240 1560.000000 0.001050 0.003488 0.000753 +16492 1 0.000256 1560.000000 -0.002188 0.000335 0.002099 +16493 1 0.000204 1560.000000 0.002179 0.002770 0.006906 +16494 1 0.000288 1560.000000 -0.003665 -0.000927 0.002661 +16495 1 0.000208 1560.000000 0.001392 -0.000337 0.005379 +16496 1 0.000221 1560.000000 -0.000769 0.002888 0.001887 +16497 1 0.000263 1560.000000 -0.001079 -0.003550 0.003849 +16498 1 0.000225 1560.000000 -0.003075 0.002275 0.004736 +16499 1 0.000260 1560.000000 -0.001245 0.000480 0.002749 +16500 1 0.000246 1560.000000 0.002239 -0.001031 0.005907 +16501 1 0.000270 1560.000000 0.001985 -0.001286 0.007418 +16502 1 0.000281 1560.000000 0.000005 0.002295 0.008931 +16503 1 0.000244 1560.000000 -0.001390 0.000391 0.007669 +16504 1 0.000202 1560.000000 -0.003280 -0.000784 0.006553 +16505 1 0.000196 1560.000000 -0.002632 -0.000368 0.005611 +16506 1 0.000250 1560.000000 -0.002511 0.000782 0.005009 +16507 1 0.000233 1560.000000 0.000297 0.000611 0.000119 +16508 1 0.000205 1560.000000 -0.000451 -0.003015 0.005398 +16509 1 0.000227 1560.000000 0.001483 0.003034 0.002123 +16510 1 0.000227 1560.000000 0.002768 0.000261 0.004228 +16511 1 0.000225 1560.000000 -0.000082 -0.002959 0.004880 +16512 1 0.000240 1560.000000 0.002471 -0.001199 0.000165 +16513 1 0.000264 1560.000000 -0.001954 0.001512 0.005519 +16514 1 0.000198 1560.000000 0.002383 0.001008 0.007096 +16515 1 0.000198 1560.000000 -0.000054 0.001863 0.005526 +16516 1 0.000275 1560.000000 -0.002784 -0.001976 0.001938 +16517 1 0.000234 1560.000000 0.001644 -0.000042 0.004255 +16518 1 0.000239 1560.000000 0.001637 -0.001728 0.002920 +16519 1 0.000264 1560.000000 0.000995 0.003721 0.007148 +16520 1 0.000273 1560.000000 0.001699 0.003347 0.000215 +16521 1 0.000252 1560.000000 0.000795 0.001439 0.000629 +16522 1 0.000236 1560.000000 0.000294 -0.002857 0.003231 +16523 1 0.000227 1560.000000 -0.001613 0.002709 0.005993 +16524 1 0.000215 1560.000000 0.000593 0.001124 0.003989 +16525 1 0.000237 1560.000000 0.003246 -0.000699 0.004193 +16526 1 0.000201 1560.000000 -0.000949 0.003046 0.006982 +16527 1 0.000244 1560.000000 -0.001926 0.003291 0.002814 +16528 1 0.000286 1560.000000 -0.003049 -0.001824 0.008894 +16529 1 0.000205 1560.000000 0.000797 -0.000633 0.003080 +16530 1 0.000199 1560.000000 -0.000904 0.003446 0.001000 +16531 1 0.000224 1560.000000 -0.001470 0.002956 0.003014 +16532 1 0.000247 1560.000000 -0.000227 -0.003628 0.005229 +16533 1 0.000284 1560.000000 0.002369 -0.000880 0.002712 +16534 1 0.000212 1560.000000 0.000643 -0.001762 0.005711 +16535 1 0.000254 1560.000000 -0.002130 0.002431 0.006802 +16536 1 0.000198 1560.000000 0.000970 -0.002396 0.006188 +16537 1 0.000193 1560.000000 -0.002061 0.002257 0.009440 +16538 1 0.000196 1560.000000 0.001804 0.000978 0.006155 +16539 1 0.000276 1560.000000 0.001078 -0.000971 0.008806 +16540 1 0.000227 1560.000000 0.000552 -0.001243 0.009818 +16541 1 0.000241 1560.000000 -0.001104 -0.003056 0.005898 +16542 1 0.000204 1560.000000 0.002828 -0.000667 0.002519 +16543 1 0.000227 1560.000000 -0.001369 -0.001657 0.009499 +16544 1 0.000195 1560.000000 -0.000628 -0.001928 0.001731 +16545 1 0.000198 1560.000000 -0.000632 0.000198 0.007349 +16546 1 0.000198 1560.000000 0.000007 0.002522 0.002885 +16547 1 0.000248 1560.000000 0.000931 0.000668 0.006443 +16548 1 0.000209 1560.000000 -0.002785 0.002171 0.003923 +16549 1 0.000276 1560.000000 0.003527 0.001479 0.005372 +16550 1 0.000199 1560.000000 0.001280 -0.003034 0.006609 +16551 1 0.000197 1560.000000 -0.001578 0.003062 0.004418 +16552 1 0.000201 1560.000000 0.000476 -0.002020 0.001166 +16553 1 0.000238 1560.000000 -0.000213 0.002300 0.003670 +16554 1 0.000217 1560.000000 0.002644 -0.001473 0.005449 +16555 1 0.000217 1560.000000 0.002298 -0.002600 0.004289 +16556 1 0.000229 1560.000000 -0.003230 -0.002035 0.005142 +16557 1 0.000230 1560.000000 -0.000932 0.002137 0.003384 +16558 1 0.000196 1560.000000 0.003594 0.000422 0.005198 +16559 1 0.000205 1560.000000 0.003588 -0.000437 0.000237 +16560 1 0.000207 1560.000000 -0.002543 -0.000103 0.007637 +16561 1 0.000219 1560.000000 0.000618 0.001822 0.003257 +16562 1 0.000208 1560.000000 -0.002140 0.000469 0.003371 +16563 1 0.000279 1560.000000 -0.000591 0.003784 0.004378 +16564 1 0.000204 1560.000000 0.003136 -0.000422 0.007809 +16565 1 0.000206 1560.000000 -0.000670 -0.000618 0.000607 +16566 1 0.000209 1560.000000 0.000102 -0.003031 0.007626 +16567 1 0.000196 1560.000000 -0.003273 0.000219 0.009651 +16568 1 0.000256 1560.000000 0.000933 0.001201 0.009686 +16569 1 0.000273 1560.000000 -0.002590 -0.002519 0.003304 +16570 1 0.000274 1560.000000 -0.000810 -0.002738 0.008003 +16571 1 0.000210 1560.000000 -0.001515 -0.001190 0.009283 +16572 1 0.000240 1560.000000 0.002886 -0.000610 0.002294 +16573 1 0.000246 1560.000000 -0.001861 -0.002187 0.009816 +16574 1 0.000221 1560.000000 0.001915 0.003309 0.005828 +16575 1 0.000276 1560.000000 -0.003520 0.001229 0.005403 +16576 1 0.000224 1560.000000 -0.002567 -0.000422 0.009310 +16577 1 0.000258 1560.000000 0.000490 0.003200 0.005756 +16578 1 0.000223 1560.000000 -0.000530 -0.002022 0.008558 +16579 1 0.000240 1560.000000 0.001079 -0.002799 0.001674 +16580 1 0.000218 1560.000000 0.002607 -0.002255 0.008085 +16581 1 0.000218 1560.000000 0.002960 -0.001935 0.004041 +16582 1 0.000220 1560.000000 0.001353 0.000119 0.000151 +16583 1 0.000282 1560.000000 0.000056 0.003808 0.001162 +16584 1 0.000233 1560.000000 0.000872 -0.000407 0.007146 +16585 1 0.000234 1560.000000 0.003098 0.002283 0.000547 +16586 1 0.000280 1560.000000 0.001173 0.003146 0.009828 +16587 1 0.000256 1560.000000 0.000660 0.002958 0.007182 +16588 1 0.000204 1560.000000 -0.001582 -0.002472 0.005136 +16589 1 0.000268 1560.000000 -0.001763 -0.001555 0.004026 +16590 1 0.000215 1560.000000 0.003593 0.000431 0.001621 +16591 1 0.000224 1560.000000 -0.002271 -0.002187 0.008569 +16592 1 0.000287 1560.000000 0.000853 -0.003039 0.005407 +16593 1 0.000246 1560.000000 -0.003510 -0.001427 0.003888 +16594 1 0.000222 1560.000000 0.002466 -0.001570 0.009607 +16595 1 0.000217 1560.000000 -0.002506 -0.000753 0.002108 +16596 1 0.000194 1560.000000 -0.000476 0.002613 0.003200 +16597 1 0.000225 1560.000000 0.000496 -0.003525 0.008433 +16598 1 0.000239 1560.000000 0.000366 0.003433 0.001342 +16599 1 0.000274 1560.000000 -0.000958 -0.001457 0.001837 +16600 1 0.000205 1560.000000 -0.000655 0.003633 0.005761 +16601 1 0.000211 1560.000000 0.001303 0.001054 0.008595 +16602 1 0.000232 1560.000000 0.000099 0.001680 0.000951 +16603 1 0.000198 1560.000000 0.003607 -0.000633 0.009096 +16604 1 0.000204 1560.000000 -0.002320 0.002380 0.003391 +16605 1 0.000230 1560.000000 0.001761 0.000222 0.008517 +16606 1 0.000225 1560.000000 -0.002314 0.002804 0.001391 +16607 1 0.000213 1560.000000 -0.001648 0.003214 0.008815 +16608 1 0.000196 1560.000000 -0.003625 0.000563 0.008646 +16609 1 0.000221 1560.000000 0.001933 -0.002428 0.002917 +16610 1 0.000248 1560.000000 0.001622 -0.002139 0.000503 +16611 1 0.000273 1560.000000 -0.000836 0.000602 0.005313 +16612 1 0.000258 1560.000000 -0.000289 -0.001321 0.007198 +16613 1 0.000224 1560.000000 -0.003561 0.000531 0.009806 +16614 1 0.000223 1560.000000 0.002067 -0.001564 0.001486 +16615 1 0.000228 1560.000000 -0.001072 -0.002575 0.000135 +16616 1 0.000194 1560.000000 0.000099 0.002939 0.000405 +16617 1 0.000266 1560.000000 -0.000882 0.002933 0.004191 +16618 1 0.000209 1560.000000 0.001382 -0.003309 0.000155 +16619 1 0.000224 1560.000000 -0.000738 0.003382 0.000431 +16620 1 0.000200 1560.000000 0.000620 -0.001693 0.006172 +16621 1 0.000244 1560.000000 0.002793 -0.002126 0.000314 +16622 1 0.000201 1560.000000 0.000278 0.001937 0.006435 +16623 1 0.000197 1560.000000 0.001001 0.000588 0.001415 +16624 1 0.000249 1560.000000 -0.003273 0.000045 0.004830 +16625 1 0.000198 1560.000000 -0.000285 0.003087 0.008335 +16626 1 0.000227 1560.000000 0.003421 -0.001435 0.005821 +16627 1 0.000259 1560.000000 -0.003718 0.000337 0.009750 +16628 1 0.000224 1560.000000 -0.002154 -0.001490 0.003159 +16629 1 0.000193 1560.000000 0.000318 -0.001409 0.009455 +16630 1 0.000271 1560.000000 0.001668 -0.002909 0.006844 +16631 1 0.000251 1560.000000 -0.000313 0.001129 0.002333 +16632 1 0.000202 1560.000000 -0.002478 0.000410 0.005291 +16633 1 0.000237 1560.000000 0.000202 -0.003640 0.005082 +16634 1 0.000284 1560.000000 0.002953 -0.001019 0.003219 +16635 1 0.000198 1560.000000 -0.001454 0.001601 0.005925 +16636 1 0.000204 1560.000000 0.000112 -0.001821 0.007784 +16637 1 0.000225 1560.000000 0.002458 0.000317 0.004624 +16638 1 0.000285 1560.000000 0.002318 -0.002214 0.008461 +16639 1 0.000242 1560.000000 -0.002592 0.000654 0.005593 +16640 1 0.000263 1560.000000 -0.002046 -0.000467 0.007724 +16641 1 0.000255 1560.000000 0.003427 -0.001749 0.005590 +16642 1 0.000281 1560.000000 0.002015 0.003270 0.002371 +16643 1 0.000238 1560.000000 -0.002177 -0.000930 0.002534 +16644 1 0.000229 1560.000000 0.002090 -0.002657 0.002327 +16645 1 0.000249 1560.000000 0.000651 -0.002379 0.007063 +16646 1 0.000207 1560.000000 -0.000562 0.002899 0.008868 +16647 1 0.000256 1560.000000 -0.000199 -0.002827 0.008383 +16648 1 0.000223 1560.000000 0.002464 0.001463 0.001262 +16649 1 0.000217 1560.000000 0.002861 0.002529 0.009400 +16650 1 0.000241 1560.000000 -0.002421 -0.000227 0.003954 +16651 1 0.000276 1560.000000 0.001423 -0.003536 0.006903 +16652 1 0.000247 1560.000000 -0.003022 0.000433 0.000233 +16653 1 0.000203 1560.000000 -0.001079 0.000004 0.004114 +16654 1 0.000278 1560.000000 -0.001119 0.000137 0.008295 +16655 1 0.000263 1560.000000 -0.000116 -0.003594 0.005812 +16656 1 0.000238 1560.000000 0.001860 0.002195 0.006933 +16657 1 0.000226 1560.000000 0.002598 0.001008 0.002939 +16658 1 0.000269 1560.000000 -0.003493 0.000354 0.005983 +16659 1 0.000195 1560.000000 0.000655 -0.002045 0.001671 +16660 1 0.000201 1560.000000 -0.000779 0.002643 0.005094 +16661 1 0.000229 1560.000000 0.002373 0.000694 0.000884 +16662 1 0.000214 1560.000000 0.001666 -0.003447 0.004359 +16663 1 0.000197 1560.000000 0.001002 0.003063 0.007547 +16664 1 0.000241 1560.000000 -0.002504 0.002543 0.003915 +16665 1 0.000208 1560.000000 0.000165 0.002203 0.003568 +16666 1 0.000247 1560.000000 -0.000566 -0.001902 0.007086 +16667 1 0.000270 1560.000000 0.000889 0.002950 0.001949 +16668 1 0.000269 1560.000000 0.000533 -0.001814 0.001637 +16669 1 0.000199 1560.000000 -0.001005 0.002877 0.004503 +16670 1 0.000193 1560.000000 0.002615 -0.000751 0.009069 +16671 1 0.000205 1560.000000 0.000810 -0.000301 0.003966 +16672 1 0.000248 1560.000000 0.001993 0.003000 0.007960 +16673 1 0.000213 1560.000000 0.001869 0.000196 0.002752 +16674 1 0.000197 1560.000000 0.000513 -0.001408 0.006233 +16675 1 0.000281 1560.000000 -0.002647 0.000410 0.003846 +16676 1 0.000228 1560.000000 0.000389 -0.003750 0.009238 +16677 1 0.000233 1560.000000 -0.001645 -0.002999 0.005109 +16678 1 0.000225 1560.000000 -0.002579 -0.000494 0.003410 +16679 1 0.000232 1560.000000 -0.000217 -0.001587 0.000202 +16680 1 0.000247 1560.000000 -0.002794 -0.001855 0.000785 +16681 1 0.000226 1560.000000 0.002280 0.001525 0.009147 +16682 1 0.000204 1560.000000 0.000670 0.002611 0.002050 +16683 1 0.000223 1560.000000 0.002177 0.002764 0.005909 +16684 1 0.000244 1560.000000 -0.000273 -0.003094 0.002096 +16685 1 0.000251 1560.000000 -0.003146 0.002168 0.007223 +16686 1 0.000206 1560.000000 -0.003843 0.000026 0.005154 +16687 1 0.000216 1560.000000 0.002916 0.001908 0.001054 +16688 1 0.000276 1560.000000 0.002566 0.000362 0.001852 +16689 1 0.000213 1560.000000 0.003300 -0.000743 0.000383 +16690 1 0.000229 1560.000000 -0.000986 0.000858 0.004671 +16691 1 0.000265 1560.000000 0.001666 -0.001404 0.003071 +16692 1 0.000213 1560.000000 0.000568 0.000675 0.006366 +16693 1 0.000281 1560.000000 0.003654 0.000003 0.000958 +16694 1 0.000239 1560.000000 0.003352 0.000605 0.000573 +16695 1 0.000246 1560.000000 0.002300 0.000597 0.008993 +16696 1 0.000195 1560.000000 0.003242 -0.000231 0.000716 +16697 1 0.000268 1560.000000 -0.000822 0.003570 0.003021 +16698 1 0.000220 1560.000000 0.000652 0.003289 0.008450 +16699 1 0.000269 1560.000000 0.003315 -0.001769 0.009220 +16700 1 0.000228 1560.000000 -0.001703 -0.002433 0.008129 +16701 1 0.000239 1560.000000 -0.002004 -0.000476 0.001487 +16702 1 0.000193 1560.000000 -0.000734 -0.002257 0.007617 +16703 1 0.000255 1560.000000 0.000373 0.003201 0.007957 +16704 1 0.000241 1560.000000 -0.001671 -0.000663 0.004819 +16705 1 0.000243 1560.000000 0.000484 -0.003358 0.009077 +16706 1 0.000236 1560.000000 -0.000676 -0.002184 0.009209 +16707 1 0.000272 1560.000000 -0.000543 0.002760 0.006860 +16708 1 0.000225 1560.000000 -0.000118 -0.001040 0.003461 +16709 1 0.000213 1560.000000 -0.001441 0.003563 0.009126 +16710 1 0.000215 1560.000000 0.000330 0.002461 0.008557 +16711 1 0.000250 1560.000000 -0.000803 -0.003110 0.003658 +16712 1 0.000228 1560.000000 -0.000886 0.001242 0.007704 +16713 1 0.000246 1560.000000 -0.002695 0.000662 0.006895 +16714 1 0.000215 1560.000000 0.001093 0.003409 0.004097 +16715 1 0.000227 1560.000000 0.002971 -0.001558 0.005462 +16716 1 0.000226 1560.000000 -0.000756 -0.000322 0.003006 +16717 1 0.000267 1560.000000 0.003645 0.000323 0.008962 +16718 1 0.000228 1560.000000 -0.000631 0.001992 0.001181 +16719 1 0.000286 1560.000000 -0.002879 0.000388 0.002532 +16720 1 0.000268 1560.000000 -0.002787 -0.001610 0.008116 +16721 1 0.000255 1560.000000 -0.000054 -0.001626 0.006893 +16722 1 0.000226 1560.000000 0.001698 0.001259 0.001676 +16723 1 0.000229 1560.000000 -0.002069 0.002433 0.001592 +16724 1 0.000255 1560.000000 -0.002626 0.002135 0.003108 +16725 1 0.000242 1560.000000 -0.001249 -0.001177 0.006644 +16726 1 0.000274 1560.000000 -0.002862 0.002527 0.007795 +16727 1 0.000194 1560.000000 -0.000091 0.000874 0.004880 +16728 1 0.000207 1560.000000 0.000527 -0.003438 0.003558 +16729 1 0.000238 1560.000000 0.000247 -0.001677 0.005135 +16730 1 0.000281 1560.000000 0.002677 -0.002102 0.008484 +16731 1 0.000244 1560.000000 0.001355 0.002170 0.004991 +16732 1 0.000194 1560.000000 -0.001406 0.001080 0.005381 +16733 1 0.000258 1560.000000 -0.003083 0.000653 0.007778 +16734 1 0.000203 1560.000000 -0.001448 0.000920 0.004140 +16735 1 0.000228 1560.000000 -0.000426 0.001177 0.002635 +16736 1 0.000199 1560.000000 0.000059 -0.003167 0.007424 +16737 1 0.000194 1560.000000 0.001826 -0.002299 0.000127 +16738 1 0.000230 1560.000000 -0.000113 -0.001516 0.004074 +16739 1 0.000218 1560.000000 0.002928 -0.001637 0.003280 +16740 1 0.000256 1560.000000 0.001748 0.000238 0.006462 +16741 1 0.000251 1560.000000 0.000779 -0.002627 0.009836 +16742 1 0.000265 1560.000000 0.001062 -0.001128 0.004749 +16743 1 0.000200 1560.000000 0.000183 0.000922 0.005838 +16744 1 0.000224 1560.000000 -0.002768 -0.000326 0.007873 +16745 1 0.000200 1560.000000 -0.001075 0.002078 0.004873 +16746 1 0.000207 1560.000000 -0.003127 -0.002050 0.007728 +16747 1 0.000216 1560.000000 -0.002140 0.002635 0.005736 +16748 1 0.000223 1560.000000 -0.003506 -0.000731 0.001807 +16749 1 0.000205 1560.000000 -0.000365 0.003690 0.000435 +16750 1 0.000241 1560.000000 0.000417 -0.002282 0.009168 +16751 1 0.000251 1560.000000 -0.002829 -0.002352 0.008508 +16752 1 0.000224 1560.000000 -0.002356 -0.000971 0.009778 +16753 1 0.000232 1560.000000 -0.001035 0.002959 0.002052 +16754 1 0.000281 1560.000000 -0.001815 0.000119 0.009363 +16755 1 0.000204 1560.000000 -0.000601 0.002205 0.005128 +16756 1 0.000217 1560.000000 0.002090 -0.001728 0.000321 +16757 1 0.000193 1560.000000 -0.000567 0.001457 0.000330 +16758 1 0.000200 1560.000000 -0.003437 0.001734 0.008251 +16759 1 0.000272 1560.000000 0.002717 -0.000873 0.003357 +16760 1 0.000211 1560.000000 -0.002809 -0.000283 0.001991 +16761 1 0.000193 1560.000000 -0.002629 -0.000806 0.009571 +16762 1 0.000196 1560.000000 -0.001255 0.002564 0.005328 +16763 1 0.000261 1560.000000 -0.000249 -0.002010 0.007972 +16764 1 0.000222 1560.000000 0.003152 -0.001825 0.004445 +16765 1 0.000287 1560.000000 -0.003251 0.002055 0.007601 +16766 1 0.000221 1560.000000 -0.002758 -0.001364 0.000224 +16767 1 0.000215 1560.000000 -0.002357 -0.001688 0.008390 +16768 1 0.000200 1560.000000 -0.002020 -0.001035 0.006114 +16769 1 0.000198 1560.000000 -0.000839 0.001396 0.006896 +16770 1 0.000264 1560.000000 0.003234 0.000571 0.003938 +16771 1 0.000196 1560.000000 -0.003076 0.001351 0.001152 +16772 1 0.000272 1560.000000 -0.002885 -0.000486 0.007547 +16773 1 0.000284 1560.000000 0.002464 -0.001907 0.006894 +16774 1 0.000245 1560.000000 0.001593 0.003189 0.008558 +16775 1 0.000221 1560.000000 0.003678 -0.000974 0.001270 +16776 1 0.000230 1560.000000 -0.000729 0.002211 0.002947 +16777 1 0.000274 1560.000000 -0.001933 -0.003203 0.003577 +16778 1 0.000227 1560.000000 -0.001973 -0.001579 0.001231 +16779 1 0.000205 1560.000000 0.000270 -0.002428 0.006421 +16780 1 0.000196 1560.000000 -0.002005 0.002198 0.003816 +16781 1 0.000282 1560.000000 0.000284 0.003024 0.009573 +16782 1 0.000231 1560.000000 0.002079 -0.001970 0.000940 +16783 1 0.000211 1560.000000 -0.001074 -0.002240 0.005701 +16784 1 0.000237 1560.000000 0.001425 0.002199 0.003160 +16785 1 0.000196 1560.000000 -0.002017 0.002680 0.007546 +16786 1 0.000205 1560.000000 -0.002867 0.001352 0.000275 +16787 1 0.000235 1560.000000 0.001535 0.001703 0.009067 +16788 1 0.000235 1560.000000 -0.001207 0.003394 0.007836 +16789 1 0.000258 1560.000000 -0.003132 0.000411 0.005540 +16790 1 0.000269 1560.000000 -0.000671 0.002253 0.009307 +16791 1 0.000261 1560.000000 0.001854 0.000958 0.003114 +16792 1 0.000237 1560.000000 0.001910 -0.003325 0.003535 +16793 1 0.000240 1560.000000 0.002547 -0.000022 0.006772 +16794 1 0.000200 1560.000000 -0.001359 -0.002133 0.008599 +16795 1 0.000238 1560.000000 -0.000386 -0.002397 0.009825 +16796 1 0.000239 1560.000000 0.001933 -0.001274 0.000183 +16797 1 0.000247 1560.000000 0.001500 0.002252 0.002689 +16798 1 0.000203 1560.000000 0.001418 0.000223 0.001554 +16799 1 0.000199 1560.000000 0.001335 0.003197 0.005232 +16800 1 0.000243 1560.000000 -0.001974 0.000785 0.001738 +16801 1 0.000219 1560.000000 0.002274 -0.001537 0.001306 +16802 1 0.000284 1560.000000 -0.003000 0.002387 0.006622 +16803 1 0.000231 1560.000000 -0.001701 -0.000401 0.001480 +16804 1 0.000238 1560.000000 0.002391 0.001125 0.003295 +16805 1 0.000194 1560.000000 -0.001557 -0.002025 0.001599 +16806 1 0.000212 1560.000000 -0.000116 -0.000249 0.001780 +16807 1 0.000192 1560.000000 0.000886 0.000939 0.007828 +16808 1 0.000216 1560.000000 0.000131 -0.001662 0.009799 +16809 1 0.000281 1560.000000 0.000807 0.002297 0.001799 +16810 1 0.000252 1560.000000 -0.002232 0.001451 0.003368 +16811 1 0.000254 1560.000000 -0.000236 0.003427 0.003222 +16812 1 0.000206 1560.000000 0.000541 -0.003815 0.009567 +16813 1 0.000225 1560.000000 -0.001543 -0.002932 0.003609 +16814 1 0.000279 1560.000000 0.001955 0.000462 0.006334 +16815 1 0.000284 1560.000000 -0.003794 0.000509 0.003820 +16816 1 0.000201 1560.000000 -0.002841 -0.002511 0.001103 +16817 1 0.000197 1560.000000 0.001413 0.000836 0.008370 +16818 1 0.000235 1560.000000 0.001440 -0.002524 0.005403 +16819 1 0.000249 1560.000000 0.001836 -0.002390 0.005419 +16820 1 0.000249 1560.000000 -0.003288 -0.000875 0.006879 +16821 1 0.000212 1560.000000 -0.002423 -0.002572 0.007458 +16822 1 0.000217 1560.000000 0.001236 0.002314 0.002115 +16823 1 0.000211 1560.000000 0.002667 -0.002729 0.009172 +16824 1 0.000240 1560.000000 -0.003179 -0.001764 0.000721 +16825 1 0.000270 1560.000000 0.002138 0.002102 0.000146 +16826 1 0.000246 1560.000000 -0.001543 -0.000615 0.001001 +16827 1 0.000242 1560.000000 0.001122 0.001872 0.001397 +16828 1 0.000230 1560.000000 0.000614 -0.003074 0.000120 +16829 1 0.000284 1560.000000 0.001183 -0.003561 0.009852 +16830 1 0.000205 1560.000000 -0.002147 -0.002419 0.009296 +16831 1 0.000204 1560.000000 -0.001750 -0.002446 0.002495 +16832 1 0.000227 1560.000000 0.002194 -0.002649 0.008386 +16833 1 0.000268 1560.000000 -0.003670 -0.000351 0.003111 +16834 1 0.000257 1560.000000 0.002489 -0.000719 0.006155 +16835 1 0.000273 1560.000000 -0.002396 0.000992 0.003189 +16836 1 0.000259 1560.000000 -0.001035 0.000855 0.006593 +16837 1 0.000205 1560.000000 0.000454 0.001820 0.001391 +16838 1 0.000222 1560.000000 0.001752 -0.001399 0.008259 +16839 1 0.000198 1560.000000 0.002943 0.000660 0.002587 +16840 1 0.000271 1560.000000 0.000445 -0.001593 0.007274 +16841 1 0.000201 1560.000000 -0.002876 -0.001629 0.008850 +16842 1 0.000220 1560.000000 -0.002321 0.000664 0.008331 +16843 1 0.000195 1560.000000 -0.000141 -0.000865 0.000981 +16844 1 0.000250 1560.000000 0.001220 0.003649 0.005742 +16845 1 0.000262 1560.000000 -0.001017 -0.000498 0.007421 +16846 1 0.000216 1560.000000 0.001423 -0.002293 0.006535 +16847 1 0.000240 1560.000000 0.000318 -0.001499 0.008918 +16848 1 0.000208 1560.000000 0.003078 0.001143 0.001951 +16849 1 0.000229 1560.000000 -0.002081 0.001733 0.000138 +16850 1 0.000223 1560.000000 -0.003632 0.000106 0.003239 +16851 1 0.000224 1560.000000 -0.001395 -0.003194 0.001851 +16852 1 0.000249 1560.000000 0.000741 0.003748 0.008067 +16853 1 0.000215 1560.000000 0.000112 0.000252 0.001134 +16854 1 0.000228 1560.000000 0.002068 -0.001187 0.003509 +16855 1 0.000203 1560.000000 0.000115 -0.001730 0.008104 +16856 1 0.000232 1560.000000 -0.003071 0.001064 0.008395 +16857 1 0.000212 1560.000000 -0.000106 0.003240 0.002736 +16858 1 0.000198 1560.000000 -0.002562 -0.002796 0.002382 +16859 1 0.000228 1560.000000 -0.001398 -0.002285 0.006443 +16860 1 0.000212 1560.000000 -0.000313 -0.001793 0.001323 +16861 1 0.000226 1560.000000 0.002323 -0.001847 0.009211 +16862 1 0.000194 1560.000000 -0.001345 -0.003331 0.008813 +16863 1 0.000281 1560.000000 0.002554 0.002509 0.002166 +16864 1 0.000220 1560.000000 -0.003307 0.001384 0.009590 +16865 1 0.000211 1560.000000 -0.000446 -0.002594 0.000389 +16866 1 0.000255 1560.000000 -0.002821 -0.000987 0.008884 +16867 1 0.000248 1560.000000 0.003440 0.001153 0.008793 +16868 1 0.000213 1560.000000 -0.003244 -0.000068 0.000931 +16869 1 0.000279 1560.000000 -0.001185 -0.002532 0.001763 +16870 1 0.000208 1560.000000 -0.002538 -0.001422 0.004137 +16871 1 0.000242 1560.000000 0.001120 -0.003615 0.004499 +16872 1 0.000246 1560.000000 -0.001973 -0.001572 0.000157 +16873 1 0.000203 1560.000000 0.001833 -0.001792 0.001936 +16874 1 0.000255 1560.000000 0.000618 -0.000820 0.006387 +16875 1 0.000262 1560.000000 0.002006 -0.001046 0.006311 +16876 1 0.000193 1560.000000 0.001276 -0.001430 0.003509 +16877 1 0.000215 1560.000000 -0.003380 0.000306 0.008216 +16878 1 0.000205 1560.000000 0.003097 -0.001803 0.009033 +16879 1 0.000284 1560.000000 0.003557 0.001397 0.006712 +16880 1 0.000206 1560.000000 -0.000032 -0.000231 0.005416 +16881 1 0.000222 1560.000000 -0.003789 0.000509 0.006115 +16882 1 0.000230 1560.000000 -0.001210 -0.001597 0.003903 +16883 1 0.000205 1560.000000 -0.002734 -0.001995 0.003383 +16884 1 0.000216 1560.000000 -0.000192 -0.003815 0.006286 +16885 1 0.000199 1560.000000 -0.000112 -0.003467 0.006832 +16886 1 0.000199 1560.000000 0.000110 -0.002806 0.006785 +16887 1 0.000234 1560.000000 0.001208 0.001063 0.002425 +16888 1 0.000193 1560.000000 0.000359 0.003829 0.001876 +16889 1 0.000207 1560.000000 -0.001278 -0.002995 0.007727 +16890 1 0.000275 1560.000000 0.002443 0.002923 0.005067 +16891 1 0.000204 1560.000000 0.001018 -0.002508 0.008337 +16892 1 0.000199 1560.000000 0.000915 0.001585 0.006686 +16893 1 0.000216 1560.000000 -0.001145 0.003071 0.000340 +16894 1 0.000235 1560.000000 0.003496 -0.000475 0.001801 +16895 1 0.000270 1560.000000 -0.001053 -0.003680 0.003163 +16896 1 0.000280 1560.000000 0.002167 -0.003161 0.003903 +16897 1 0.000196 1560.000000 -0.003297 -0.001471 0.008316 +16898 1 0.000231 1560.000000 0.002185 0.002417 0.007860 +16899 1 0.000199 1560.000000 0.001339 0.001545 0.006140 +16900 1 0.000194 1560.000000 -0.001125 -0.000442 0.002803 +16901 1 0.000222 1560.000000 -0.000044 -0.002372 0.009267 +16902 1 0.000225 1560.000000 0.000464 0.000251 0.009303 +16903 1 0.000258 1560.000000 -0.001468 0.003298 0.004334 +16904 1 0.000219 1560.000000 -0.003155 -0.000443 0.006405 +16905 1 0.000198 1560.000000 -0.000089 0.002401 0.006615 +16906 1 0.000260 1560.000000 -0.002615 -0.001817 0.007178 +16907 1 0.000198 1560.000000 -0.003091 0.001570 0.000605 +16908 1 0.000200 1560.000000 0.002654 0.001450 0.000471 +16909 1 0.000238 1560.000000 -0.001792 -0.001296 0.001270 +16910 1 0.000226 1560.000000 0.001953 -0.000512 0.006701 +16911 1 0.000194 1560.000000 -0.000304 0.000953 0.004395 +16912 1 0.000229 1560.000000 -0.000096 0.002436 0.000140 +16913 1 0.000234 1560.000000 -0.001414 0.002039 0.007202 +16914 1 0.000218 1560.000000 0.003130 -0.000643 0.002798 +16915 1 0.000260 1560.000000 -0.002540 -0.000958 0.007150 +16916 1 0.000200 1560.000000 0.000510 -0.001960 0.003816 +16917 1 0.000247 1560.000000 -0.002716 0.002275 0.009824 +16918 1 0.000214 1560.000000 0.001536 -0.002600 0.000388 +16919 1 0.000199 1560.000000 -0.001689 -0.000295 0.005057 +16920 1 0.000237 1560.000000 0.002549 0.001697 0.009357 +16921 1 0.000224 1560.000000 0.002535 0.002234 0.003150 +16922 1 0.000256 1560.000000 -0.001566 -0.002977 0.009078 +16923 1 0.000287 1560.000000 0.000498 -0.003758 0.001656 +16924 1 0.000210 1560.000000 -0.000266 -0.003615 0.007896 +16925 1 0.000257 1560.000000 -0.003712 -0.000162 0.000291 +16926 1 0.000195 1560.000000 0.001125 0.003676 0.009285 +16927 1 0.000197 1560.000000 -0.000267 -0.003608 0.003393 +16928 1 0.000199 1560.000000 0.001420 0.001258 0.007173 +16929 1 0.000269 1560.000000 -0.002547 -0.001796 0.009752 +16930 1 0.000219 1560.000000 -0.000872 -0.001327 0.005018 +16931 1 0.000202 1560.000000 0.002029 0.002027 0.007578 +16932 1 0.000269 1560.000000 -0.000386 -0.001134 0.007708 +16933 1 0.000258 1560.000000 0.001751 0.001366 0.005960 +16934 1 0.000222 1560.000000 -0.002088 -0.003223 0.000250 +16935 1 0.000218 1560.000000 -0.001684 0.002385 0.000161 +16936 1 0.000196 1560.000000 -0.003247 0.000560 0.002664 +16937 1 0.000282 1560.000000 0.002105 -0.001809 0.009345 +16938 1 0.000226 1560.000000 -0.000293 -0.003670 0.008682 +16939 1 0.000283 1560.000000 -0.001513 -0.003339 0.002240 +16940 1 0.000247 1560.000000 0.000715 -0.002652 0.000197 +16941 1 0.000201 1560.000000 0.000273 -0.003361 0.009148 +16942 1 0.000221 1560.000000 0.002540 -0.001290 0.002143 +16943 1 0.000234 1560.000000 -0.003743 0.000367 0.002724 +16944 1 0.000259 1560.000000 0.001800 -0.003349 0.003118 +16945 1 0.000192 1560.000000 -0.001541 -0.000642 0.002621 +16946 1 0.000258 1560.000000 0.003702 0.000890 0.002863 +16947 1 0.000247 1560.000000 0.002944 0.001817 0.000826 +16948 1 0.000230 1560.000000 -0.000969 0.000349 0.008537 +16949 1 0.000216 1560.000000 0.000927 -0.000791 0.008219 +16950 1 0.000250 1560.000000 0.002197 0.000319 0.006959 +16951 1 0.000273 1560.000000 -0.002923 -0.000938 0.006986 +16952 1 0.000217 1560.000000 0.000290 0.003823 0.004819 +16953 1 0.000253 1560.000000 0.002917 -0.000405 0.007673 +16954 1 0.000204 1560.000000 0.002691 0.001485 0.006554 +16955 1 0.000251 1560.000000 0.002281 -0.002748 0.006034 +16956 1 0.000221 1560.000000 0.003165 0.002150 0.004916 +16957 1 0.000211 1560.000000 0.000874 -0.002257 0.002119 +16958 1 0.000225 1560.000000 0.001501 0.003340 0.006447 +16959 1 0.000192 1560.000000 0.000439 -0.003808 0.008962 +16960 1 0.000253 1560.000000 0.003332 -0.001430 0.002156 +16961 1 0.000240 1560.000000 -0.003498 -0.001489 0.001446 +16962 1 0.000224 1560.000000 -0.003346 0.000195 0.005518 +16963 1 0.000259 1560.000000 -0.000883 0.000187 0.009277 +16964 1 0.000277 1560.000000 -0.002870 -0.000528 0.009665 +16965 1 0.000199 1560.000000 -0.001386 0.003174 0.009018 +16966 1 0.000201 1560.000000 0.000694 -0.001952 0.006987 +16967 1 0.000259 1560.000000 -0.002128 0.003110 0.000530 +16968 1 0.000200 1560.000000 -0.000327 0.001353 0.007438 +16969 1 0.000204 1560.000000 0.001798 0.001813 0.008377 +16970 1 0.000221 1560.000000 -0.001031 0.001833 0.004045 +16971 1 0.000194 1560.000000 0.002184 0.001730 0.009761 +16972 1 0.000265 1560.000000 -0.003735 -0.000025 0.008038 +16973 1 0.000205 1560.000000 0.000190 0.001850 0.006949 +16974 1 0.000284 1560.000000 0.001419 0.001415 0.007828 +16975 1 0.000235 1560.000000 -0.002355 0.002126 0.001139 +16976 1 0.000263 1560.000000 0.002503 0.001776 0.004911 +16977 1 0.000244 1560.000000 -0.000024 0.003292 0.000649 +16978 1 0.000271 1560.000000 -0.002283 -0.000062 0.008547 +16979 1 0.000286 1560.000000 0.002240 0.001944 0.002332 +16980 1 0.000279 1560.000000 -0.000247 0.003832 0.008952 +16981 1 0.000287 1560.000000 0.002720 -0.002523 0.005060 +16982 1 0.000278 1560.000000 -0.003292 0.000410 0.007856 +16983 1 0.000274 1560.000000 -0.002401 0.001026 0.009494 +16984 1 0.000249 1560.000000 -0.002163 -0.000189 0.004098 +16985 1 0.000260 1560.000000 0.000400 0.002306 0.002302 +16986 1 0.000208 1560.000000 -0.000523 0.000134 0.001169 +16987 1 0.000212 1560.000000 0.003236 0.000662 0.009763 +16988 1 0.000194 1560.000000 0.001300 0.002296 0.005364 +16989 1 0.000253 1560.000000 -0.000233 -0.003275 0.008701 +16990 1 0.000287 1560.000000 0.001998 0.003214 0.005579 +16991 1 0.000205 1560.000000 -0.001705 0.001769 0.006433 +16992 1 0.000261 1560.000000 -0.000758 0.001346 0.003118 +16993 1 0.000284 1560.000000 -0.000864 -0.003226 0.002376 +16994 1 0.000193 1560.000000 0.000745 0.002145 0.000736 +16995 1 0.000268 1560.000000 0.000592 -0.001331 0.000279 +16996 1 0.000213 1560.000000 -0.002345 0.002143 0.003148 +16997 1 0.000222 1560.000000 0.002963 0.000874 0.003677 +16998 1 0.000216 1560.000000 -0.000819 -0.000109 0.009368 +16999 1 0.000206 1560.000000 0.001104 -0.000098 0.005836 +17000 1 0.000271 1560.000000 0.002677 -0.001311 0.001217 +17001 1 0.000205 1560.000000 -0.001124 0.003680 0.002160 +17002 1 0.000242 1560.000000 0.002618 0.001235 0.005807 +17003 1 0.000274 1560.000000 -0.000654 0.002874 0.004420 +17004 1 0.000250 1560.000000 0.000118 -0.003509 0.006775 +17005 1 0.000228 1560.000000 0.001068 -0.003192 0.006938 +17006 1 0.000253 1560.000000 0.000191 0.002537 0.008374 +17007 1 0.000264 1560.000000 -0.001398 -0.002118 0.008181 +17008 1 0.000231 1560.000000 0.001915 0.000960 0.007237 +17009 1 0.000243 1560.000000 0.002709 0.002217 0.002116 +17010 1 0.000204 1560.000000 -0.000296 0.001513 0.004332 +17011 1 0.000198 1560.000000 -0.000867 -0.002810 0.001281 +17012 1 0.000258 1560.000000 0.002157 0.001513 0.009462 +17013 1 0.000197 1560.000000 -0.001901 0.002061 0.007664 +17014 1 0.000276 1560.000000 0.002384 0.000321 0.008254 +17015 1 0.000210 1560.000000 0.000809 -0.002979 0.008503 +17016 1 0.000259 1560.000000 0.000046 0.000933 0.002259 +17017 1 0.000196 1560.000000 0.001535 0.001584 0.008154 +17018 1 0.000281 1560.000000 0.001929 -0.002396 0.005969 +17019 1 0.000221 1560.000000 0.003070 0.002135 0.006394 +17020 1 0.000194 1560.000000 -0.000835 0.002197 0.006693 +17021 1 0.000241 1560.000000 0.001639 -0.001171 0.009513 +17022 1 0.000249 1560.000000 0.000787 0.002937 0.004044 +17023 1 0.000268 1560.000000 -0.002116 -0.001656 0.005244 +17024 1 0.000243 1560.000000 0.002303 -0.002080 0.001375 +17025 1 0.000227 1560.000000 0.000272 -0.001734 0.005499 +17026 1 0.000241 1560.000000 -0.001755 -0.002825 0.007663 +17027 1 0.000197 1560.000000 -0.000995 0.001575 0.008673 +17028 1 0.000277 1560.000000 -0.000265 -0.002637 0.002897 +17029 1 0.000193 1560.000000 -0.001198 -0.002105 0.000729 +17030 1 0.000212 1560.000000 0.001200 -0.001416 0.001388 +17031 1 0.000192 1560.000000 -0.000976 -0.003148 0.006792 +17032 1 0.000261 1560.000000 -0.002233 0.002350 0.000358 +17033 1 0.000225 1560.000000 -0.001623 -0.001549 0.008455 +17034 1 0.000256 1560.000000 0.003325 -0.000061 0.002619 +17035 1 0.000212 1560.000000 -0.001753 0.001150 0.002290 +17036 1 0.000252 1560.000000 0.000060 0.000589 0.006715 +17037 1 0.000262 1560.000000 -0.001677 -0.001286 0.006966 +17038 1 0.000202 1560.000000 -0.002704 -0.002093 0.002777 +17039 1 0.000244 1560.000000 0.000234 0.002386 0.003926 +17040 1 0.000284 1560.000000 0.002719 0.001753 0.005671 +17041 1 0.000229 1560.000000 0.003657 -0.001175 0.003125 +17042 1 0.000214 1560.000000 0.002107 0.000630 0.003895 +17043 1 0.000235 1560.000000 -0.001021 -0.001770 0.007455 +17044 1 0.000209 1560.000000 -0.000647 -0.001349 0.003702 +17045 1 0.000206 1560.000000 -0.000856 -0.002794 0.007224 +17046 1 0.000213 1560.000000 -0.001108 0.001043 0.008532 +17047 1 0.000219 1560.000000 -0.002287 0.000746 0.004818 +17048 1 0.000225 1560.000000 0.001069 0.002850 0.007526 +17049 1 0.000207 1560.000000 0.001691 0.003439 0.001384 +17050 1 0.000274 1560.000000 -0.003126 0.000415 0.001566 +17051 1 0.000201 1560.000000 0.001913 -0.001614 0.002424 +17052 1 0.000198 1560.000000 0.001187 -0.000095 0.002645 +17053 1 0.000278 1560.000000 0.002996 -0.000875 0.004083 +17054 1 0.000234 1560.000000 0.001585 -0.002556 0.002297 +17055 1 0.000220 1560.000000 -0.002195 0.002098 0.000386 +17056 1 0.000221 1560.000000 0.001711 0.000881 0.006902 +17057 1 0.000239 1560.000000 0.003457 0.000792 0.002039 +17058 1 0.000202 1560.000000 -0.001320 -0.000340 0.005825 +17059 1 0.000249 1560.000000 -0.000840 -0.003296 0.006117 +17060 1 0.000250 1560.000000 -0.001081 0.003407 0.009792 +17061 1 0.000266 1560.000000 -0.000034 0.002458 0.003509 +17062 1 0.000257 1560.000000 -0.002424 -0.001925 0.004763 +17063 1 0.000284 1560.000000 0.003815 -0.000339 0.004172 +17064 1 0.000213 1560.000000 -0.001162 -0.000355 0.007737 +17065 1 0.000202 1560.000000 -0.001542 0.003185 0.009333 +17066 1 0.000269 1560.000000 -0.003419 -0.001491 0.004781 +17067 1 0.000258 1560.000000 0.003819 -0.000424 0.007456 +17068 1 0.000247 1560.000000 -0.000428 -0.002038 0.003850 +17069 1 0.000287 1560.000000 -0.000522 -0.003497 0.009794 +17070 1 0.000195 1560.000000 -0.002465 -0.001092 0.006245 +17071 1 0.000268 1560.000000 -0.000267 -0.003184 0.003347 +17072 1 0.000242 1560.000000 0.002910 -0.000150 0.003865 +17073 1 0.000215 1560.000000 0.002372 0.000704 0.001764 +17074 1 0.000225 1560.000000 0.000260 -0.000046 0.004304 +17075 1 0.000204 1560.000000 -0.002027 0.000935 0.004884 +17076 1 0.000230 1560.000000 -0.002570 0.001026 0.000498 +17077 1 0.000202 1560.000000 0.000528 0.001549 0.007545 +17078 1 0.000263 1560.000000 -0.002441 -0.002661 0.006638 +17079 1 0.000200 1560.000000 0.003754 0.000613 0.002863 +17080 1 0.000284 1560.000000 -0.001481 -0.001819 0.002667 +17081 1 0.000272 1560.000000 0.003675 0.001158 0.002320 +17082 1 0.000231 1560.000000 0.002198 -0.001557 0.005056 +17083 1 0.000236 1560.000000 0.003818 0.000261 0.002643 +17084 1 0.000275 1560.000000 0.001497 -0.003504 0.007767 +17085 1 0.000284 1560.000000 -0.001919 -0.000913 0.008926 +17086 1 0.000198 1560.000000 -0.000389 -0.000628 0.008203 +17087 1 0.000233 1560.000000 0.000081 0.001080 0.000153 +17088 1 0.000223 1560.000000 0.001279 -0.002619 0.007107 +17089 1 0.000196 1560.000000 0.001292 -0.000391 0.001660 +17090 1 0.000199 1560.000000 0.000117 -0.000959 0.003449 +17091 1 0.000203 1560.000000 0.000876 0.002425 0.006163 +17092 1 0.000227 1560.000000 -0.002371 -0.002503 0.000148 +17093 1 0.000263 1560.000000 0.000532 -0.002019 0.008420 +17094 1 0.000194 1560.000000 -0.002748 0.002154 0.006157 +17095 1 0.000240 1560.000000 -0.003124 0.000569 0.007389 +17096 1 0.000221 1560.000000 0.001554 0.002788 0.003676 +17097 1 0.000202 1560.000000 0.000079 -0.002760 0.004659 +17098 1 0.000227 1560.000000 0.000671 -0.000845 0.001188 +17099 1 0.000213 1560.000000 0.003488 0.000607 0.004788 +17100 1 0.000212 1560.000000 0.003201 -0.001218 0.000483 +17101 1 0.000282 1560.000000 0.003752 -0.000784 0.004588 +17102 1 0.000236 1560.000000 0.003620 0.001114 0.003744 +17103 1 0.000284 1560.000000 -0.001906 -0.003348 0.001948 +17104 1 0.000194 1560.000000 -0.001653 -0.001493 0.004556 +17105 1 0.000206 1560.000000 -0.002547 0.002112 0.003430 +17106 1 0.000226 1560.000000 0.002466 -0.002484 0.004938 +17107 1 0.000250 1560.000000 -0.001818 -0.002536 0.007875 +17108 1 0.000205 1560.000000 -0.001370 0.000369 0.006194 +17109 1 0.000197 1560.000000 -0.000274 0.000325 0.004040 +17110 1 0.000212 1560.000000 0.001805 0.001985 0.008930 +17111 1 0.000253 1560.000000 0.003658 -0.000859 0.007218 +17112 1 0.000226 1560.000000 0.001415 -0.001184 0.000759 +17113 1 0.000210 1560.000000 0.001834 0.000562 0.006806 +17114 1 0.000227 1560.000000 0.002886 -0.001727 0.001010 +17115 1 0.000266 1560.000000 0.001635 0.003381 0.005958 +17116 1 0.000224 1560.000000 0.003161 0.000952 0.003492 +17117 1 0.000274 1560.000000 -0.001592 0.000625 0.007018 +17118 1 0.000277 1560.000000 0.003304 -0.000050 0.000541 +17119 1 0.000204 1560.000000 0.001594 0.002223 0.002169 +17120 1 0.000218 1560.000000 -0.003007 -0.000715 0.008033 +17121 1 0.000286 1560.000000 -0.000840 -0.002757 0.008405 +17122 1 0.000221 1560.000000 0.000035 0.002237 0.004733 +17123 1 0.000277 1560.000000 -0.000743 0.002888 0.005070 +17124 1 0.000265 1560.000000 -0.001495 0.001250 0.006183 +17125 1 0.000243 1560.000000 0.001414 0.000773 0.007375 +17126 1 0.000252 1560.000000 -0.002498 -0.002386 0.001048 +17127 1 0.000256 1560.000000 -0.001046 -0.002635 0.001067 +17128 1 0.000204 1560.000000 -0.000488 0.000588 0.009095 +17129 1 0.000210 1560.000000 0.000732 0.000016 0.001685 +17130 1 0.000247 1560.000000 -0.000347 -0.003590 0.001687 +17131 1 0.000202 1560.000000 0.000519 0.000388 0.002671 +17132 1 0.000247 1560.000000 0.001617 0.002093 0.005260 +17133 1 0.000233 1560.000000 -0.000354 0.001703 0.008904 +17134 1 0.000227 1560.000000 0.001471 0.003029 0.003270 +17135 1 0.000260 1560.000000 -0.001221 -0.002937 0.007011 +17136 1 0.000270 1560.000000 0.001331 0.002814 0.001675 +17137 1 0.000242 1560.000000 0.000969 -0.003140 0.000375 +17138 1 0.000227 1560.000000 0.002511 0.001290 0.006061 +17139 1 0.000229 1560.000000 0.001711 -0.002655 0.006442 +17140 1 0.000254 1560.000000 0.003080 -0.001827 0.009471 +17141 1 0.000215 1560.000000 -0.002170 -0.001939 0.003504 +17142 1 0.000213 1560.000000 0.003060 0.000029 0.006298 +17143 1 0.000219 1560.000000 0.001405 -0.003283 0.003733 +17144 1 0.000227 1560.000000 0.003539 -0.001376 0.005048 +17145 1 0.000243 1560.000000 -0.001938 -0.003065 0.005996 +17146 1 0.000267 1560.000000 -0.001170 0.000368 0.008881 +17147 1 0.000239 1560.000000 0.000896 -0.003666 0.006547 +17148 1 0.000219 1560.000000 -0.001564 0.002780 0.000388 +17149 1 0.000198 1560.000000 -0.001976 -0.001455 0.003389 +17150 1 0.000288 1560.000000 0.000066 -0.003170 0.005379 +17151 1 0.000271 1560.000000 -0.001482 0.001440 0.001367 +17152 1 0.000253 1560.000000 0.002054 -0.000685 0.002816 +17153 1 0.000260 1560.000000 0.002317 -0.000595 0.000186 +17154 1 0.000227 1560.000000 0.000010 0.002865 0.009680 +17155 1 0.000260 1560.000000 0.000594 -0.000273 0.004255 +17156 1 0.000229 1560.000000 -0.001921 -0.000878 0.005860 +17157 1 0.000286 1560.000000 -0.001005 0.002767 0.004739 +17158 1 0.000264 1560.000000 -0.003767 0.000787 0.005348 +17159 1 0.000246 1560.000000 0.000966 0.003501 0.001686 +17160 1 0.000255 1560.000000 0.003377 -0.000496 0.006590 +17161 1 0.000213 1560.000000 -0.003397 -0.000442 0.003681 +17162 1 0.000251 1560.000000 -0.001966 -0.002806 0.003512 +17163 1 0.000206 1560.000000 0.000713 -0.001654 0.009135 +17164 1 0.000200 1560.000000 0.003307 -0.001332 0.004547 +17165 1 0.000209 1560.000000 -0.002459 -0.000665 0.000194 +17166 1 0.000232 1560.000000 -0.000079 -0.000662 0.007627 +17167 1 0.000209 1560.000000 -0.002572 0.002366 0.002734 +17168 1 0.000195 1560.000000 0.001542 -0.002919 0.009353 +17169 1 0.000204 1560.000000 0.002468 0.002893 0.003802 +17170 1 0.000242 1560.000000 -0.000033 -0.002233 0.005162 +17171 1 0.000241 1560.000000 0.001632 0.002491 0.006257 +17172 1 0.000246 1560.000000 0.000688 -0.002989 0.002965 +17173 1 0.000225 1560.000000 -0.003015 -0.000567 0.000446 +17174 1 0.000197 1560.000000 0.000398 -0.001214 0.003950 +17175 1 0.000225 1560.000000 0.000007 0.003497 0.008674 +17176 1 0.000266 1560.000000 0.000664 -0.000305 0.006695 +17177 1 0.000260 1560.000000 -0.000450 -0.002490 0.007599 +17178 1 0.000246 1560.000000 0.003309 -0.000737 0.008008 +17179 1 0.000222 1560.000000 -0.000235 0.001744 0.003167 +17180 1 0.000267 1560.000000 0.003716 -0.001003 0.008893 +17181 1 0.000204 1560.000000 -0.000113 -0.000313 0.000985 +17182 1 0.000240 1560.000000 0.000881 -0.001746 0.008143 +17183 1 0.000256 1560.000000 0.001457 0.003563 0.002845 +17184 1 0.000283 1560.000000 0.002729 0.001387 0.001361 +17185 1 0.000213 1560.000000 -0.001118 -0.001438 0.008217 +17186 1 0.000193 1560.000000 0.002329 -0.002819 0.007689 +17187 1 0.000246 1560.000000 -0.003433 0.001586 0.008001 +17188 1 0.000194 1560.000000 0.002881 0.001867 0.003599 +17189 1 0.000227 1560.000000 0.002133 -0.001514 0.000793 +17190 1 0.000264 1560.000000 0.003787 -0.000551 0.006374 +17191 1 0.000199 1560.000000 0.000748 -0.003432 0.002471 +17192 1 0.000281 1560.000000 -0.002140 -0.000054 0.007282 +17193 1 0.000201 1560.000000 -0.003107 -0.002223 0.005770 +17194 1 0.000232 1560.000000 -0.001787 -0.001416 0.007392 +17195 1 0.000205 1560.000000 0.000666 -0.000549 0.009794 +17196 1 0.000232 1560.000000 0.000027 -0.001215 0.000352 +17197 1 0.000223 1560.000000 0.002881 -0.001834 0.004637 +17198 1 0.000247 1560.000000 -0.000418 -0.003245 0.008311 +17199 1 0.000269 1560.000000 0.002398 -0.000929 0.001690 +17200 1 0.000231 1560.000000 0.003125 0.002245 0.005991 +17201 1 0.000211 1560.000000 -0.000127 0.001141 0.004992 +17202 1 0.000224 1560.000000 -0.000784 0.000944 0.008238 +17203 1 0.000217 1560.000000 -0.001837 0.002996 0.007250 +17204 1 0.000221 1560.000000 -0.000168 0.001799 0.001364 +17205 1 0.000197 1560.000000 -0.001183 0.000615 0.008989 +17206 1 0.000231 1560.000000 0.003140 0.001723 0.003043 +17207 1 0.000202 1560.000000 -0.000705 -0.000983 0.004589 +17208 1 0.000265 1560.000000 0.000313 -0.003256 0.002804 +17209 1 0.000213 1560.000000 -0.002097 -0.001132 0.007638 +17210 1 0.000213 1560.000000 -0.000691 -0.000277 0.000640 +17211 1 0.000239 1560.000000 0.002107 0.003054 0.003433 +17212 1 0.000232 1560.000000 -0.001392 0.002576 0.000479 +17213 1 0.000234 1560.000000 0.003517 -0.000230 0.000161 +17214 1 0.000264 1560.000000 0.002868 -0.002414 0.000261 +17215 1 0.000247 1560.000000 -0.003763 0.000826 0.002611 +17216 1 0.000193 1560.000000 0.002624 0.001633 0.000169 +17217 1 0.000261 1560.000000 -0.001355 0.003486 0.005567 +17218 1 0.000225 1560.000000 0.002271 0.001502 0.006837 +17219 1 0.000228 1560.000000 -0.002698 -0.002299 0.006610 +17220 1 0.000260 1560.000000 0.000635 -0.002004 0.003270 +17221 1 0.000203 1560.000000 -0.001202 0.000349 0.006664 +17222 1 0.000226 1560.000000 0.003372 0.000243 0.006485 +17223 1 0.000223 1560.000000 -0.000726 0.003651 0.000172 +17224 1 0.000199 1560.000000 0.000140 0.003476 0.006191 +17225 1 0.000247 1560.000000 0.002823 0.000495 0.004093 +17226 1 0.000232 1560.000000 0.001024 0.000991 0.006813 +17227 1 0.000193 1560.000000 0.001429 0.003409 0.000463 +17228 1 0.000243 1560.000000 -0.000202 0.001994 0.003640 +17229 1 0.000274 1560.000000 -0.000383 -0.003664 0.000151 +17230 1 0.000233 1560.000000 -0.003027 0.001919 0.006714 +17231 1 0.000205 1560.000000 -0.000509 -0.002869 0.007655 +17232 1 0.000213 1560.000000 0.000238 0.003307 0.000331 +17233 1 0.000237 1560.000000 -0.001967 0.003046 0.008541 +17234 1 0.000275 1560.000000 -0.003711 0.000837 0.001614 +17235 1 0.000222 1560.000000 0.000035 -0.002828 0.001785 +17236 1 0.000208 1560.000000 -0.001930 -0.002726 0.005471 +17237 1 0.000205 1560.000000 0.002831 0.002014 0.000201 +17238 1 0.000218 1560.000000 -0.000895 -0.000400 0.008620 +17239 1 0.000209 1560.000000 -0.000458 -0.003802 0.009423 +17240 1 0.000249 1560.000000 0.001210 -0.001045 0.007164 +17241 1 0.000270 1560.000000 0.003650 0.000984 0.007391 +17242 1 0.000215 1560.000000 -0.003246 -0.001917 0.005500 +17243 1 0.000238 1560.000000 -0.000709 0.002473 0.000833 +17244 1 0.000216 1560.000000 0.002938 0.000833 0.007416 +17245 1 0.000204 1560.000000 0.000999 -0.003074 0.005792 +17246 1 0.000285 1560.000000 -0.002989 -0.001243 0.003472 +17247 1 0.000251 1560.000000 -0.002082 -0.002871 0.002912 +17248 1 0.000195 1560.000000 -0.002046 0.000926 0.002274 +17249 1 0.000250 1560.000000 -0.002960 0.000196 0.004709 +17250 1 0.000215 1560.000000 -0.001055 0.002909 0.005561 +17251 1 0.000281 1560.000000 -0.002403 0.001327 0.003871 +17252 1 0.000210 1560.000000 0.002430 0.002508 0.005755 +17253 1 0.000219 1560.000000 0.003150 -0.000520 0.009626 +17254 1 0.000257 1560.000000 -0.003272 -0.001079 0.007510 +17255 1 0.000230 1560.000000 0.000333 0.000185 0.004356 +17256 1 0.000196 1560.000000 0.000775 0.003208 0.006760 +17257 1 0.000207 1560.000000 0.002683 0.002366 0.005909 +17258 1 0.000202 1560.000000 0.001452 -0.001896 0.005073 +17259 1 0.000210 1560.000000 -0.001565 -0.001641 0.006121 +17260 1 0.000268 1560.000000 0.003781 0.000139 0.000699 +17261 1 0.000206 1560.000000 -0.000796 0.000582 0.007243 +17262 1 0.000255 1560.000000 -0.000658 -0.001163 0.005949 +17263 1 0.000280 1560.000000 -0.002928 0.001168 0.008759 +17264 1 0.000222 1560.000000 -0.002339 -0.002664 0.000586 +17265 1 0.000230 1560.000000 0.000232 0.003281 0.002419 +17266 1 0.000272 1560.000000 -0.001667 0.000741 0.002008 +17267 1 0.000248 1560.000000 -0.001362 -0.002094 0.004793 +17268 1 0.000192 1560.000000 -0.000168 -0.003474 0.007035 +17269 1 0.000219 1560.000000 -0.000546 0.001263 0.000839 +17270 1 0.000281 1560.000000 0.001184 -0.003663 0.003377 +17271 1 0.000272 1560.000000 0.003205 -0.002084 0.003814 +17272 1 0.000195 1560.000000 0.000062 0.003039 0.003456 +17273 1 0.000268 1560.000000 0.000098 0.001167 0.001084 +17274 1 0.000199 1560.000000 0.002470 0.002818 0.002324 +17275 1 0.000207 1560.000000 0.001781 0.000805 0.003566 +17276 1 0.000203 1560.000000 0.000848 0.001232 0.000988 +17277 1 0.000221 1560.000000 0.003177 -0.001896 0.006893 +17278 1 0.000208 1560.000000 -0.001189 -0.001454 0.001919 +17279 1 0.000237 1560.000000 -0.000165 -0.002431 0.003806 +17280 1 0.000197 1560.000000 0.003218 -0.000845 0.008445 +17281 1 0.000201 1560.000000 -0.002503 0.002436 0.008240 +17282 1 0.000258 1560.000000 0.000659 -0.003789 0.004622 +17283 1 0.000232 1560.000000 -0.001387 0.002672 0.008753 +17284 1 0.000242 1560.000000 0.000603 -0.001260 0.000702 +17285 1 0.000208 1560.000000 -0.000079 0.000403 0.006979 +17286 1 0.000272 1560.000000 0.000194 -0.002703 0.002733 +17287 1 0.000209 1560.000000 -0.001230 -0.003614 0.001973 +17288 1 0.000262 1560.000000 0.001355 -0.001553 0.006049 +17289 1 0.000232 1560.000000 0.002627 -0.002290 0.001033 +17290 1 0.000284 1560.000000 -0.001016 -0.003692 0.006081 +17291 1 0.000231 1560.000000 0.002286 -0.002556 0.007937 +17292 1 0.000262 1560.000000 -0.003376 -0.000024 0.003147 +17293 1 0.000214 1560.000000 -0.002156 0.003168 0.002744 +17294 1 0.000222 1560.000000 0.001090 -0.000815 0.009021 +17295 1 0.000226 1560.000000 0.001947 -0.003007 0.006003 +17296 1 0.000219 1560.000000 0.003448 0.001284 0.007350 +17297 1 0.000197 1560.000000 0.002550 0.002833 0.004149 +17298 1 0.000228 1560.000000 0.003222 -0.001003 0.006273 +17299 1 0.000223 1560.000000 -0.001493 -0.000439 0.004404 +17300 1 0.000198 1560.000000 -0.000338 -0.001999 0.005626 +17301 1 0.000222 1560.000000 0.002994 -0.000700 0.001153 +17302 1 0.000249 1560.000000 -0.002612 0.001577 0.007294 +17303 1 0.000216 1560.000000 -0.000736 0.001814 0.001859 +17304 1 0.000222 1560.000000 0.000346 0.003118 0.003090 +17305 1 0.000228 1560.000000 0.001221 0.002558 0.002556 +17306 1 0.000219 1560.000000 0.002985 -0.000966 0.005742 +17307 1 0.000206 1560.000000 0.001011 -0.001816 0.004494 +17308 1 0.000228 1560.000000 0.001263 -0.002853 0.009195 +17309 1 0.000238 1560.000000 0.001063 0.000974 0.002221 +17310 1 0.000285 1560.000000 0.001005 -0.003027 0.005053 +17311 1 0.000221 1560.000000 -0.001826 0.001838 0.004460 +17312 1 0.000211 1560.000000 -0.000699 0.002236 0.002656 +17313 1 0.000240 1560.000000 -0.003361 -0.001476 0.000846 +17314 1 0.000246 1560.000000 -0.000123 -0.000851 0.005965 +17315 1 0.000285 1560.000000 0.002521 0.000612 0.002682 +17316 1 0.000201 1560.000000 0.001101 0.003086 0.005999 +17317 1 0.000195 1560.000000 0.001248 0.002694 0.007446 +17318 1 0.000222 1560.000000 0.001392 -0.000878 0.007420 +17319 1 0.000225 1560.000000 -0.003001 0.000026 0.000925 +17320 1 0.000272 1560.000000 0.002885 0.002390 0.007117 +17321 1 0.000202 1560.000000 -0.000901 0.003210 0.008053 +17322 1 0.000192 1560.000000 0.001809 0.001590 0.005857 +17323 1 0.000200 1560.000000 -0.001982 0.000094 0.004026 +17324 1 0.000205 1560.000000 0.001483 -0.002125 0.008941 +17325 1 0.000207 1560.000000 -0.000672 -0.001690 0.006223 +17326 1 0.000261 1560.000000 0.002386 -0.000892 0.008450 +17327 1 0.000230 1560.000000 -0.002082 0.002138 0.003344 +17328 1 0.000227 1560.000000 0.000903 -0.000940 0.003921 +17329 1 0.000224 1560.000000 -0.002868 -0.002460 0.009525 +17330 1 0.000210 1560.000000 -0.001700 0.001321 0.002594 +17331 1 0.000270 1560.000000 0.002588 0.000765 0.007543 +17332 1 0.000204 1560.000000 0.000043 -0.002098 0.008383 +17333 1 0.000227 1560.000000 0.000183 -0.000403 0.004066 +17334 1 0.000197 1560.000000 -0.001627 -0.000784 0.000195 +17335 1 0.000226 1560.000000 0.003806 0.000137 0.001965 +17336 1 0.000193 1560.000000 -0.003165 0.001425 0.003716 +17337 1 0.000225 1560.000000 0.000041 -0.001110 0.007668 +17338 1 0.000211 1560.000000 0.001496 -0.002617 0.008710 +17339 1 0.000225 1560.000000 0.003205 -0.000137 0.006320 +17340 1 0.000278 1560.000000 -0.001779 -0.002961 0.003934 +17341 1 0.000196 1560.000000 0.001753 0.001231 0.001294 +17342 1 0.000203 1560.000000 -0.001739 0.001022 0.005623 +17343 1 0.000253 1560.000000 -0.002276 -0.002252 0.004226 +17344 1 0.000230 1560.000000 -0.001492 -0.000258 0.005685 +17345 1 0.000244 1560.000000 0.003472 0.000416 0.000477 +17346 1 0.000219 1560.000000 0.001972 0.002926 0.003079 +17347 1 0.000208 1560.000000 0.000148 0.002105 0.009311 +17348 1 0.000225 1560.000000 0.002888 0.000617 0.005240 +17349 1 0.000246 1560.000000 0.003344 -0.000437 0.004169 +17350 1 0.000240 1560.000000 -0.000152 -0.000231 0.008454 +17351 1 0.000209 1560.000000 -0.000164 0.003138 0.005020 +17352 1 0.000279 1560.000000 -0.003550 -0.001479 0.007109 +17353 1 0.000206 1560.000000 0.001879 0.000241 0.002968 +17354 1 0.000239 1560.000000 -0.002499 0.001731 0.006561 +17355 1 0.000194 1560.000000 -0.001883 0.001663 0.001966 +17356 1 0.000206 1560.000000 -0.001444 0.000341 0.004112 +17357 1 0.000206 1560.000000 -0.000438 -0.002226 0.003328 +17358 1 0.000195 1560.000000 0.003677 0.000496 0.009695 +17359 1 0.000200 1560.000000 -0.000615 0.003122 0.008247 +17360 1 0.000234 1560.000000 0.003069 -0.002284 0.001779 +17361 1 0.000198 1560.000000 0.001380 0.002181 0.001340 +17362 1 0.000203 1560.000000 -0.003204 0.001779 0.004703 +17363 1 0.000261 1560.000000 -0.002312 -0.001717 0.003609 +17364 1 0.000214 1560.000000 -0.002693 0.000360 0.002305 +17365 1 0.000219 1560.000000 -0.000456 0.002798 0.001919 +17366 1 0.000193 1560.000000 -0.001281 -0.001430 0.005281 +17367 1 0.000228 1560.000000 -0.000720 -0.003715 0.004801 +17368 1 0.000221 1560.000000 -0.000028 -0.002911 0.001389 +17369 1 0.000268 1560.000000 -0.000336 0.003592 0.005784 +17370 1 0.000253 1560.000000 0.000827 -0.002013 0.005686 +17371 1 0.000222 1560.000000 0.001106 0.002501 0.001578 +17372 1 0.000279 1560.000000 -0.000153 0.002312 0.009819 +17373 1 0.000211 1560.000000 0.001668 0.000955 0.002146 +17374 1 0.000204 1560.000000 -0.001452 0.002351 0.000544 +17375 1 0.000194 1560.000000 0.002202 -0.000197 0.007243 +17376 1 0.000209 1560.000000 -0.003041 -0.002329 0.006291 +17377 1 0.000245 1560.000000 -0.001189 0.000835 0.004077 +17378 1 0.000260 1560.000000 0.001592 0.000644 0.001984 +17379 1 0.000213 1560.000000 -0.000939 0.002540 0.001762 +17380 1 0.000226 1560.000000 -0.002682 -0.001057 0.004623 +17381 1 0.000208 1560.000000 -0.000374 0.003609 0.003938 +17382 1 0.000197 1560.000000 -0.001686 -0.001455 0.005689 +17383 1 0.000261 1560.000000 -0.002076 0.001732 0.007372 +17384 1 0.000276 1560.000000 -0.003499 0.001482 0.000864 +17385 1 0.000201 1560.000000 0.002985 -0.001316 0.006009 +17386 1 0.000261 1560.000000 -0.003235 0.000072 0.006314 +17387 1 0.000232 1560.000000 0.002044 0.001284 0.004249 +17388 1 0.000205 1560.000000 -0.000323 0.003391 0.009632 +17389 1 0.000200 1560.000000 -0.001994 0.002042 0.002319 +17390 1 0.000243 1560.000000 0.002978 -0.001034 0.003817 +17391 1 0.000212 1560.000000 -0.000934 -0.001138 0.007036 +17392 1 0.000257 1560.000000 0.000447 0.003354 0.001037 +17393 1 0.000207 1560.000000 -0.002422 -0.000423 0.001260 +17394 1 0.000204 1560.000000 0.002857 -0.001247 0.001502 +17395 1 0.000216 1560.000000 -0.000202 0.000179 0.007604 +17396 1 0.000266 1560.000000 -0.003796 0.000636 0.001829 +17397 1 0.000199 1560.000000 0.000569 0.002701 0.008359 +17398 1 0.000216 1560.000000 0.002907 0.000715 0.006039 +17399 1 0.000265 1560.000000 0.001900 -0.003169 0.002436 +17400 1 0.000281 1560.000000 0.000203 0.002843 0.007386 +17401 1 0.000222 1560.000000 -0.003281 -0.000792 0.008830 +17402 1 0.000236 1560.000000 0.000560 0.001203 0.001094 +17403 1 0.000261 1560.000000 0.003385 0.000862 0.006766 +17404 1 0.000204 1560.000000 0.001439 0.002223 0.008170 +17405 1 0.000227 1560.000000 -0.001441 -0.003328 0.009457 +17406 1 0.000258 1560.000000 -0.002981 0.001474 0.003156 +17407 1 0.000288 1560.000000 -0.002379 -0.002774 0.000292 +17408 1 0.000241 1560.000000 0.002916 0.000083 0.000126 +17409 1 0.000242 1560.000000 0.000588 0.001543 0.003905 +17410 1 0.000195 1560.000000 -0.001315 -0.002883 0.000553 +17411 1 0.000230 1560.000000 -0.001781 -0.002758 0.008736 +17412 1 0.000226 1560.000000 -0.002747 0.000904 0.006557 +17413 1 0.000229 1560.000000 0.000034 -0.002096 0.002799 +17414 1 0.000194 1560.000000 0.001450 -0.000226 0.009052 +17415 1 0.000216 1560.000000 0.000925 -0.001110 0.009417 +17416 1 0.000194 1560.000000 0.000554 0.002308 0.002948 +17417 1 0.000200 1560.000000 0.003290 -0.001367 0.002468 +17418 1 0.000234 1560.000000 -0.002410 -0.001162 0.008841 +17419 1 0.000236 1560.000000 0.001992 0.000472 0.007520 +17420 1 0.000286 1560.000000 0.002179 -0.002800 0.007502 +17421 1 0.000215 1560.000000 -0.000096 0.002929 0.000986 +17422 1 0.000278 1560.000000 0.000122 0.003052 0.004712 +17423 1 0.000219 1560.000000 0.000195 0.003581 0.004476 +17424 1 0.000242 1560.000000 0.001971 -0.001191 0.002191 +17425 1 0.000216 1560.000000 -0.000644 0.000805 0.001141 +17426 1 0.000253 1560.000000 -0.002419 -0.001417 0.001213 +17427 1 0.000268 1560.000000 -0.001071 0.001200 0.009654 +17428 1 0.000252 1560.000000 0.002265 0.002087 0.003732 +17429 1 0.000259 1560.000000 -0.001043 0.002785 0.002359 +17430 1 0.000204 1560.000000 -0.000236 -0.002592 0.006415 +17431 1 0.000260 1560.000000 0.001729 -0.002073 0.006367 +17432 1 0.000205 1560.000000 0.002809 0.000455 0.001002 +17433 1 0.000196 1560.000000 -0.000025 0.000162 0.004961 +17434 1 0.000288 1560.000000 -0.002544 0.002897 0.002181 +17435 1 0.000234 1560.000000 -0.001007 -0.002979 0.004162 +17436 1 0.000221 1560.000000 0.000018 -0.002568 0.006090 +17437 1 0.000288 1560.000000 -0.001646 0.002391 0.007095 +17438 1 0.000229 1560.000000 0.001487 0.003478 0.000942 +17439 1 0.000207 1560.000000 0.002455 -0.001719 0.003670 +17440 1 0.000201 1560.000000 -0.003450 0.000830 0.008934 +17441 1 0.000229 1560.000000 -0.001388 0.001514 0.008817 +17442 1 0.000206 1560.000000 0.002690 -0.001334 0.004005 +17443 1 0.000241 1560.000000 0.001855 0.002173 0.009650 +17444 1 0.000283 1560.000000 0.002051 -0.003199 0.004562 +17445 1 0.000208 1560.000000 0.002728 0.000594 0.005601 +17446 1 0.000227 1560.000000 -0.000298 0.000302 0.001227 +17447 1 0.000212 1560.000000 -0.000657 -0.000653 0.007608 +17448 1 0.000261 1560.000000 -0.001049 -0.003487 0.007776 +17449 1 0.000207 1560.000000 -0.002097 0.002865 0.009128 +17450 1 0.000196 1560.000000 -0.001561 -0.003488 0.008795 +17451 1 0.000201 1560.000000 -0.000100 0.000348 0.008730 +17452 1 0.000235 1560.000000 0.003153 0.000826 0.006058 +17453 1 0.000232 1560.000000 -0.000818 -0.000854 0.000314 +17454 1 0.000283 1560.000000 0.003325 0.000356 0.009089 +17455 1 0.000203 1560.000000 -0.001704 0.002474 0.009139 +17456 1 0.000276 1560.000000 0.000500 0.000816 0.006781 +17457 1 0.000229 1560.000000 -0.000613 -0.003164 0.000928 +17458 1 0.000200 1560.000000 0.001705 -0.000110 0.001602 +17459 1 0.000257 1560.000000 -0.002068 -0.000662 0.001744 +17460 1 0.000274 1560.000000 -0.001422 0.000263 0.009558 +17461 1 0.000283 1560.000000 -0.002155 -0.003086 0.008782 +17462 1 0.000227 1560.000000 0.001818 0.002718 0.005988 +17463 1 0.000223 1560.000000 -0.002855 -0.002194 0.006330 +17464 1 0.000222 1560.000000 0.001816 -0.000292 0.006778 +17465 1 0.000247 1560.000000 0.001361 -0.000667 0.004966 +17466 1 0.000234 1560.000000 0.001075 -0.002100 0.004605 +17467 1 0.000219 1560.000000 0.002177 0.000907 0.009525 +17468 1 0.000265 1560.000000 0.000167 0.001868 0.002642 +17469 1 0.000196 1560.000000 0.001849 0.002968 0.001268 +17470 1 0.000202 1560.000000 0.000846 -0.002774 0.005845 +17471 1 0.000282 1560.000000 -0.001751 0.002619 0.009839 +17472 1 0.000231 1560.000000 -0.002180 -0.002287 0.002668 +17473 1 0.000217 1560.000000 0.003206 -0.001615 0.002056 +17474 1 0.000262 1560.000000 -0.000283 -0.001749 0.009397 +17475 1 0.000284 1560.000000 -0.001013 0.003257 0.004431 +17476 1 0.000233 1560.000000 -0.000686 -0.002515 0.007237 +17477 1 0.000282 1560.000000 -0.001224 0.003656 0.006481 +17478 1 0.000281 1560.000000 0.002532 -0.000810 0.007816 +17479 1 0.000275 1560.000000 -0.002802 0.002589 0.007472 +17480 1 0.000227 1560.000000 0.001053 -0.000052 0.001188 +17481 1 0.000212 1560.000000 0.000418 -0.001114 0.003366 +17482 1 0.000217 1560.000000 -0.001683 0.002805 0.007600 +17483 1 0.000212 1560.000000 -0.002184 -0.001557 0.003761 +17484 1 0.000210 1560.000000 0.001918 0.000425 0.001891 +17485 1 0.000205 1560.000000 0.001001 -0.002205 0.006698 +17486 1 0.000221 1560.000000 0.003129 -0.000193 0.008639 +17487 1 0.000285 1560.000000 -0.001708 0.002204 0.003910 +17488 1 0.000203 1560.000000 0.002983 -0.000394 0.002925 +17489 1 0.000283 1560.000000 -0.002388 -0.001019 0.007909 +17490 1 0.000213 1560.000000 0.000806 0.001503 0.008812 +17491 1 0.000242 1560.000000 0.003501 0.001385 0.009804 +17492 1 0.000250 1560.000000 0.000095 -0.001657 0.000910 +17493 1 0.000245 1560.000000 -0.000865 0.000668 0.007465 +17494 1 0.000211 1560.000000 -0.001667 0.000160 0.005635 +17495 1 0.000242 1560.000000 0.001784 0.002416 0.002255 +17496 1 0.000206 1560.000000 0.002604 0.000161 0.000152 +17497 1 0.000193 1560.000000 0.000786 0.001441 0.004684 +17498 1 0.000229 1560.000000 -0.003237 -0.000358 0.009129 +17499 1 0.000276 1560.000000 0.001956 0.003243 0.002063 +17500 1 0.000199 1560.000000 0.001224 -0.003369 0.007317 +17501 1 0.000277 1560.000000 -0.003567 -0.000264 0.005997 +17502 1 0.000196 1560.000000 0.000993 0.002193 0.002630 +17503 1 0.000278 1560.000000 -0.002955 -0.001133 0.005823 +17504 1 0.000216 1560.000000 0.002577 0.002866 0.008700 +17505 1 0.000244 1560.000000 -0.000129 0.003146 0.007230 +17506 1 0.000200 1560.000000 -0.000320 -0.000199 0.001844 +17507 1 0.000205 1560.000000 -0.000284 -0.002088 0.008356 +17508 1 0.000214 1560.000000 -0.000625 0.003627 0.008842 +17509 1 0.000270 1560.000000 -0.001889 0.002068 0.003487 +17510 1 0.000212 1560.000000 0.000792 0.000962 0.002857 +17511 1 0.000285 1560.000000 0.000128 -0.003294 0.002378 +17512 1 0.000213 1560.000000 -0.003371 0.001856 0.001177 +17513 1 0.000269 1560.000000 -0.002267 0.002065 0.008534 +17514 1 0.000206 1560.000000 -0.001425 0.002742 0.002161 +17515 1 0.000268 1560.000000 -0.001982 -0.003254 0.001700 +17516 1 0.000214 1560.000000 0.000565 0.003161 0.003879 +17517 1 0.000204 1560.000000 0.000423 -0.002137 0.001399 +17518 1 0.000222 1560.000000 0.001826 0.000180 0.006934 +17519 1 0.000211 1560.000000 0.001364 0.002854 0.005585 +17520 1 0.000212 1560.000000 -0.001043 -0.000604 0.003230 +17521 1 0.000195 1560.000000 0.000558 0.001256 0.007851 +17522 1 0.000204 1560.000000 0.000903 0.003055 0.001723 +17523 1 0.000237 1560.000000 0.001357 0.000174 0.004970 +17524 1 0.000203 1560.000000 -0.002254 -0.002148 0.002514 +17525 1 0.000194 1560.000000 0.000229 0.000506 0.002578 +17526 1 0.000223 1560.000000 -0.000625 0.003802 0.007560 +17527 1 0.000254 1560.000000 0.002755 -0.000806 0.006613 +17528 1 0.000279 1560.000000 -0.000829 0.001684 0.001403 +17529 1 0.000251 1560.000000 0.003750 -0.000019 0.009184 +17530 1 0.000219 1560.000000 -0.000776 0.003103 0.006396 +17531 1 0.000203 1560.000000 -0.002752 -0.001698 0.001029 +17532 1 0.000201 1560.000000 -0.003344 -0.000905 0.007687 +17533 1 0.000271 1560.000000 0.001196 0.003001 0.008507 +17534 1 0.000276 1560.000000 -0.001409 -0.000840 0.002628 +17535 1 0.000203 1560.000000 0.000917 -0.000323 0.002898 +17536 1 0.000232 1560.000000 0.001978 -0.001848 0.007087 +17537 1 0.000281 1560.000000 -0.003847 0.000217 0.002222 +17538 1 0.000247 1560.000000 -0.000248 0.001183 0.007144 +17539 1 0.000249 1560.000000 -0.000801 -0.002118 0.009508 +17540 1 0.000268 1560.000000 -0.002526 -0.001832 0.000996 +17541 1 0.000261 1560.000000 0.001936 -0.000214 0.001031 +17542 1 0.000218 1560.000000 0.000898 0.003487 0.003087 +17543 1 0.000225 1560.000000 0.001647 -0.002923 0.003819 +17544 1 0.000241 1560.000000 -0.002831 0.000065 0.003690 +17545 1 0.000202 1560.000000 -0.000570 -0.000097 0.005002 +17546 1 0.000272 1560.000000 0.003850 0.000110 0.006735 +17547 1 0.000205 1560.000000 -0.002990 -0.000066 0.002806 +17548 1 0.000238 1560.000000 -0.000311 0.003128 0.001840 +17549 1 0.000253 1560.000000 -0.000995 0.002134 0.009399 +17550 1 0.000208 1560.000000 -0.000272 -0.002426 0.006974 +17551 1 0.000247 1560.000000 -0.001086 -0.003690 0.003479 +17552 1 0.000204 1560.000000 0.002802 0.000450 0.001623 +17553 1 0.000217 1560.000000 -0.000646 -0.000325 0.001081 +17554 1 0.000256 1560.000000 -0.003032 -0.001702 0.002986 +17555 1 0.000285 1560.000000 0.003628 0.001228 0.005042 +17556 1 0.000238 1560.000000 0.000310 0.003158 0.003343 +17557 1 0.000254 1560.000000 -0.000029 -0.002114 0.002328 +17558 1 0.000212 1560.000000 0.001646 -0.001224 0.001282 +17559 1 0.000240 1560.000000 -0.002886 0.000197 0.005249 +17560 1 0.000287 1560.000000 -0.001565 -0.000721 0.009821 +17561 1 0.000192 1560.000000 -0.001438 -0.001943 0.001134 +17562 1 0.000272 1560.000000 -0.001274 -0.003238 0.002629 +17563 1 0.000288 1560.000000 0.002240 0.002796 0.002542 +17564 1 0.000218 1560.000000 0.002034 0.000589 0.008850 +17565 1 0.000241 1560.000000 0.001495 -0.002545 0.009000 +17566 1 0.000206 1560.000000 0.000167 0.002646 0.005042 +17567 1 0.000205 1560.000000 0.000116 0.003324 0.009227 +17568 1 0.000210 1560.000000 0.002328 -0.000812 0.001245 +17569 1 0.000197 1560.000000 0.001369 -0.002858 0.002724 +17570 1 0.000214 1560.000000 0.001772 -0.000423 0.003213 +17571 1 0.000280 1560.000000 0.002953 0.001856 0.004174 +17572 1 0.000193 1560.000000 -0.002748 0.000297 0.004759 +17573 1 0.000237 1560.000000 -0.003386 -0.001759 0.002748 +17574 1 0.000204 1560.000000 0.000014 -0.002878 0.001045 +17575 1 0.000198 1560.000000 0.000022 -0.002845 0.007023 +17576 1 0.000194 1560.000000 -0.002098 -0.000880 0.004872 +17577 1 0.000227 1560.000000 0.000085 -0.002898 0.007811 +17578 1 0.000278 1560.000000 -0.001672 0.000770 0.009308 +17579 1 0.000250 1560.000000 0.000978 -0.003534 0.006913 +17580 1 0.000229 1560.000000 0.001805 0.001391 0.004257 +17581 1 0.000213 1560.000000 -0.003047 0.002339 0.000527 +17582 1 0.000221 1560.000000 0.002990 -0.001537 0.001816 +17583 1 0.000196 1560.000000 -0.001238 -0.000482 0.001537 +17584 1 0.000229 1560.000000 -0.002509 -0.000202 0.001231 +17585 1 0.000200 1560.000000 -0.001052 -0.002425 0.009800 +17586 1 0.000230 1560.000000 0.002542 -0.002878 0.009805 +17587 1 0.000197 1560.000000 -0.001701 0.002338 0.000730 +17588 1 0.000208 1560.000000 0.000531 -0.003745 0.002179 +17589 1 0.000218 1560.000000 -0.000007 0.003566 0.005568 +17590 1 0.000236 1560.000000 0.001669 -0.000110 0.002153 +17591 1 0.000251 1560.000000 -0.002520 -0.000632 0.006744 +17592 1 0.000245 1560.000000 -0.003105 -0.001457 0.002405 +17593 1 0.000204 1560.000000 -0.002586 0.000150 0.005811 +17594 1 0.000283 1560.000000 -0.001817 -0.002544 0.006331 +17595 1 0.000263 1560.000000 0.002258 -0.000537 0.006938 +17596 1 0.000251 1560.000000 -0.001777 0.002352 0.008102 +17597 1 0.000202 1560.000000 0.000172 -0.001738 0.003839 +17598 1 0.000195 1560.000000 0.003107 0.001611 0.007685 +17599 1 0.000205 1560.000000 -0.000488 0.003376 0.001797 +17600 1 0.000217 1560.000000 -0.003177 -0.000406 0.001587 +17601 1 0.000195 1560.000000 0.001987 0.002848 0.002106 +17602 1 0.000197 1560.000000 -0.003199 -0.001634 0.004165 +17603 1 0.000199 1560.000000 -0.002200 0.002460 0.005901 +17604 1 0.000213 1560.000000 0.000815 0.002160 0.002808 +17605 1 0.000238 1560.000000 -0.003543 0.000580 0.005422 +17606 1 0.000256 1560.000000 0.002902 0.001767 0.009630 +17607 1 0.000212 1560.000000 0.001290 0.000051 0.008362 +17608 1 0.000277 1560.000000 0.003374 -0.001028 0.007836 +17609 1 0.000194 1560.000000 -0.003375 0.000820 0.006957 +17610 1 0.000206 1560.000000 -0.001226 -0.001072 0.000657 +17611 1 0.000220 1560.000000 -0.000521 0.003552 0.000569 +17612 1 0.000237 1560.000000 -0.002858 -0.001694 0.002525 +17613 1 0.000220 1560.000000 -0.002866 0.001902 0.000552 +17614 1 0.000209 1560.000000 -0.003193 -0.001417 0.001951 +17615 1 0.000281 1560.000000 -0.000783 -0.003431 0.009017 +17616 1 0.000275 1560.000000 0.003500 0.000826 0.000886 +17617 1 0.000234 1560.000000 0.001734 0.002784 0.007420 +17618 1 0.000213 1560.000000 -0.002763 -0.001967 0.002190 +17619 1 0.000214 1560.000000 0.002109 -0.002522 0.008607 +17620 1 0.000201 1560.000000 -0.003613 0.000876 0.001206 +17621 1 0.000197 1560.000000 -0.000539 -0.001087 0.001958 +17622 1 0.000194 1560.000000 0.003356 0.000012 0.009590 +17623 1 0.000214 1560.000000 -0.000470 -0.002492 0.002868 +17624 1 0.000214 1560.000000 -0.001744 0.002049 0.008527 +17625 1 0.000195 1560.000000 -0.003124 0.000607 0.005030 +17626 1 0.000227 1560.000000 -0.002500 -0.000723 0.005290 +17627 1 0.000217 1560.000000 -0.001418 0.003061 0.005314 +17628 1 0.000214 1560.000000 0.001389 0.000248 0.002986 +17629 1 0.000245 1560.000000 -0.002607 0.001583 0.009616 +17630 1 0.000271 1560.000000 -0.002492 -0.000167 0.002848 +17631 1 0.000205 1560.000000 -0.002380 0.001302 0.003220 +17632 1 0.000206 1560.000000 -0.002177 -0.001754 0.006084 +17633 1 0.000240 1560.000000 -0.000654 -0.002676 0.000138 +17634 1 0.000218 1560.000000 0.001564 0.000863 0.004512 +17635 1 0.000272 1560.000000 -0.003272 0.000461 0.003022 +17636 1 0.000273 1560.000000 0.001893 -0.002960 0.007709 +17637 1 0.000281 1560.000000 -0.001876 0.000045 0.001709 +17638 1 0.000233 1560.000000 0.002307 0.000290 0.004176 +17639 1 0.000213 1560.000000 0.001333 -0.001880 0.000676 +17640 1 0.000239 1560.000000 -0.001379 -0.000580 0.007266 +17641 1 0.000209 1560.000000 0.002529 0.002796 0.008374 +17642 1 0.000276 1560.000000 -0.003166 0.001134 0.002747 +17643 1 0.000245 1560.000000 -0.000591 -0.002496 0.006166 +17644 1 0.000200 1560.000000 0.001334 -0.002770 0.006593 +17645 1 0.000249 1560.000000 -0.000060 -0.003275 0.005744 +17646 1 0.000286 1560.000000 -0.002347 0.001855 0.000746 +17647 1 0.000252 1560.000000 0.000418 -0.001524 0.005403 +17648 1 0.000238 1560.000000 -0.001423 -0.003248 0.003292 +17649 1 0.000207 1560.000000 0.001213 -0.001192 0.005834 +17650 1 0.000209 1560.000000 0.003404 -0.001151 0.000337 +17651 1 0.000278 1560.000000 0.003796 -0.000273 0.000828 +17652 1 0.000237 1560.000000 0.003108 -0.001255 0.007897 +17653 1 0.000278 1560.000000 -0.003778 -0.000367 0.003963 +17654 1 0.000223 1560.000000 -0.002246 -0.002162 0.006482 +17655 1 0.000216 1560.000000 -0.001214 -0.003152 0.005320 +17656 1 0.000240 1560.000000 0.003282 -0.001268 0.002725 +17657 1 0.000264 1560.000000 -0.001490 0.003117 0.004769 +17658 1 0.000273 1560.000000 0.001109 -0.001974 0.001064 +17659 1 0.000252 1560.000000 0.003094 0.001695 0.001590 +17660 1 0.000262 1560.000000 -0.003079 -0.000316 0.007726 +17661 1 0.000234 1560.000000 -0.002763 0.001201 0.006258 +17662 1 0.000259 1560.000000 -0.001247 -0.002966 0.006276 +17663 1 0.000247 1560.000000 0.003248 0.000164 0.001084 +17664 1 0.000255 1560.000000 0.001470 -0.002164 0.002504 +17665 1 0.000258 1560.000000 -0.003129 0.001281 0.001399 +17666 1 0.000263 1560.000000 0.001884 0.002167 0.003056 +17667 1 0.000208 1560.000000 -0.000619 -0.003441 0.006466 +17668 1 0.000268 1560.000000 -0.003128 0.000230 0.008935 +17669 1 0.000231 1560.000000 -0.000544 0.001829 0.004443 +17670 1 0.000274 1560.000000 -0.002096 -0.000549 0.004534 +17671 1 0.000257 1560.000000 0.001238 -0.002122 0.003029 +17672 1 0.000207 1560.000000 0.000926 0.001406 0.009811 +17673 1 0.000195 1560.000000 0.002395 0.002931 0.004512 +17674 1 0.000242 1560.000000 -0.000561 0.002774 0.000466 +17675 1 0.000193 1560.000000 0.002417 -0.000546 0.009661 +17676 1 0.000256 1560.000000 -0.003688 -0.000368 0.008261 +17677 1 0.000248 1560.000000 -0.003477 -0.001191 0.000259 +17678 1 0.000213 1560.000000 0.002059 -0.001852 0.002183 +17679 1 0.000272 1560.000000 -0.003075 0.002306 0.001734 +17680 1 0.000197 1560.000000 -0.001384 0.003537 0.000786 +17681 1 0.000267 1560.000000 0.002177 0.002955 0.002939 +17682 1 0.000271 1560.000000 -0.001929 -0.003324 0.003844 +17683 1 0.000269 1560.000000 0.003132 0.001519 0.000841 +17684 1 0.000257 1560.000000 -0.000930 -0.000863 0.007888 +17685 1 0.000225 1560.000000 -0.003235 -0.000051 0.003442 +17686 1 0.000261 1560.000000 0.002935 0.000337 0.000140 +17687 1 0.000197 1560.000000 -0.001877 0.000542 0.009714 +17688 1 0.000279 1560.000000 -0.002001 0.003115 0.005537 +17689 1 0.000228 1560.000000 0.001622 -0.000323 0.004338 +17690 1 0.000222 1560.000000 -0.002010 0.002512 0.005279 +17691 1 0.000232 1560.000000 -0.001983 0.000238 0.006789 +17692 1 0.000194 1560.000000 0.001595 0.002741 0.000486 +17693 1 0.000192 1560.000000 0.000245 -0.000909 0.004005 +17694 1 0.000250 1560.000000 0.001824 0.003324 0.007209 +17695 1 0.000231 1560.000000 -0.002539 -0.002514 0.002071 +17696 1 0.000285 1560.000000 -0.000750 0.002280 0.002317 +17697 1 0.000277 1560.000000 0.002865 -0.001070 0.006459 +17698 1 0.000211 1560.000000 0.002104 0.000222 0.008088 +17699 1 0.000230 1560.000000 -0.000176 0.002299 0.003932 +17700 1 0.000228 1560.000000 -0.000365 0.000504 0.002642 +17701 1 0.000241 1560.000000 0.000392 -0.002056 0.005108 +17702 1 0.000270 1560.000000 -0.002254 0.000075 0.001467 +17703 1 0.000250 1560.000000 0.001526 -0.002261 0.007359 +17704 1 0.000283 1560.000000 -0.000342 0.002711 0.004970 +17705 1 0.000201 1560.000000 0.000091 -0.000081 0.008115 +17706 1 0.000193 1560.000000 0.002801 -0.000065 0.008002 +17707 1 0.000220 1560.000000 0.002437 -0.000418 0.006421 +17708 1 0.000220 1560.000000 0.002724 0.001120 0.007211 +17709 1 0.000197 1560.000000 0.000433 -0.002605 0.001686 +17710 1 0.000237 1560.000000 -0.003520 0.000129 0.003685 +17711 1 0.000233 1560.000000 0.001723 0.003143 0.001343 +17712 1 0.000212 1560.000000 -0.001718 0.001208 0.004059 +17713 1 0.000232 1560.000000 0.002783 0.002147 0.003743 +17714 1 0.000202 1560.000000 -0.001296 -0.000067 0.001306 +17715 1 0.000222 1560.000000 0.001119 -0.002847 0.001966 +17716 1 0.000208 1560.000000 0.002753 0.000628 0.006967 +17717 1 0.000199 1560.000000 -0.003580 -0.000017 0.009338 +17718 1 0.000219 1560.000000 0.000270 0.002832 0.006772 +17719 1 0.000221 1560.000000 0.002744 0.001007 0.009494 +17720 1 0.000286 1560.000000 0.001497 -0.001556 0.009775 +17721 1 0.000266 1560.000000 -0.003256 -0.001269 0.006314 +17722 1 0.000217 1560.000000 -0.002256 -0.000201 0.007542 +17723 1 0.000235 1560.000000 -0.000892 -0.002970 0.006658 +17724 1 0.000212 1560.000000 0.002766 -0.001765 0.009348 +17725 1 0.000241 1560.000000 0.000381 0.002554 0.004992 +17726 1 0.000285 1560.000000 -0.001056 -0.001928 0.007664 +17727 1 0.000260 1560.000000 -0.001618 -0.002346 0.007019 +17728 1 0.000204 1560.000000 -0.000094 0.000846 0.004353 +17729 1 0.000251 1560.000000 0.002104 -0.000985 0.001861 +17730 1 0.000248 1560.000000 -0.001032 0.002018 0.002792 +17731 1 0.000262 1560.000000 0.002518 0.001267 0.000697 +17732 1 0.000229 1560.000000 -0.002442 -0.001134 0.007356 +17733 1 0.000283 1560.000000 0.001517 -0.000981 0.000467 +17734 1 0.000214 1560.000000 -0.002008 -0.001983 0.000634 +17735 1 0.000266 1560.000000 -0.001989 -0.002145 0.001098 +17736 1 0.000279 1560.000000 -0.001316 -0.003436 0.005652 +17737 1 0.000196 1560.000000 -0.002274 -0.001170 0.006341 +17738 1 0.000233 1560.000000 -0.000203 0.001761 0.006129 +17739 1 0.000243 1560.000000 0.002782 0.000560 0.003513 +17740 1 0.000194 1560.000000 0.001520 -0.000437 0.003886 +17741 1 0.000242 1560.000000 -0.001407 -0.001069 0.009468 +17742 1 0.000200 1560.000000 -0.000552 -0.001177 0.003641 +17743 1 0.000235 1560.000000 -0.000076 -0.002778 0.009744 +17744 1 0.000262 1560.000000 0.003325 -0.001850 0.003190 +17745 1 0.000255 1560.000000 0.003166 -0.000323 0.005149 +17746 1 0.000288 1560.000000 -0.001285 0.003622 0.005155 +17747 1 0.000203 1560.000000 -0.002853 0.000904 0.000321 +17748 1 0.000236 1560.000000 -0.000410 -0.003685 0.000753 +17749 1 0.000227 1560.000000 -0.002114 0.002571 0.002176 +17750 1 0.000221 1560.000000 -0.000106 0.001536 0.005989 +17751 1 0.000268 1560.000000 -0.002019 0.002820 0.000872 +17752 1 0.000212 1560.000000 0.002483 0.001611 0.003490 +17753 1 0.000226 1560.000000 0.000871 -0.000578 0.004654 +17754 1 0.000227 1560.000000 -0.000098 -0.003702 0.004303 +17755 1 0.000264 1560.000000 0.001255 0.003486 0.008111 +17756 1 0.000252 1560.000000 -0.003406 -0.001144 0.002206 +17757 1 0.000216 1560.000000 0.001324 0.003453 0.001553 +17758 1 0.000280 1560.000000 0.002042 -0.002224 0.009305 +17759 1 0.000205 1560.000000 -0.001995 0.002177 0.004822 +17760 1 0.000219 1560.000000 0.000935 0.000187 0.006782 +17761 1 0.000192 1560.000000 0.000477 0.002351 0.003800 +17762 1 0.000225 1560.000000 0.001412 0.001763 0.000629 +17763 1 0.000281 1560.000000 0.001531 -0.001706 0.008602 +17764 1 0.000219 1560.000000 0.000256 -0.000280 0.000500 +17765 1 0.000234 1560.000000 -0.002206 -0.001223 0.001868 +17766 1 0.000199 1560.000000 -0.001359 -0.000124 0.008739 +17767 1 0.000235 1560.000000 -0.001831 0.001118 0.006568 +17768 1 0.000227 1560.000000 0.003050 0.000242 0.006409 +17769 1 0.000280 1560.000000 0.002640 0.001031 0.006646 +17770 1 0.000259 1560.000000 0.003392 0.000142 0.009305 +17771 1 0.000212 1560.000000 -0.000541 -0.002503 0.001297 +17772 1 0.000255 1560.000000 -0.001753 0.002382 0.008929 +17773 1 0.000200 1560.000000 0.000457 -0.001781 0.008359 +17774 1 0.000221 1560.000000 -0.002792 -0.000196 0.002253 +17775 1 0.000233 1560.000000 0.001075 -0.003347 0.009531 +17776 1 0.000208 1560.000000 0.000870 0.001894 0.008701 +17777 1 0.000194 1560.000000 -0.000061 0.001131 0.002980 +17778 1 0.000276 1560.000000 -0.003064 -0.001513 0.008945 +17779 1 0.000272 1560.000000 0.002104 0.001144 0.009780 +17780 1 0.000196 1560.000000 -0.000344 0.002607 0.006551 +17781 1 0.000197 1560.000000 0.000134 -0.002253 0.001377 +17782 1 0.000278 1560.000000 -0.000448 0.002246 0.004840 +17783 1 0.000204 1560.000000 -0.002678 -0.000397 0.003090 +17784 1 0.000192 1560.000000 -0.002162 -0.003026 0.003597 +17785 1 0.000206 1560.000000 -0.000706 -0.003353 0.005857 +17786 1 0.000195 1560.000000 -0.001831 0.003269 0.004867 +17787 1 0.000241 1560.000000 0.003604 0.000115 0.002723 +17788 1 0.000222 1560.000000 0.001808 -0.001793 0.002687 +17789 1 0.000223 1560.000000 0.002109 -0.002619 0.000771 +17790 1 0.000256 1560.000000 0.002489 -0.001500 0.006536 +17791 1 0.000274 1560.000000 0.001086 -0.002908 0.008984 +17792 1 0.000194 1560.000000 -0.002192 0.000131 0.005715 +17793 1 0.000263 1560.000000 -0.003180 -0.001570 0.006511 +17794 1 0.000208 1560.000000 0.002666 0.002767 0.002956 +17795 1 0.000259 1560.000000 0.003291 0.000249 0.005531 +17796 1 0.000235 1560.000000 -0.000509 -0.003784 0.001478 +17797 1 0.000260 1560.000000 0.003646 -0.001204 0.003669 +17798 1 0.000206 1560.000000 -0.002149 0.003195 0.003354 +17799 1 0.000264 1560.000000 0.001114 0.000282 0.002993 +17800 1 0.000229 1560.000000 0.000649 0.000575 0.002669 +17801 1 0.000220 1560.000000 -0.003181 -0.001339 0.007280 +17802 1 0.000215 1560.000000 0.001651 0.002829 0.003180 +17803 1 0.000196 1560.000000 -0.002059 -0.001592 0.007722 +17804 1 0.000234 1560.000000 0.000225 -0.003554 0.004664 +17805 1 0.000208 1560.000000 0.003070 0.001885 0.004590 +17806 1 0.000204 1560.000000 0.002976 -0.002014 0.003604 +17807 1 0.000231 1560.000000 0.001389 -0.000626 0.007575 +17808 1 0.000206 1560.000000 -0.001793 0.002454 0.005246 +17809 1 0.000195 1560.000000 -0.000211 0.000156 0.003523 +17810 1 0.000203 1560.000000 0.003018 -0.002390 0.000482 +17811 1 0.000267 1560.000000 0.000384 0.001589 0.003560 +17812 1 0.000212 1560.000000 -0.001346 0.001509 0.003908 +17813 1 0.000277 1560.000000 -0.001317 0.001147 0.002007 +17814 1 0.000223 1560.000000 -0.000059 0.001275 0.007415 +17815 1 0.000195 1560.000000 -0.003538 -0.001516 0.002497 +17816 1 0.000225 1560.000000 0.000836 0.001026 0.003277 +17817 1 0.000287 1560.000000 -0.001916 -0.003265 0.006930 +17818 1 0.000248 1560.000000 -0.000810 0.002694 0.009778 +17819 1 0.000262 1560.000000 0.000873 0.003747 0.009154 +17820 1 0.000277 1560.000000 0.001492 -0.001946 0.005629 +17821 1 0.000282 1560.000000 -0.002464 0.001695 0.004221 +17822 1 0.000283 1560.000000 -0.000043 -0.003839 0.001906 +17823 1 0.000274 1560.000000 -0.003528 -0.000044 0.005208 +17824 1 0.000240 1560.000000 0.003613 0.000919 0.004260 +17825 1 0.000215 1560.000000 -0.001185 -0.001891 0.008674 +17826 1 0.000205 1560.000000 -0.002692 -0.002156 0.000658 +17827 1 0.000251 1560.000000 -0.002776 -0.001207 0.003125 +17828 1 0.000239 1560.000000 0.002317 0.000260 0.000591 +17829 1 0.000288 1560.000000 0.002134 0.000125 0.002684 +17830 1 0.000194 1560.000000 0.003081 0.000822 0.007242 +17831 1 0.000196 1560.000000 0.000930 -0.000502 0.008390 +17832 1 0.000200 1560.000000 -0.002542 -0.001262 0.001815 +17833 1 0.000203 1560.000000 -0.001011 0.000503 0.004395 +17834 1 0.000229 1560.000000 0.000278 -0.002858 0.008221 +17835 1 0.000265 1560.000000 0.001501 -0.003131 0.008824 +17836 1 0.000254 1560.000000 0.003261 0.002020 0.008871 +17837 1 0.000243 1560.000000 0.000394 -0.003831 0.001258 +17838 1 0.000285 1560.000000 0.002249 0.002179 0.000940 +17839 1 0.000199 1560.000000 0.001200 0.001214 0.008517 +17840 1 0.000207 1560.000000 -0.001065 -0.003114 0.005518 +17841 1 0.000245 1560.000000 0.000377 0.002926 0.000146 +17842 1 0.000195 1560.000000 0.001443 -0.002374 0.005014 +17843 1 0.000265 1560.000000 0.003339 0.000054 0.005065 +17844 1 0.000221 1560.000000 0.002442 -0.000908 0.009240 +17845 1 0.000268 1560.000000 -0.001879 0.000384 0.009275 +17846 1 0.000259 1560.000000 0.002789 0.002583 0.000879 +17847 1 0.000207 1560.000000 0.001844 -0.001678 0.001371 +17848 1 0.000287 1560.000000 0.001769 -0.002086 0.009801 +17849 1 0.000283 1560.000000 0.002579 -0.002039 0.001981 +17850 1 0.000257 1560.000000 -0.000400 -0.002790 0.001411 +17851 1 0.000259 1560.000000 -0.001350 -0.002116 0.003915 +17852 1 0.000224 1560.000000 -0.002713 -0.001347 0.007915 +17853 1 0.000271 1560.000000 -0.002806 -0.002585 0.002450 +17854 1 0.000198 1560.000000 -0.002032 0.003266 0.005101 +17855 1 0.000279 1560.000000 0.002638 0.000873 0.002280 +17856 1 0.000218 1560.000000 -0.000012 -0.000847 0.001862 +17857 1 0.000284 1560.000000 -0.002747 -0.000696 0.005843 +17858 1 0.000202 1560.000000 -0.003253 0.002048 0.003746 +17859 1 0.000213 1560.000000 0.002524 -0.002499 0.006405 +17860 1 0.000226 1560.000000 0.003271 0.001860 0.006810 +17861 1 0.000239 1560.000000 -0.000830 0.002311 0.004134 +17862 1 0.000243 1560.000000 -0.001058 -0.003061 0.001305 +17863 1 0.000228 1560.000000 -0.000609 0.001271 0.001302 +17864 1 0.000231 1560.000000 -0.001423 -0.000722 0.000295 +17865 1 0.000201 1560.000000 -0.000038 -0.000254 0.001434 +17866 1 0.000201 1560.000000 -0.003577 -0.000431 0.004378 +17867 1 0.000245 1560.000000 -0.000891 -0.002111 0.003216 +17868 1 0.000282 1560.000000 0.002760 0.001589 0.005127 +17869 1 0.000243 1560.000000 -0.003520 0.000296 0.004284 +17870 1 0.000271 1560.000000 0.000375 -0.001455 0.006000 +17871 1 0.000200 1560.000000 -0.001201 0.001094 0.000898 +17872 1 0.000203 1560.000000 -0.002812 0.002153 0.000142 +17873 1 0.000265 1560.000000 0.000299 -0.003019 0.006070 +17874 1 0.000237 1560.000000 0.003546 0.000550 0.002095 +17875 1 0.000218 1560.000000 -0.001582 0.001163 0.005585 +17876 1 0.000215 1560.000000 0.001640 0.000352 0.005055 +17877 1 0.000264 1560.000000 -0.003299 0.000911 0.003893 +17878 1 0.000281 1560.000000 -0.000798 0.001979 0.006807 +17879 1 0.000225 1560.000000 -0.002336 0.000764 0.009276 +17880 1 0.000258 1560.000000 -0.000071 0.000934 0.003884 +17881 1 0.000269 1560.000000 -0.001621 -0.003096 0.004805 +17882 1 0.000214 1560.000000 -0.001549 -0.002993 0.008283 +17883 1 0.000209 1560.000000 0.000681 0.000581 0.003129 +17884 1 0.000232 1560.000000 -0.001968 0.002894 0.007694 +17885 1 0.000211 1560.000000 0.000240 -0.003150 0.006920 +17886 1 0.000253 1560.000000 0.001475 -0.003193 0.003396 +17887 1 0.000229 1560.000000 0.003326 -0.001052 0.001735 +17888 1 0.000209 1560.000000 -0.000130 -0.003286 0.002343 +17889 1 0.000288 1560.000000 0.000540 0.003703 0.001457 +17890 1 0.000204 1560.000000 -0.000233 -0.000134 0.001445 +17891 1 0.000196 1560.000000 0.001414 0.001975 0.007041 +17892 1 0.000228 1560.000000 -0.001539 -0.001728 0.008991 +17893 1 0.000266 1560.000000 -0.000360 0.001580 0.001000 +17894 1 0.000206 1560.000000 0.000377 0.002060 0.003053 +17895 1 0.000198 1560.000000 0.000274 0.001966 0.009582 +17896 1 0.000282 1560.000000 0.003628 0.000115 0.009792 +17897 1 0.000194 1560.000000 -0.002339 -0.002679 0.004462 +17898 1 0.000194 1560.000000 0.003514 -0.000022 0.008759 +17899 1 0.000281 1560.000000 0.001615 0.003414 0.004195 +17900 1 0.000238 1560.000000 -0.001527 0.002310 0.000328 +17901 1 0.000195 1560.000000 -0.000763 -0.003166 0.006810 +17902 1 0.000202 1560.000000 -0.000052 -0.001309 0.000138 +17903 1 0.000225 1560.000000 -0.002378 0.002349 0.007471 +17904 1 0.000257 1560.000000 -0.002404 0.001651 0.001068 +17905 1 0.000219 1560.000000 -0.001646 -0.003246 0.004057 +17906 1 0.000194 1560.000000 0.001312 0.002039 0.008709 +17907 1 0.000285 1560.000000 -0.000626 -0.003552 0.008316 +17908 1 0.000230 1560.000000 -0.000207 0.000286 0.008507 +17909 1 0.000197 1560.000000 -0.000985 0.002594 0.002957 +17910 1 0.000275 1560.000000 -0.001153 0.002130 0.008101 +17911 1 0.000230 1560.000000 0.001373 -0.001281 0.003069 +17912 1 0.000222 1560.000000 0.001324 -0.002161 0.000128 +17913 1 0.000253 1560.000000 -0.001737 0.001924 0.009035 +17914 1 0.000254 1560.000000 0.000337 -0.002489 0.008502 +17915 1 0.000214 1560.000000 -0.000131 0.002503 0.006241 +17916 1 0.000255 1560.000000 -0.002784 0.000913 0.009432 +17917 1 0.000257 1560.000000 -0.003815 -0.000255 0.004620 +17918 1 0.000199 1560.000000 0.000406 0.003545 0.001834 +17919 1 0.000238 1560.000000 0.003209 0.000759 0.003109 +17920 1 0.000268 1560.000000 0.000290 -0.001848 0.006647 +17921 1 0.000282 1560.000000 -0.003753 0.000838 0.001011 +17922 1 0.000251 1560.000000 0.000486 -0.000970 0.008200 +17923 1 0.000196 1560.000000 0.000513 -0.000035 0.006707 +17924 1 0.000200 1560.000000 0.001310 -0.000126 0.007555 +17925 1 0.000206 1560.000000 0.000947 -0.002637 0.002505 +17926 1 0.000199 1560.000000 -0.001877 -0.000712 0.005446 +17927 1 0.000286 1560.000000 0.003769 0.000704 0.001633 +17928 1 0.000265 1560.000000 -0.002152 -0.001150 0.001245 +17929 1 0.000245 1560.000000 0.003104 -0.000836 0.000195 +17930 1 0.000195 1560.000000 -0.000557 -0.001389 0.000591 +17931 1 0.000233 1560.000000 0.002812 -0.002631 0.002847 +17932 1 0.000246 1560.000000 0.002636 -0.001009 0.008754 +17933 1 0.000283 1560.000000 0.000860 -0.002191 0.007465 +17934 1 0.000220 1560.000000 -0.000114 0.000710 0.004191 +17935 1 0.000268 1560.000000 0.003256 -0.000321 0.005963 +17936 1 0.000205 1560.000000 -0.002328 0.000705 0.008788 +17937 1 0.000275 1560.000000 0.002835 0.002564 0.004826 +17938 1 0.000258 1560.000000 0.000947 0.003455 0.002270 +17939 1 0.000216 1560.000000 0.000919 -0.003154 0.004377 +17940 1 0.000280 1560.000000 -0.001701 0.001944 0.005851 +17941 1 0.000249 1560.000000 0.000984 0.002259 0.001541 +17942 1 0.000199 1560.000000 -0.001270 -0.000529 0.006602 +17943 1 0.000212 1560.000000 -0.000045 -0.000869 0.009539 +17944 1 0.000278 1560.000000 0.001699 0.001337 0.009833 +17945 1 0.000260 1560.000000 0.000662 0.003509 0.004194 +17946 1 0.000233 1560.000000 0.002683 -0.000934 0.005410 +17947 1 0.000197 1560.000000 -0.002151 -0.002682 0.004294 +17948 1 0.000266 1560.000000 0.000770 0.003703 0.003242 +17949 1 0.000195 1560.000000 0.001930 0.003145 0.008925 +17950 1 0.000254 1560.000000 -0.003618 0.001320 0.007825 +17951 1 0.000281 1560.000000 -0.001927 0.001217 0.008149 +17952 1 0.000266 1560.000000 -0.002762 -0.000128 0.002685 +17953 1 0.000240 1560.000000 0.001337 -0.001204 0.008614 +17954 1 0.000193 1560.000000 -0.003126 0.000545 0.008723 +17955 1 0.000210 1560.000000 -0.001814 0.000321 0.008394 +17956 1 0.000205 1560.000000 0.000116 -0.000063 0.007584 +17957 1 0.000203 1560.000000 0.000827 0.000886 0.003938 +17958 1 0.000283 1560.000000 0.001494 0.000469 0.000783 +17959 1 0.000241 1560.000000 -0.001755 -0.003429 0.007153 +17960 1 0.000192 1560.000000 -0.002187 0.000606 0.005092 +17961 1 0.000214 1560.000000 -0.002229 -0.002163 0.000569 +17962 1 0.000205 1560.000000 0.000554 -0.000074 0.005044 +17963 1 0.000198 1560.000000 -0.003734 0.000952 0.007927 +17964 1 0.000232 1560.000000 0.001637 -0.001912 0.003210 +17965 1 0.000235 1560.000000 -0.002546 -0.002753 0.008103 +17966 1 0.000249 1560.000000 0.003310 -0.000553 0.008588 +17967 1 0.000214 1560.000000 -0.002449 0.002571 0.007311 +17968 1 0.000215 1560.000000 0.003173 -0.002003 0.008731 +17969 1 0.000238 1560.000000 0.000410 -0.003695 0.005886 +17970 1 0.000215 1560.000000 -0.001411 -0.001508 0.006793 +17971 1 0.000206 1560.000000 -0.002501 0.001563 0.007851 +17972 1 0.000276 1560.000000 -0.001023 -0.003565 0.008610 +17973 1 0.000276 1560.000000 0.001732 0.001379 0.006730 +17974 1 0.000201 1560.000000 -0.000621 -0.003065 0.004445 +17975 1 0.000240 1560.000000 0.002697 0.002255 0.005500 +17976 1 0.000272 1560.000000 0.000607 0.002305 0.008075 +17977 1 0.000210 1560.000000 -0.003490 0.001172 0.003198 +17978 1 0.000222 1560.000000 -0.000849 -0.002753 0.004019 +17979 1 0.000203 1560.000000 -0.000482 -0.001510 0.002161 +17980 1 0.000194 1560.000000 -0.002452 -0.001125 0.003594 +17981 1 0.000279 1560.000000 0.002481 0.000254 0.007408 +17982 1 0.000285 1560.000000 0.001471 -0.002046 0.001871 +17983 1 0.000205 1560.000000 0.003629 0.001034 0.000991 +17984 1 0.000202 1560.000000 -0.002446 0.000737 0.002788 +17985 1 0.000232 1560.000000 -0.002626 0.002560 0.003151 +17986 1 0.000264 1560.000000 0.002974 0.002346 0.004281 +17987 1 0.000282 1560.000000 -0.001988 -0.003044 0.007712 +17988 1 0.000243 1560.000000 0.003154 0.001609 0.004731 +17989 1 0.000227 1560.000000 0.002649 0.000463 0.007662 +17990 1 0.000270 1560.000000 0.002298 0.002628 0.007296 +17991 1 0.000220 1560.000000 -0.002108 -0.001298 0.009177 +17992 1 0.000193 1560.000000 0.000486 0.002798 0.001283 +17993 1 0.000247 1560.000000 0.000651 -0.001202 0.006315 +17994 1 0.000288 1560.000000 -0.001763 0.002619 0.006422 +17995 1 0.000204 1560.000000 0.002338 -0.002096 0.000966 +17996 1 0.000279 1560.000000 -0.003575 -0.000803 0.007133 +17997 1 0.000195 1560.000000 0.001006 -0.000962 0.001910 +17998 1 0.000273 1560.000000 -0.002637 0.000893 0.004466 +17999 1 0.000228 1560.000000 0.000950 -0.002471 0.005666 +18000 1 0.000282 1560.000000 0.001475 0.002813 0.007459 +18001 1 0.000209 1560.000000 -0.000987 0.003720 0.006153 +18002 1 0.000248 1560.000000 0.000730 0.003334 0.000290 +18003 1 0.000206 1560.000000 0.001847 0.000912 0.000114 +18004 1 0.000230 1560.000000 0.001078 -0.002579 0.003469 +18005 1 0.000251 1560.000000 -0.000563 0.003483 0.003468 +18006 1 0.000253 1560.000000 -0.000362 -0.002970 0.000931 +18007 1 0.000255 1560.000000 -0.001779 -0.000684 0.002240 +18008 1 0.000202 1560.000000 0.000115 -0.002244 0.009682 +18009 1 0.000196 1560.000000 0.003133 -0.001992 0.003228 +18010 1 0.000264 1560.000000 -0.000703 -0.003726 0.000667 +18011 1 0.000259 1560.000000 -0.000160 -0.002364 0.006166 +18012 1 0.000229 1560.000000 -0.003745 -0.000907 0.008411 +18013 1 0.000218 1560.000000 -0.003051 -0.000082 0.004380 +18014 1 0.000211 1560.000000 0.001570 0.000585 0.006356 +18015 1 0.000226 1560.000000 -0.001803 0.001598 0.003992 +18016 1 0.000246 1560.000000 -0.003188 -0.000389 0.005962 +18017 1 0.000220 1560.000000 -0.003104 0.000983 0.007185 +18018 1 0.000220 1560.000000 0.003750 0.000855 0.003872 +18019 1 0.000193 1560.000000 -0.000707 -0.003027 0.003236 +18020 1 0.000201 1560.000000 0.001234 -0.003580 0.006734 +18021 1 0.000231 1560.000000 -0.002826 0.002417 0.003346 +18022 1 0.000209 1560.000000 0.001071 -0.002417 0.006779 +18023 1 0.000230 1560.000000 -0.001336 -0.000198 0.009504 +18024 1 0.000202 1560.000000 0.001556 0.002103 0.004431 +18025 1 0.000252 1560.000000 -0.003049 0.001905 0.006244 +18026 1 0.000251 1560.000000 -0.002333 0.001117 0.000420 +18027 1 0.000219 1560.000000 -0.001146 0.002846 0.000486 +18028 1 0.000254 1560.000000 0.002119 -0.001005 0.000136 +18029 1 0.000223 1560.000000 0.001032 0.001957 0.007520 +18030 1 0.000267 1560.000000 0.000785 -0.002845 0.007730 +18031 1 0.000223 1560.000000 -0.001307 0.001291 0.007227 +18032 1 0.000208 1560.000000 0.000224 -0.000484 0.001590 +18033 1 0.000194 1560.000000 -0.003062 -0.002101 0.003480 +18034 1 0.000207 1560.000000 0.000810 -0.000607 0.002007 +18035 1 0.000236 1560.000000 0.001916 0.001631 0.006501 +18036 1 0.000193 1560.000000 0.001585 -0.001039 0.003801 +18037 1 0.000202 1560.000000 0.002269 0.002280 0.002767 +18038 1 0.000192 1560.000000 -0.001059 -0.002282 0.004519 +18039 1 0.000205 1560.000000 0.003409 -0.001006 0.000873 +18040 1 0.000198 1560.000000 -0.002325 0.001697 0.003259 +18041 1 0.000245 1560.000000 0.003408 -0.000844 0.002288 +18042 1 0.000222 1560.000000 0.000889 0.000990 0.006332 +18043 1 0.000226 1560.000000 0.002433 -0.001097 0.004893 +18044 1 0.000277 1560.000000 -0.002316 0.002764 0.001071 +18045 1 0.000208 1560.000000 0.003434 -0.000100 0.006578 +18046 1 0.000267 1560.000000 -0.001397 -0.000191 0.006378 +18047 1 0.000242 1560.000000 -0.000912 0.001138 0.000727 +18048 1 0.000277 1560.000000 -0.002452 -0.001383 0.007268 +18049 1 0.000250 1560.000000 -0.001816 -0.002091 0.009394 +18050 1 0.000198 1560.000000 -0.000394 0.003434 0.009372 +18051 1 0.000231 1560.000000 -0.000801 -0.001415 0.000553 +18052 1 0.000246 1560.000000 0.000424 -0.002477 0.007528 +18053 1 0.000228 1560.000000 -0.000292 0.002838 0.000190 +18054 1 0.000235 1560.000000 -0.001865 0.000484 0.002778 +18055 1 0.000251 1560.000000 -0.001322 -0.002382 0.006144 +18056 1 0.000251 1560.000000 0.002819 0.002601 0.004247 +18057 1 0.000198 1560.000000 0.000094 0.001533 0.008276 +18058 1 0.000220 1560.000000 -0.002249 0.002446 0.008634 +18059 1 0.000285 1560.000000 0.003210 -0.002018 0.001930 +18060 1 0.000211 1560.000000 0.000545 0.002722 0.001681 +18061 1 0.000246 1560.000000 -0.003313 0.001257 0.007504 +18062 1 0.000246 1560.000000 -0.002373 0.002052 0.007692 +18063 1 0.000210 1560.000000 0.000171 0.002967 0.007874 +18064 1 0.000269 1560.000000 0.000541 0.003716 0.009541 +18065 1 0.000226 1560.000000 -0.000337 0.000872 0.007131 +18066 1 0.000228 1560.000000 0.000751 0.003690 0.006288 +18067 1 0.000238 1560.000000 0.000797 0.001877 0.000983 +18068 1 0.000206 1560.000000 -0.003813 -0.000473 0.001470 +18069 1 0.000248 1560.000000 -0.000586 -0.003370 0.003423 +18070 1 0.000286 1560.000000 0.000545 0.002121 0.000221 +18071 1 0.000230 1560.000000 -0.001557 0.000129 0.006488 +18072 1 0.000239 1560.000000 0.000113 -0.003311 0.001455 +18073 1 0.000268 1560.000000 0.002203 -0.003120 0.000986 +18074 1 0.000231 1560.000000 -0.000743 0.002018 0.007270 +18075 1 0.000225 1560.000000 -0.001618 -0.001877 0.008114 +18076 1 0.000247 1560.000000 0.002600 -0.002671 0.003008 +18077 1 0.000275 1560.000000 -0.003561 0.001369 0.006881 +18078 1 0.000284 1560.000000 0.000676 0.003255 0.007444 +18079 1 0.000237 1560.000000 -0.002189 0.001781 0.006180 +18080 1 0.000228 1560.000000 0.002844 -0.001105 0.008470 +18081 1 0.000261 1560.000000 0.001513 0.001997 0.000290 +18082 1 0.000219 1560.000000 -0.000200 0.001986 0.001810 +18083 1 0.000205 1560.000000 0.001113 0.003492 0.007063 +18084 1 0.000277 1560.000000 -0.002268 0.001440 0.005024 +18085 1 0.000195 1560.000000 -0.000053 -0.000620 0.006333 +18086 1 0.000208 1560.000000 -0.000276 0.000334 0.006958 +18087 1 0.000271 1560.000000 -0.001563 0.003447 0.004557 +18088 1 0.000284 1560.000000 -0.001526 -0.001324 0.009707 +18089 1 0.000288 1560.000000 -0.000280 -0.003186 0.009322 +18090 1 0.000261 1560.000000 0.002899 0.000147 0.006685 +18091 1 0.000255 1560.000000 -0.000723 -0.001462 0.007752 +18092 1 0.000207 1560.000000 -0.001801 0.002741 0.002901 +18093 1 0.000203 1560.000000 0.002980 -0.002379 0.004793 +18094 1 0.000220 1560.000000 0.001271 0.002240 0.000490 +18095 1 0.000265 1560.000000 0.002141 0.002419 0.006610 +18096 1 0.000202 1560.000000 0.001708 0.001654 0.000174 +18097 1 0.000209 1560.000000 0.000199 0.003815 0.000937 +18098 1 0.000200 1560.000000 0.001901 0.002417 0.004268 +18099 1 0.000214 1560.000000 0.002221 0.002496 0.005644 +18100 1 0.000237 1560.000000 0.001915 0.001425 0.000133 +18101 1 0.000261 1560.000000 -0.000893 0.002481 0.000637 +18102 1 0.000193 1560.000000 -0.000491 -0.002067 0.009044 +18103 1 0.000254 1560.000000 0.002170 -0.001219 0.006451 +18104 1 0.000251 1560.000000 0.000775 -0.002099 0.005351 +18105 1 0.000221 1560.000000 -0.000610 0.002360 0.004354 +18106 1 0.000220 1560.000000 0.002192 -0.001398 0.007767 +18107 1 0.000283 1560.000000 0.000804 0.003399 0.002791 +18108 1 0.000230 1560.000000 -0.001703 0.000468 0.000923 +18109 1 0.000220 1560.000000 0.000889 0.001756 0.005940 +18110 1 0.000222 1560.000000 0.000613 0.001829 0.003520 +18111 1 0.000204 1560.000000 -0.000610 0.000097 0.009167 +18112 1 0.000198 1560.000000 0.001656 0.002099 0.001834 +18113 1 0.000205 1560.000000 0.000185 -0.000033 0.005805 +18114 1 0.000283 1560.000000 -0.001498 -0.003549 0.003059 +18115 1 0.000226 1560.000000 -0.003055 0.001989 0.001198 +18116 1 0.000245 1560.000000 0.002181 0.002930 0.009813 +18117 1 0.000262 1560.000000 -0.001988 0.003160 0.007945 +18118 1 0.000211 1560.000000 -0.002150 -0.002894 0.009419 +18119 1 0.000198 1560.000000 -0.002175 0.000154 0.004404 +18120 1 0.000230 1560.000000 0.003564 -0.001431 0.000886 +18121 1 0.000197 1560.000000 -0.001653 -0.002475 0.001670 +18122 1 0.000207 1560.000000 -0.002134 0.000788 0.007140 +18123 1 0.000213 1560.000000 0.001914 -0.002859 0.007084 +18124 1 0.000195 1560.000000 -0.002458 -0.001609 0.005064 +18125 1 0.000214 1560.000000 0.002871 0.001961 0.001634 +18126 1 0.000237 1560.000000 0.000023 -0.002485 0.009772 +18127 1 0.000248 1560.000000 0.002593 0.002190 0.001529 +18128 1 0.000287 1560.000000 0.003014 0.001392 0.009833 +18129 1 0.000235 1560.000000 -0.000790 0.002967 0.008113 +18130 1 0.000283 1560.000000 -0.002799 0.000236 0.000145 +18131 1 0.000227 1560.000000 0.000956 0.003349 0.007135 +18132 1 0.000258 1560.000000 -0.002392 0.002387 0.001218 +18133 1 0.000273 1560.000000 -0.001884 0.001105 0.009848 +18134 1 0.000247 1560.000000 -0.002089 -0.001771 0.002392 +18135 1 0.000237 1560.000000 0.000680 -0.003291 0.004776 +18136 1 0.000197 1560.000000 -0.000457 0.002544 0.004676 +18137 1 0.000210 1560.000000 0.003313 -0.001894 0.007705 +18138 1 0.000281 1560.000000 -0.002123 -0.003202 0.005776 +18139 1 0.000204 1560.000000 -0.001302 0.000732 0.005390 +18140 1 0.000239 1560.000000 -0.002742 0.000097 0.005577 +18141 1 0.000268 1560.000000 0.002240 0.001812 0.008360 +18142 1 0.000282 1560.000000 -0.003563 0.001343 0.002535 +18143 1 0.000196 1560.000000 -0.000171 0.002709 0.008653 +18144 1 0.000213 1560.000000 -0.000775 0.001539 0.008986 +18145 1 0.000247 1560.000000 -0.002335 -0.000462 0.009607 +18146 1 0.000256 1560.000000 0.002627 0.002517 0.006104 +18147 1 0.000249 1560.000000 0.001454 0.002688 0.009817 +18148 1 0.000195 1560.000000 0.003245 -0.000812 0.001001 +18149 1 0.000247 1560.000000 0.001385 0.002223 0.005640 +18150 1 0.000209 1560.000000 0.001270 0.001616 0.002623 +18151 1 0.000256 1560.000000 -0.000432 -0.001689 0.004724 +18152 1 0.000199 1560.000000 -0.003242 -0.000743 0.004484 +18153 1 0.000283 1560.000000 -0.002853 -0.002572 0.004236 +18154 1 0.000211 1560.000000 0.001622 0.001754 0.001574 +18155 1 0.000223 1560.000000 0.002314 -0.001599 0.005690 +18156 1 0.000284 1560.000000 0.000475 -0.002159 0.004149 +18157 1 0.000216 1560.000000 0.000577 -0.003318 0.006417 +18158 1 0.000241 1560.000000 -0.002052 -0.002633 0.000783 +18159 1 0.000195 1560.000000 0.000018 0.000706 0.005360 +18160 1 0.000211 1560.000000 -0.002618 0.001232 0.008404 +18161 1 0.000247 1560.000000 0.001668 -0.000268 0.001276 +18162 1 0.000199 1560.000000 -0.000186 -0.002549 0.009249 +18163 1 0.000202 1560.000000 0.000316 0.001326 0.000141 +18164 1 0.000243 1560.000000 -0.003442 -0.001030 0.009076 +18165 1 0.000215 1560.000000 -0.000001 0.000628 0.009681 +18166 1 0.000224 1560.000000 0.001172 -0.002248 0.001026 +18167 1 0.000204 1560.000000 0.002169 -0.001712 0.006279 +18168 1 0.000283 1560.000000 -0.001923 0.001067 0.001502 +18169 1 0.000231 1560.000000 -0.000564 -0.000778 0.002447 +18170 1 0.000199 1560.000000 -0.001806 0.000830 0.006027 +18171 1 0.000231 1560.000000 -0.002266 0.001280 0.001874 +18172 1 0.000193 1560.000000 0.000184 0.001210 0.009219 +18173 1 0.000273 1560.000000 -0.000033 -0.002250 0.004114 +18174 1 0.000199 1560.000000 -0.000684 0.003386 0.008530 +18175 1 0.000197 1560.000000 0.000563 0.001697 0.004692 +18176 1 0.000208 1560.000000 -0.001226 -0.001598 0.000913 +18177 1 0.000216 1560.000000 0.001535 0.001866 0.005335 +18178 1 0.000220 1560.000000 -0.000043 0.001890 0.007342 +18179 1 0.000215 1560.000000 -0.001087 -0.001628 0.005240 +18180 1 0.000193 1560.000000 0.001196 0.002534 0.009015 +18181 1 0.000265 1560.000000 0.000192 0.000615 0.007224 +18182 1 0.000197 1560.000000 -0.000348 0.003113 0.002426 +18183 1 0.000221 1560.000000 -0.001798 -0.002271 0.008315 +18184 1 0.000242 1560.000000 -0.003260 0.001934 0.002342 +18185 1 0.000211 1560.000000 0.000417 0.001168 0.007490 +18186 1 0.000246 1560.000000 0.003357 0.001522 0.005574 +18187 1 0.000192 1560.000000 -0.002323 0.000136 0.009172 +18188 1 0.000236 1560.000000 -0.002321 -0.001524 0.003392 +18189 1 0.000259 1560.000000 0.000644 0.002294 0.001422 +18190 1 0.000248 1560.000000 0.000932 -0.000932 0.000136 +18191 1 0.000204 1560.000000 0.000020 -0.003734 0.000719 +18192 1 0.000214 1560.000000 -0.001955 -0.001947 0.000175 +18193 1 0.000229 1560.000000 0.001594 0.000370 0.004223 +18194 1 0.000270 1560.000000 0.001197 0.001764 0.003733 +18195 1 0.000245 1560.000000 -0.000186 0.002758 0.005785 +18196 1 0.000206 1560.000000 -0.001697 -0.000547 0.003125 +18197 1 0.000215 1560.000000 -0.000591 0.002528 0.006409 +18198 1 0.000220 1560.000000 -0.001552 -0.002821 0.002948 +18199 1 0.000212 1560.000000 0.000016 -0.003845 0.005690 +18200 1 0.000198 1560.000000 0.001494 -0.003373 0.008681 +18201 1 0.000222 1560.000000 -0.003099 -0.000287 0.006832 +18202 1 0.000201 1560.000000 0.001052 -0.000644 0.004236 +18203 1 0.000253 1560.000000 -0.003474 -0.001331 0.006899 +18204 1 0.000247 1560.000000 0.001047 0.003269 0.001766 +18205 1 0.000208 1560.000000 -0.002066 -0.002963 0.006438 +18206 1 0.000260 1560.000000 0.003391 -0.000462 0.002038 +18207 1 0.000218 1560.000000 -0.002437 0.002415 0.000590 +18208 1 0.000273 1560.000000 0.001084 0.001941 0.009186 +18209 1 0.000221 1560.000000 0.000305 -0.003757 0.001938 +18210 1 0.000211 1560.000000 0.001437 0.001484 0.007081 +18211 1 0.000233 1560.000000 0.002455 -0.002931 0.005857 +18212 1 0.000205 1560.000000 0.001572 -0.001723 0.003787 +18213 1 0.000197 1560.000000 0.000084 -0.000579 0.003371 +18214 1 0.000216 1560.000000 0.001030 0.000162 0.006123 +18215 1 0.000195 1560.000000 0.001974 -0.002333 0.003533 +18216 1 0.000246 1560.000000 0.003702 -0.000806 0.006045 +18217 1 0.000201 1560.000000 0.002193 0.000942 0.005378 +18218 1 0.000225 1560.000000 -0.000229 -0.001041 0.007532 +18219 1 0.000287 1560.000000 -0.001325 0.003578 0.003975 +18220 1 0.000242 1560.000000 0.000257 0.002573 0.001666 +18221 1 0.000283 1560.000000 0.003290 0.001926 0.003469 +18222 1 0.000274 1560.000000 0.000032 -0.003816 0.007440 +18223 1 0.000245 1560.000000 0.001196 -0.000713 0.009818 +18224 1 0.000211 1560.000000 -0.000234 0.003812 0.001388 +18225 1 0.000196 1560.000000 0.000020 -0.000329 0.007407 +18226 1 0.000222 1560.000000 0.001378 -0.000897 0.004557 +18227 1 0.000238 1560.000000 -0.000031 0.002478 0.002660 +18228 1 0.000214 1560.000000 -0.001513 0.002396 0.009368 +18229 1 0.000208 1560.000000 0.002975 -0.001638 0.004188 +18230 1 0.000209 1560.000000 0.001452 0.001647 0.002031 +18231 1 0.000192 1560.000000 -0.001420 0.000955 0.004980 +18232 1 0.000194 1560.000000 -0.000712 -0.003284 0.000192 +18233 1 0.000251 1560.000000 0.001807 0.000578 0.004533 +18234 1 0.000284 1560.000000 -0.001330 0.002926 0.003964 +18235 1 0.000226 1560.000000 0.000574 -0.000733 0.004012 +18236 1 0.000197 1560.000000 -0.001931 -0.000325 0.000648 +18237 1 0.000193 1560.000000 -0.000993 -0.002016 0.005140 +18238 1 0.000198 1560.000000 0.002348 -0.000605 0.002992 +18239 1 0.000199 1560.000000 -0.002212 0.001487 0.008567 +18240 1 0.000239 1560.000000 -0.003662 -0.000666 0.003577 +18241 1 0.000246 1560.000000 0.001364 -0.001374 0.007450 +18242 1 0.000288 1560.000000 -0.002653 0.002250 0.009362 +18243 1 0.000233 1560.000000 0.002201 -0.000713 0.008876 +18244 1 0.000212 1560.000000 0.001417 0.003206 0.003069 +18245 1 0.000271 1560.000000 -0.001078 -0.002080 0.001601 +18246 1 0.000235 1560.000000 0.000519 0.003240 0.004764 +18247 1 0.000221 1560.000000 -0.001888 0.001383 0.007872 +18248 1 0.000246 1560.000000 0.002491 0.001786 0.006915 +18249 1 0.000283 1560.000000 0.002192 0.000785 0.009157 +18250 1 0.000283 1560.000000 0.001840 0.002001 0.008066 +18251 1 0.000254 1560.000000 -0.001351 -0.002767 0.001659 +18252 1 0.000283 1560.000000 0.003770 -0.000687 0.008070 +18253 1 0.000210 1560.000000 -0.003318 -0.000674 0.003141 +18254 1 0.000262 1560.000000 -0.001285 0.001390 0.009839 +18255 1 0.000230 1560.000000 0.002281 0.002392 0.001537 +18256 1 0.000232 1560.000000 -0.000792 -0.001792 0.005830 +18257 1 0.000271 1560.000000 0.000162 0.003669 0.009810 +18258 1 0.000255 1560.000000 0.002836 -0.000150 0.000476 +18259 1 0.000219 1560.000000 0.000610 0.003108 0.002478 +18260 1 0.000259 1560.000000 0.001471 -0.001361 0.000213 +18261 1 0.000238 1560.000000 0.000048 0.002688 0.006906 +18262 1 0.000207 1560.000000 -0.000157 -0.003149 0.003612 +18263 1 0.000271 1560.000000 -0.001346 0.002975 0.002555 +18264 1 0.000218 1560.000000 -0.000676 -0.000693 0.003619 +18265 1 0.000219 1560.000000 -0.000703 0.002973 0.002781 +18266 1 0.000239 1560.000000 -0.000955 0.003438 0.005444 +18267 1 0.000213 1560.000000 -0.001232 0.000805 0.005617 +18268 1 0.000262 1560.000000 0.002280 -0.001657 0.004594 +18269 1 0.000250 1560.000000 -0.000971 0.001700 0.007845 +18270 1 0.000219 1560.000000 -0.002663 -0.002718 0.008334 +18271 1 0.000236 1560.000000 0.002332 -0.002672 0.007315 +18272 1 0.000216 1560.000000 -0.002608 -0.000139 0.005072 +18273 1 0.000227 1560.000000 0.003791 -0.000561 0.000628 +18274 1 0.000199 1560.000000 -0.000841 -0.002599 0.003466 +18275 1 0.000207 1560.000000 -0.000896 0.003215 0.001849 +18276 1 0.000265 1560.000000 -0.001078 -0.001995 0.008182 +18277 1 0.000218 1560.000000 0.002082 -0.003032 0.000513 +18278 1 0.000232 1560.000000 0.000638 -0.002738 0.007926 +18279 1 0.000224 1560.000000 0.001966 0.002286 0.006321 +18280 1 0.000217 1560.000000 0.000162 -0.002734 0.004284 +18281 1 0.000193 1560.000000 -0.001451 0.002340 0.001830 +18282 1 0.000195 1560.000000 -0.001871 -0.000775 0.003469 +18283 1 0.000218 1560.000000 -0.001944 0.002633 0.004302 +18284 1 0.000266 1560.000000 -0.002409 0.000273 0.004775 +18285 1 0.000282 1560.000000 0.002978 0.000093 0.006055 +18286 1 0.000225 1560.000000 0.001686 -0.002780 0.008913 +18287 1 0.000231 1560.000000 -0.002377 0.002516 0.003154 +18288 1 0.000205 1560.000000 -0.001256 0.001755 0.000351 +18289 1 0.000201 1560.000000 -0.001887 0.000927 0.006365 +18290 1 0.000212 1560.000000 0.003210 0.001702 0.009516 +18291 1 0.000220 1560.000000 0.003472 -0.001210 0.005907 +18292 1 0.000249 1560.000000 0.001806 -0.000295 0.000509 +18293 1 0.000212 1560.000000 -0.000817 -0.001154 0.003918 +18294 1 0.000194 1560.000000 0.003823 0.000252 0.000141 +18295 1 0.000203 1560.000000 -0.002869 0.002156 0.007400 +18296 1 0.000231 1560.000000 0.000902 0.002012 0.004868 +18297 1 0.000279 1560.000000 -0.002477 -0.000588 0.009077 +18298 1 0.000244 1560.000000 -0.001398 -0.002307 0.001439 +18299 1 0.000237 1560.000000 -0.003339 -0.001924 0.000340 +18300 1 0.000247 1560.000000 0.000481 0.003782 0.004486 +18301 1 0.000218 1560.000000 0.000970 0.002492 0.006749 +18302 1 0.000259 1560.000000 0.000327 0.002669 0.009047 +18303 1 0.000207 1560.000000 0.003700 -0.000527 0.005565 +18304 1 0.000215 1560.000000 0.000095 -0.001238 0.001087 +18305 1 0.000202 1560.000000 0.002431 -0.001195 0.001226 +18306 1 0.000208 1560.000000 0.001542 -0.002723 0.005817 +18307 1 0.000264 1560.000000 0.003628 -0.001031 0.006372 +18308 1 0.000192 1560.000000 -0.002288 0.000666 0.007289 +18309 1 0.000197 1560.000000 0.002611 0.000227 0.002815 +18310 1 0.000211 1560.000000 -0.002378 0.000328 0.004231 +18311 1 0.000229 1560.000000 0.000992 -0.002264 0.002735 +18312 1 0.000193 1560.000000 0.002919 0.001077 0.001840 +18313 1 0.000197 1560.000000 -0.002033 0.002474 0.007540 +18314 1 0.000210 1560.000000 0.003483 0.001635 0.009537 +18315 1 0.000236 1560.000000 -0.003458 -0.000579 0.007919 +18316 1 0.000273 1560.000000 -0.001083 -0.001308 0.007183 +18317 1 0.000199 1560.000000 0.002540 -0.001325 0.006162 +18318 1 0.000209 1560.000000 0.000270 -0.002765 0.009312 +18319 1 0.000223 1560.000000 -0.002192 -0.002477 0.005429 +18320 1 0.000282 1560.000000 -0.001824 0.003379 0.006905 +18321 1 0.000273 1560.000000 0.001077 -0.002886 0.007267 +18322 1 0.000258 1560.000000 0.002624 0.000108 0.004353 +18323 1 0.000258 1560.000000 0.000150 0.001527 0.003684 +18324 1 0.000195 1560.000000 0.002794 0.001488 0.002469 +18325 1 0.000213 1560.000000 0.001798 -0.002088 0.004870 +18326 1 0.000213 1560.000000 -0.000666 -0.002606 0.005311 +18327 1 0.000197 1560.000000 0.001412 0.001262 0.001483 +18328 1 0.000195 1560.000000 0.000015 -0.003842 0.002800 +18329 1 0.000209 1560.000000 -0.001214 0.000304 0.000905 +18330 1 0.000197 1560.000000 0.000397 -0.001674 0.004828 +18331 1 0.000214 1560.000000 -0.002511 0.001807 0.009516 +18332 1 0.000214 1560.000000 0.003763 0.000709 0.005023 +18333 1 0.000225 1560.000000 0.001554 -0.002929 0.004477 +18334 1 0.000213 1560.000000 -0.003387 -0.001061 0.006420 +18335 1 0.000259 1560.000000 0.001795 0.002865 0.004416 +18336 1 0.000246 1560.000000 -0.000903 -0.002706 0.002291 +18337 1 0.000261 1560.000000 -0.000436 -0.000958 0.008335 +18338 1 0.000276 1560.000000 -0.000451 0.002786 0.002218 +18339 1 0.000202 1560.000000 0.003467 0.001584 0.005137 +18340 1 0.000193 1560.000000 -0.000771 0.001099 0.000299 +18341 1 0.000281 1560.000000 0.000056 0.003076 0.002059 +18342 1 0.000241 1560.000000 -0.002936 0.000831 0.003069 +18343 1 0.000203 1560.000000 -0.000188 -0.001474 0.005507 +18344 1 0.000224 1560.000000 -0.000130 -0.003012 0.008851 +18345 1 0.000212 1560.000000 -0.002431 0.000242 0.005416 +18346 1 0.000216 1560.000000 0.003669 0.000944 0.009097 +18347 1 0.000195 1560.000000 0.002833 -0.002390 0.003521 +18348 1 0.000229 1560.000000 -0.002258 -0.000471 0.005519 +18349 1 0.000267 1560.000000 -0.002873 0.000191 0.001611 +18350 1 0.000227 1560.000000 0.000428 0.002249 0.000587 +18351 1 0.000209 1560.000000 0.002979 0.001864 0.008406 +18352 1 0.000260 1560.000000 -0.002461 0.002864 0.006728 +18353 1 0.000269 1560.000000 0.002747 0.000504 0.004715 +18354 1 0.000232 1560.000000 -0.002411 -0.000862 0.002971 +18355 1 0.000222 1560.000000 0.003345 -0.001157 0.006792 +18356 1 0.000243 1560.000000 -0.001876 0.001821 0.002425 +18357 1 0.000207 1560.000000 0.000534 -0.000309 0.002760 +18358 1 0.000287 1560.000000 -0.002223 0.001588 0.009854 +18359 1 0.000225 1560.000000 0.001093 -0.001975 0.005913 +18360 1 0.000196 1560.000000 0.002879 0.000905 0.004428 +18361 1 0.000224 1560.000000 0.001137 -0.001472 0.003160 +18362 1 0.000263 1560.000000 0.000801 0.002993 0.004809 +18363 1 0.000271 1560.000000 -0.001592 -0.001223 0.000204 +18364 1 0.000197 1560.000000 -0.001547 -0.001296 0.000525 +18365 1 0.000206 1560.000000 0.002998 -0.000277 0.001010 +18366 1 0.000229 1560.000000 -0.000547 -0.003197 0.000537 +18367 1 0.000193 1560.000000 -0.000305 0.000070 0.008161 +18368 1 0.000283 1560.000000 -0.000784 -0.003775 0.001525 +18369 1 0.000268 1560.000000 -0.001626 -0.000491 0.008429 +18370 1 0.000205 1560.000000 0.002133 0.002593 0.003849 +18371 1 0.000238 1560.000000 0.001453 -0.003210 0.005625 +18372 1 0.000193 1560.000000 0.001151 -0.000622 0.005769 +18373 1 0.000230 1560.000000 0.000822 -0.002819 0.006766 +18374 1 0.000218 1560.000000 0.001616 -0.002365 0.003571 +18375 1 0.000273 1560.000000 0.002137 0.002618 0.003235 +18376 1 0.000196 1560.000000 0.002347 0.000369 0.007933 +18377 1 0.000224 1560.000000 -0.000611 0.003766 0.000722 +18378 1 0.000210 1560.000000 0.000557 -0.000660 0.003026 +18379 1 0.000281 1560.000000 0.002764 0.001771 0.007771 +18380 1 0.000207 1560.000000 -0.002542 -0.000974 0.002788 +18381 1 0.000222 1560.000000 0.002296 0.002138 0.005608 +18382 1 0.000210 1560.000000 0.002544 -0.002324 0.002542 +18383 1 0.000231 1560.000000 0.002632 -0.001905 0.007152 +18384 1 0.000284 1560.000000 0.000343 -0.003838 0.006271 +18385 1 0.000227 1560.000000 0.001202 -0.002069 0.006130 +18386 1 0.000251 1560.000000 -0.003661 0.000243 0.000628 +18387 1 0.000249 1560.000000 -0.002337 -0.001801 0.006241 +18388 1 0.000232 1560.000000 -0.002892 -0.001805 0.003211 +18389 1 0.000203 1560.000000 -0.002260 0.001061 0.006276 +18390 1 0.000282 1560.000000 -0.002613 -0.001008 0.008293 +18391 1 0.000219 1560.000000 0.001631 0.000927 0.008827 +18392 1 0.000252 1560.000000 -0.002993 0.002367 0.004227 +18393 1 0.000203 1560.000000 -0.000540 -0.002074 0.004382 +18394 1 0.000216 1560.000000 0.001002 0.001590 0.003288 +18395 1 0.000201 1560.000000 -0.001205 -0.000251 0.000598 +18396 1 0.000250 1560.000000 0.003475 -0.001484 0.005475 +18397 1 0.000206 1560.000000 -0.002535 0.002124 0.007102 +18398 1 0.000208 1560.000000 0.001682 -0.002281 0.004875 +18399 1 0.000278 1560.000000 0.001221 -0.000965 0.003805 +18400 1 0.000239 1560.000000 -0.002385 -0.001607 0.001449 +18401 1 0.000218 1560.000000 -0.003260 0.000802 0.002444 +18402 1 0.000201 1560.000000 -0.001127 0.003391 0.001199 +18403 1 0.000201 1560.000000 -0.001275 -0.002751 0.002521 +18404 1 0.000217 1560.000000 0.002095 -0.001912 0.002805 +18405 1 0.000243 1560.000000 -0.001192 0.000715 0.003426 +18406 1 0.000288 1560.000000 -0.002636 -0.001848 0.008303 +18407 1 0.000245 1560.000000 -0.002176 -0.000765 0.000135 +18408 1 0.000287 1560.000000 0.002713 -0.002312 0.009712 +18409 1 0.000202 1560.000000 0.001947 -0.001134 0.004976 +18410 1 0.000219 1560.000000 0.000915 0.002403 0.004127 +18411 1 0.000210 1560.000000 -0.000622 0.003116 0.004951 +18412 1 0.000263 1560.000000 -0.003536 0.000841 0.001863 +18413 1 0.000211 1560.000000 0.002188 0.002288 0.007607 +18414 1 0.000237 1560.000000 0.002499 -0.000331 0.001020 +18415 1 0.000195 1560.000000 0.001833 -0.003002 0.001538 +18416 1 0.000232 1560.000000 -0.002525 0.001415 0.009810 +18417 1 0.000196 1560.000000 -0.000890 0.001264 0.003745 +18418 1 0.000213 1560.000000 0.001368 -0.001037 0.009390 +18419 1 0.000220 1560.000000 -0.003420 0.000057 0.006091 +18420 1 0.000217 1560.000000 -0.002462 -0.001545 0.000291 +18421 1 0.000203 1560.000000 -0.001752 -0.002937 0.005653 +18422 1 0.000259 1560.000000 0.001628 -0.000989 0.007368 +18423 1 0.000272 1560.000000 0.002038 -0.001548 0.003885 +18424 1 0.000275 1560.000000 -0.000349 0.003121 0.000531 +18425 1 0.000274 1560.000000 -0.001012 0.003129 0.003799 +18426 1 0.000199 1560.000000 -0.000325 -0.001619 0.008019 +18427 1 0.000209 1560.000000 -0.000692 0.000120 0.000589 +18428 1 0.000286 1560.000000 -0.003352 -0.001768 0.007989 +18429 1 0.000240 1560.000000 0.002028 -0.002920 0.000243 +18430 1 0.000246 1560.000000 -0.000134 -0.001754 0.003103 +18431 1 0.000196 1560.000000 0.000332 0.001129 0.001987 +18432 1 0.000235 1560.000000 0.001796 0.000166 0.002279 +18433 1 0.000247 1560.000000 0.001347 0.002236 0.006837 +18434 1 0.000214 1560.000000 -0.000800 -0.001673 0.005631 +18435 1 0.000278 1560.000000 -0.002209 -0.001192 0.009749 +18436 1 0.000238 1560.000000 -0.000495 0.001756 0.006903 +18437 1 0.000229 1560.000000 0.000735 0.003772 0.007124 +18438 1 0.000278 1560.000000 0.001487 -0.002285 0.005828 +18439 1 0.000228 1560.000000 0.003076 0.001674 0.007343 +18440 1 0.000240 1560.000000 0.000893 0.002818 0.009821 +18441 1 0.000287 1560.000000 -0.002643 -0.002709 0.001099 +18442 1 0.000282 1560.000000 0.000454 0.002829 0.004404 +18443 1 0.000251 1560.000000 0.001063 -0.001803 0.001475 +18444 1 0.000218 1560.000000 -0.001386 -0.003485 0.001801 +18445 1 0.000218 1560.000000 0.001525 -0.000969 0.002309 +18446 1 0.000217 1560.000000 -0.000658 0.002211 0.000780 +18447 1 0.000212 1560.000000 0.002687 0.002650 0.003297 +18448 1 0.000280 1560.000000 -0.001715 0.002392 0.001204 +18449 1 0.000211 1560.000000 0.002346 0.001574 0.008419 +18450 1 0.000284 1560.000000 0.000999 0.003712 0.005534 +18451 1 0.000235 1560.000000 -0.003161 -0.001124 0.008663 +18452 1 0.000256 1560.000000 -0.001594 -0.000132 0.000145 +18453 1 0.000201 1560.000000 -0.001695 -0.003381 0.006334 +18454 1 0.000251 1560.000000 0.001236 -0.000114 0.005250 +18455 1 0.000221 1560.000000 -0.000235 -0.002134 0.001650 +18456 1 0.000273 1560.000000 -0.001903 0.003221 0.008288 +18457 1 0.000275 1560.000000 0.001000 -0.003277 0.001094 +18458 1 0.000226 1560.000000 0.002055 -0.000471 0.004026 +18459 1 0.000227 1560.000000 0.000408 -0.003831 0.008686 +18460 1 0.000222 1560.000000 -0.001171 0.003183 0.005948 +18461 1 0.000194 1560.000000 0.000546 0.001154 0.003344 +18462 1 0.000217 1560.000000 -0.000403 -0.002984 0.002329 +18463 1 0.000266 1560.000000 -0.000798 -0.000516 0.009088 +18464 1 0.000196 1560.000000 0.000687 0.000996 0.009267 +18465 1 0.000193 1560.000000 -0.003176 0.001301 0.004953 +18466 1 0.000239 1560.000000 -0.003575 0.001398 0.004014 +18467 1 0.000200 1560.000000 0.003237 -0.000298 0.004720 +18468 1 0.000220 1560.000000 -0.001073 0.003266 0.006940 +18469 1 0.000243 1560.000000 -0.000364 -0.001678 0.008813 +18470 1 0.000249 1560.000000 -0.002395 -0.001544 0.000822 +18471 1 0.000203 1560.000000 0.000364 -0.003428 0.000437 +18472 1 0.000236 1560.000000 0.000601 0.002251 0.003538 +18473 1 0.000265 1560.000000 -0.001645 -0.000907 0.001892 +18474 1 0.000240 1560.000000 -0.003379 -0.000968 0.005651 +18475 1 0.000269 1560.000000 0.002112 -0.002410 0.004129 +18476 1 0.000192 1560.000000 -0.000931 -0.001540 0.009270 +18477 1 0.000230 1560.000000 -0.002126 -0.003197 0.007271 +18478 1 0.000239 1560.000000 0.003307 -0.001131 0.006511 +18479 1 0.000261 1560.000000 0.000802 0.003336 0.000938 +18480 1 0.000229 1560.000000 -0.002686 0.000062 0.008248 +18481 1 0.000203 1560.000000 0.001690 -0.000434 0.006476 +18482 1 0.000260 1560.000000 -0.002704 0.002291 0.009017 +18483 1 0.000220 1560.000000 -0.000707 -0.001851 0.000535 +18484 1 0.000210 1560.000000 0.003055 -0.000367 0.003265 +18485 1 0.000273 1560.000000 0.001053 0.003145 0.006462 +18486 1 0.000284 1560.000000 -0.003616 -0.001233 0.005933 +18487 1 0.000203 1560.000000 -0.001837 -0.002453 0.000827 +18488 1 0.000266 1560.000000 0.002671 -0.002185 0.006026 +18489 1 0.000255 1560.000000 0.003124 -0.000151 0.002329 +18490 1 0.000257 1560.000000 0.000806 0.003467 0.003983 +18491 1 0.000277 1560.000000 -0.001886 -0.003346 0.005260 +18492 1 0.000286 1560.000000 -0.002197 -0.003115 0.003060 +18493 1 0.000255 1560.000000 0.001024 -0.001571 0.004647 +18494 1 0.000216 1560.000000 -0.000842 -0.002343 0.006957 +18495 1 0.000258 1560.000000 0.001380 0.003155 0.009139 +18496 1 0.000283 1560.000000 0.003541 0.000242 0.008221 +18497 1 0.000205 1560.000000 0.003369 0.001363 0.000758 +18498 1 0.000267 1560.000000 -0.002015 -0.000238 0.009150 +18499 1 0.000282 1560.000000 -0.003271 -0.001899 0.001764 +18500 1 0.000210 1560.000000 -0.000602 0.001717 0.005134 +18501 1 0.000226 1560.000000 0.001961 0.003212 0.008456 +18502 1 0.000198 1560.000000 0.001586 -0.003470 0.009326 +18503 1 0.000240 1560.000000 0.000927 -0.002290 0.008087 +18504 1 0.000219 1560.000000 0.003257 -0.001592 0.008755 +18505 1 0.000221 1560.000000 -0.001551 -0.003523 0.009685 +18506 1 0.000280 1560.000000 0.000883 -0.000257 0.009801 +18507 1 0.000276 1560.000000 -0.002971 -0.001511 0.001769 +18508 1 0.000200 1560.000000 -0.000977 -0.002646 0.000835 +18509 1 0.000263 1560.000000 0.003479 0.001405 0.004334 +18510 1 0.000266 1560.000000 -0.002210 -0.001486 0.006720 +18511 1 0.000282 1560.000000 0.001989 -0.000024 0.003914 +18512 1 0.000210 1560.000000 -0.001316 0.002211 0.005050 +18513 1 0.000206 1560.000000 -0.001285 0.001602 0.007915 +18514 1 0.000226 1560.000000 -0.002279 -0.001201 0.003169 +18515 1 0.000280 1560.000000 -0.002891 0.001895 0.004517 +18516 1 0.000197 1560.000000 -0.001690 0.001457 0.002246 +18517 1 0.000256 1560.000000 -0.001407 0.000062 0.005267 +18518 1 0.000231 1560.000000 0.001544 -0.002995 0.004249 +18519 1 0.000227 1560.000000 -0.001115 -0.001180 0.001711 +18520 1 0.000247 1560.000000 -0.002157 -0.001640 0.009266 +18521 1 0.000210 1560.000000 0.003492 -0.001617 0.006087 +18522 1 0.000225 1560.000000 -0.002900 0.002295 0.002151 +18523 1 0.000257 1560.000000 0.003649 -0.001236 0.001896 +18524 1 0.000202 1560.000000 0.000437 -0.002797 0.004167 +18525 1 0.000216 1560.000000 0.000209 -0.003790 0.005253 +18526 1 0.000216 1560.000000 -0.000128 0.002695 0.004180 +18527 1 0.000219 1560.000000 -0.001487 0.000585 0.005195 +18528 1 0.000196 1560.000000 0.002760 0.001622 0.003159 +18529 1 0.000222 1560.000000 -0.001379 0.002735 0.005524 +18530 1 0.000204 1560.000000 0.000168 -0.002734 0.007136 +18531 1 0.000209 1560.000000 -0.000564 0.001642 0.007699 +18532 1 0.000224 1560.000000 -0.001234 -0.002571 0.004346 +18533 1 0.000223 1560.000000 0.000857 -0.002776 0.007195 +18534 1 0.000194 1560.000000 0.002645 0.000788 0.003732 +18535 1 0.000219 1560.000000 -0.003653 0.000842 0.004959 +18536 1 0.000269 1560.000000 -0.000613 -0.003800 0.003868 +18537 1 0.000208 1560.000000 -0.000654 -0.001917 0.009365 +18538 1 0.000195 1560.000000 0.002610 0.000491 0.009348 +18539 1 0.000213 1560.000000 0.001289 -0.000986 0.006332 +18540 1 0.000258 1560.000000 0.002546 0.001124 0.001195 +18541 1 0.000226 1560.000000 -0.003210 0.000567 0.008496 +18542 1 0.000274 1560.000000 0.003416 0.001430 0.001254 +18543 1 0.000219 1560.000000 -0.001093 -0.000941 0.003586 +18544 1 0.000251 1560.000000 0.001633 0.002349 0.009201 +18545 1 0.000272 1560.000000 0.001098 0.003031 0.003040 +18546 1 0.000195 1560.000000 0.000070 -0.000691 0.009552 +18547 1 0.000204 1560.000000 -0.001659 -0.001267 0.008218 +18548 1 0.000244 1560.000000 -0.003022 -0.001144 0.000156 +18549 1 0.000199 1560.000000 0.001636 -0.001792 0.004804 +18550 1 0.000255 1560.000000 -0.001568 0.000697 0.008163 +18551 1 0.000222 1560.000000 0.000970 -0.000829 0.005353 +18552 1 0.000242 1560.000000 -0.003778 -0.000686 0.006759 +18553 1 0.000215 1560.000000 0.001778 -0.000101 0.008248 +18554 1 0.000231 1560.000000 -0.002554 -0.002128 0.008453 +18555 1 0.000227 1560.000000 0.001711 -0.002415 0.007446 +18556 1 0.000272 1560.000000 -0.002000 0.001022 0.002541 +18557 1 0.000228 1560.000000 0.002587 -0.001904 0.000678 +18558 1 0.000214 1560.000000 0.003087 0.000010 0.005656 +18559 1 0.000242 1560.000000 -0.003124 -0.001721 0.002745 +18560 1 0.000261 1560.000000 -0.002493 -0.000422 0.003646 +18561 1 0.000280 1560.000000 0.002825 -0.000744 0.005849 +18562 1 0.000202 1560.000000 -0.000204 -0.002618 0.002277 +18563 1 0.000224 1560.000000 -0.002420 -0.002339 0.002441 +18564 1 0.000242 1560.000000 0.002824 0.001270 0.009503 +18565 1 0.000217 1560.000000 0.001310 0.000035 0.000577 +18566 1 0.000213 1560.000000 -0.001346 0.000682 0.003925 +18567 1 0.000276 1560.000000 0.003810 0.000370 0.005043 +18568 1 0.000218 1560.000000 0.002603 0.002837 0.004855 +18569 1 0.000213 1560.000000 -0.002103 -0.002116 0.001745 +18570 1 0.000224 1560.000000 0.001055 0.000139 0.005858 +18571 1 0.000251 1560.000000 -0.002577 0.000803 0.000859 +18572 1 0.000204 1560.000000 -0.003153 0.000188 0.000145 +18573 1 0.000211 1560.000000 0.000925 0.001382 0.008092 +18574 1 0.000226 1560.000000 0.002144 -0.002666 0.004104 +18575 1 0.000231 1560.000000 0.001531 0.000013 0.008958 +18576 1 0.000265 1560.000000 0.002940 -0.001584 0.009746 +18577 1 0.000229 1560.000000 -0.001966 -0.002482 0.004706 +18578 1 0.000209 1560.000000 0.003245 -0.002052 0.008476 +18579 1 0.000251 1560.000000 0.003091 0.002289 0.005296 +18580 1 0.000218 1560.000000 0.003610 0.001247 0.002622 +18581 1 0.000209 1560.000000 0.000221 -0.000971 0.006161 +18582 1 0.000243 1560.000000 -0.001022 -0.002358 0.001160 +18583 1 0.000267 1560.000000 0.000734 0.003616 0.002516 +18584 1 0.000231 1560.000000 -0.002171 0.002066 0.009679 +18585 1 0.000240 1560.000000 -0.001087 -0.000196 0.008037 +18586 1 0.000208 1560.000000 0.000615 -0.000612 0.007740 +18587 1 0.000259 1560.000000 0.001937 -0.000287 0.005784 +18588 1 0.000276 1560.000000 0.003330 0.001821 0.007254 +18589 1 0.000244 1560.000000 -0.000330 0.001577 0.000429 +18590 1 0.000202 1560.000000 0.001810 -0.000761 0.001154 +18591 1 0.000201 1560.000000 0.003094 -0.001053 0.001772 +18592 1 0.000277 1560.000000 -0.001002 -0.001707 0.006914 +18593 1 0.000197 1560.000000 0.000449 -0.002695 0.003521 +18594 1 0.000198 1560.000000 0.002298 -0.000069 0.004086 +18595 1 0.000275 1560.000000 -0.003475 -0.001532 0.000213 +18596 1 0.000212 1560.000000 0.002527 0.000792 0.006288 +18597 1 0.000260 1560.000000 0.001707 -0.003455 0.008496 +18598 1 0.000210 1560.000000 -0.000620 -0.002304 0.000911 +18599 1 0.000254 1560.000000 -0.002504 -0.001094 0.000857 +18600 1 0.000194 1560.000000 -0.001023 -0.003256 0.002190 +18601 1 0.000220 1560.000000 -0.001631 0.002001 0.009811 +18602 1 0.000194 1560.000000 0.003722 -0.000834 0.002755 +18603 1 0.000283 1560.000000 0.002279 -0.001219 0.007401 +18604 1 0.000262 1560.000000 -0.000793 0.002090 0.006025 +18605 1 0.000214 1560.000000 0.001213 -0.001299 0.000136 +18606 1 0.000209 1560.000000 -0.000808 0.000569 0.002338 +18607 1 0.000239 1560.000000 0.003726 -0.000648 0.005763 +18608 1 0.000246 1560.000000 0.001502 0.001772 0.007866 +18609 1 0.000240 1560.000000 -0.000187 0.001288 0.000420 +18610 1 0.000230 1560.000000 -0.000608 -0.002695 0.006502 +18611 1 0.000200 1560.000000 0.002598 -0.002795 0.002248 +18612 1 0.000226 1560.000000 -0.000456 0.002648 0.001608 +18613 1 0.000253 1560.000000 -0.002700 0.002675 0.002226 +18614 1 0.000224 1560.000000 -0.002071 -0.002506 0.007003 +18615 1 0.000260 1560.000000 0.002954 0.001265 0.005611 +18616 1 0.000194 1560.000000 -0.000165 -0.000960 0.008716 +18617 1 0.000251 1560.000000 0.002025 -0.000635 0.006074 +18618 1 0.000270 1560.000000 -0.000810 0.001861 0.005057 +18619 1 0.000268 1560.000000 -0.000611 -0.001115 0.008486 +18620 1 0.000216 1560.000000 0.002435 -0.001585 0.002137 +18621 1 0.000208 1560.000000 0.000767 -0.001063 0.009801 +18622 1 0.000246 1560.000000 0.003499 -0.001436 0.003572 +18623 1 0.000199 1560.000000 0.001844 0.002333 0.008456 +18624 1 0.000273 1560.000000 0.002531 0.002796 0.000868 +18625 1 0.000200 1560.000000 -0.001301 -0.000062 0.000482 +18626 1 0.000232 1560.000000 0.000620 -0.002791 0.005584 +18627 1 0.000203 1560.000000 -0.001934 0.001950 0.005434 +18628 1 0.000270 1560.000000 -0.001149 -0.000575 0.006910 +18629 1 0.000221 1560.000000 -0.001672 -0.003457 0.000362 +18630 1 0.000259 1560.000000 0.002056 0.002770 0.001699 +18631 1 0.000246 1560.000000 -0.003577 0.000260 0.003883 +18632 1 0.000193 1560.000000 -0.003181 0.000001 0.002917 +18633 1 0.000284 1560.000000 -0.001161 0.001872 0.006687 +18634 1 0.000216 1560.000000 -0.003269 0.002034 0.004645 +18635 1 0.000198 1560.000000 -0.002413 0.002876 0.002714 +18636 1 0.000209 1560.000000 0.000464 -0.003143 0.006927 +18637 1 0.000264 1560.000000 -0.002032 -0.002461 0.001859 +18638 1 0.000196 1560.000000 -0.000355 -0.001825 0.008255 +18639 1 0.000199 1560.000000 0.000310 0.000095 0.009140 +18640 1 0.000199 1560.000000 -0.001765 0.002125 0.007803 +18641 1 0.000210 1560.000000 -0.000916 -0.002954 0.004856 +18642 1 0.000227 1560.000000 -0.001644 -0.000238 0.007017 +18643 1 0.000207 1560.000000 0.001580 -0.000306 0.009386 +18644 1 0.000221 1560.000000 -0.000936 -0.003365 0.007043 +18645 1 0.000198 1560.000000 -0.002644 -0.001331 0.000500 +18646 1 0.000237 1560.000000 -0.002443 -0.002231 0.001848 +18647 1 0.000205 1560.000000 0.000480 -0.000313 0.002050 +18648 1 0.000265 1560.000000 -0.002846 -0.002476 0.004916 +18649 1 0.000200 1560.000000 0.003069 0.000090 0.003000 +18650 1 0.000269 1560.000000 0.000798 0.002820 0.002711 +18651 1 0.000227 1560.000000 0.001075 0.002771 0.007237 +18652 1 0.000199 1560.000000 0.002063 -0.001270 0.005430 +18653 1 0.000258 1560.000000 -0.002028 -0.000876 0.008210 +18654 1 0.000243 1560.000000 0.001451 0.000931 0.006491 +18655 1 0.000210 1560.000000 -0.000599 -0.003405 0.003793 +18656 1 0.000192 1560.000000 -0.002766 0.002053 0.005690 +18657 1 0.000231 1560.000000 -0.000106 0.000632 0.006466 +18658 1 0.000196 1560.000000 -0.000251 -0.002691 0.001676 +18659 1 0.000195 1560.000000 -0.002134 0.001578 0.005228 +18660 1 0.000263 1560.000000 -0.001977 -0.001839 0.006740 +18661 1 0.000202 1560.000000 -0.000934 -0.000341 0.006398 +18662 1 0.000241 1560.000000 -0.001521 -0.002024 0.008996 +18663 1 0.000218 1560.000000 -0.001477 -0.001481 0.008211 +18664 1 0.000234 1560.000000 -0.000043 -0.001355 0.008584 +18665 1 0.000202 1560.000000 0.000391 -0.000491 0.002180 +18666 1 0.000285 1560.000000 -0.002551 0.002796 0.005836 +18667 1 0.000223 1560.000000 -0.002519 -0.001966 0.004213 +18668 1 0.000249 1560.000000 -0.001809 0.002693 0.000454 +18669 1 0.000207 1560.000000 0.000908 0.003561 0.009475 +18670 1 0.000219 1560.000000 0.001289 -0.003208 0.003134 +18671 1 0.000281 1560.000000 0.000818 -0.003701 0.007473 +18672 1 0.000214 1560.000000 -0.001656 0.000368 0.008153 +18673 1 0.000237 1560.000000 -0.002892 -0.001361 0.005402 +18674 1 0.000241 1560.000000 -0.001894 0.000678 0.000467 +18675 1 0.000213 1560.000000 0.002442 0.001957 0.000719 +18676 1 0.000199 1560.000000 0.003278 -0.001406 0.005193 +18677 1 0.000231 1560.000000 -0.000161 0.001655 0.008272 +18678 1 0.000240 1560.000000 -0.001266 -0.003299 0.004734 +18679 1 0.000256 1560.000000 0.003083 0.002190 0.008677 +18680 1 0.000208 1560.000000 0.001858 -0.001259 0.005665 +18681 1 0.000216 1560.000000 0.003347 -0.000455 0.006969 +18682 1 0.000216 1560.000000 -0.002229 0.000449 0.008228 +18683 1 0.000217 1560.000000 0.003337 0.000510 0.002347 +18684 1 0.000277 1560.000000 -0.001113 -0.001084 0.004555 +18685 1 0.000252 1560.000000 0.000512 0.001781 0.000212 +18686 1 0.000249 1560.000000 0.002156 0.003164 0.004417 +18687 1 0.000208 1560.000000 0.001869 -0.002441 0.003158 +18688 1 0.000247 1560.000000 0.001474 0.002453 0.003468 +18689 1 0.000237 1560.000000 -0.002445 0.001837 0.007983 +18690 1 0.000217 1560.000000 -0.002985 0.000256 0.004152 +18691 1 0.000213 1560.000000 -0.002236 -0.001479 0.002612 +18692 1 0.000251 1560.000000 -0.003330 0.001727 0.007423 +18693 1 0.000269 1560.000000 0.001291 0.001885 0.008129 +18694 1 0.000200 1560.000000 0.003375 0.000760 0.006293 +18695 1 0.000264 1560.000000 -0.000463 -0.002826 0.003659 +18696 1 0.000241 1560.000000 0.000228 0.001197 0.000317 +18697 1 0.000236 1560.000000 -0.000822 -0.003067 0.007913 +18698 1 0.000261 1560.000000 -0.002061 0.002430 0.008020 +18699 1 0.000263 1560.000000 -0.003383 -0.001131 0.001881 +18700 1 0.000241 1560.000000 -0.000541 -0.001320 0.007148 +18701 1 0.000213 1560.000000 -0.002930 -0.000295 0.008052 +18702 1 0.000232 1560.000000 -0.002909 -0.002507 0.002989 +18703 1 0.000261 1560.000000 0.003707 0.000754 0.008291 +18704 1 0.000204 1560.000000 0.003407 -0.001733 0.001801 +18705 1 0.000264 1560.000000 0.003359 -0.000568 0.009110 +18706 1 0.000216 1560.000000 -0.003300 -0.000712 0.001541 +18707 1 0.000273 1560.000000 -0.001955 0.001000 0.008538 +18708 1 0.000252 1560.000000 -0.001941 -0.002861 0.001726 +18709 1 0.000243 1560.000000 0.000825 0.000841 0.006120 +18710 1 0.000225 1560.000000 -0.003673 0.000993 0.005545 +18711 1 0.000226 1560.000000 0.001463 -0.000905 0.008455 +18712 1 0.000243 1560.000000 0.000788 0.001258 0.005253 +18713 1 0.000223 1560.000000 -0.002309 -0.000989 0.008477 +18714 1 0.000210 1560.000000 -0.003397 -0.000239 0.004265 +18715 1 0.000221 1560.000000 -0.000498 0.001479 0.003728 +18716 1 0.000215 1560.000000 0.003558 -0.000946 0.003913 +18717 1 0.000216 1560.000000 0.001391 0.000092 0.009116 +18718 1 0.000200 1560.000000 -0.003786 0.000425 0.006706 +18719 1 0.000259 1560.000000 -0.001481 0.001687 0.008633 +18720 1 0.000282 1560.000000 0.002953 -0.002326 0.005055 +18721 1 0.000233 1560.000000 -0.002126 0.002466 0.002809 +18722 1 0.000234 1560.000000 0.001216 -0.001943 0.007353 +18723 1 0.000200 1560.000000 -0.000177 0.000287 0.005696 +18724 1 0.000207 1560.000000 0.000225 -0.003819 0.007018 +18725 1 0.000263 1560.000000 -0.001172 -0.001453 0.002821 +18726 1 0.000237 1560.000000 -0.000559 0.003155 0.006913 +18727 1 0.000255 1560.000000 -0.002785 -0.002139 0.004823 +18728 1 0.000271 1560.000000 0.002108 -0.001497 0.009783 +18729 1 0.000205 1560.000000 -0.003156 0.000357 0.003982 +18730 1 0.000193 1560.000000 0.000260 -0.000638 0.001307 +18731 1 0.000200 1560.000000 -0.000605 -0.002381 0.002714 +18732 1 0.000198 1560.000000 -0.002893 -0.001035 0.004229 +18733 1 0.000225 1560.000000 -0.000506 -0.000531 0.005904 +18734 1 0.000223 1560.000000 0.001490 0.001147 0.008697 +18735 1 0.000251 1560.000000 0.001362 0.002618 0.003146 +18736 1 0.000256 1560.000000 -0.002316 0.001273 0.000138 +18737 1 0.000263 1560.000000 -0.002025 0.000076 0.000160 +18738 1 0.000278 1560.000000 -0.001061 0.002328 0.008813 +18739 1 0.000240 1560.000000 0.002265 0.002814 0.006369 +18740 1 0.000222 1560.000000 0.003212 -0.000093 0.005242 +18741 1 0.000261 1560.000000 0.003460 0.001672 0.008356 +18742 1 0.000217 1560.000000 0.002348 -0.001606 0.004235 +18743 1 0.000194 1560.000000 0.002294 -0.000177 0.004251 +18744 1 0.000260 1560.000000 -0.000216 -0.002030 0.004811 +18745 1 0.000212 1560.000000 -0.000699 0.001448 0.001174 +18746 1 0.000208 1560.000000 0.002579 0.001477 0.002327 +18747 1 0.000198 1560.000000 -0.003577 -0.000812 0.000875 +18748 1 0.000240 1560.000000 -0.001075 -0.001671 0.008309 +18749 1 0.000208 1560.000000 -0.001249 0.002865 0.002811 +18750 1 0.000237 1560.000000 0.001257 0.003219 0.006299 +18751 1 0.000229 1560.000000 0.001381 -0.000405 0.003594 +18752 1 0.000203 1560.000000 -0.003155 0.000959 0.000622 +18753 1 0.000223 1560.000000 0.002684 0.001137 0.005536 +18754 1 0.000213 1560.000000 0.001773 -0.000647 0.004311 +18755 1 0.000212 1560.000000 0.001283 -0.000287 0.002258 +18756 1 0.000259 1560.000000 -0.002257 0.000178 0.007846 +18757 1 0.000218 1560.000000 -0.001572 -0.001098 0.004842 +18758 1 0.000249 1560.000000 0.001893 0.000715 0.009047 +18759 1 0.000280 1560.000000 0.003425 -0.001704 0.009810 +18760 1 0.000218 1560.000000 0.000634 0.000417 0.005577 +18761 1 0.000203 1560.000000 0.000672 -0.000011 0.000513 +18762 1 0.000195 1560.000000 -0.001330 -0.001538 0.008421 +18763 1 0.000210 1560.000000 0.002398 -0.000824 0.009037 +18764 1 0.000241 1560.000000 -0.000965 0.000005 0.001823 +18765 1 0.000227 1560.000000 -0.000144 -0.002966 0.003001 +18766 1 0.000285 1560.000000 -0.003590 0.000522 0.003586 +18767 1 0.000201 1560.000000 -0.000228 0.002351 0.008843 +18768 1 0.000248 1560.000000 -0.000529 0.003329 0.007715 +18769 1 0.000287 1560.000000 -0.001584 -0.001681 0.000729 +18770 1 0.000206 1560.000000 -0.002406 -0.001607 0.009485 +18771 1 0.000225 1560.000000 0.001222 -0.002116 0.009344 +18772 1 0.000230 1560.000000 0.001865 -0.002736 0.005143 +18773 1 0.000257 1560.000000 -0.003826 0.000472 0.000137 +18774 1 0.000229 1560.000000 -0.001617 0.002287 0.008501 +18775 1 0.000235 1560.000000 -0.001796 -0.002449 0.005297 +18776 1 0.000203 1560.000000 -0.001719 -0.001204 0.008772 +18777 1 0.000207 1560.000000 -0.000718 0.001924 0.000676 +18778 1 0.000282 1560.000000 -0.000402 -0.003532 0.000967 +18779 1 0.000230 1560.000000 0.001147 -0.002036 0.003445 +18780 1 0.000249 1560.000000 -0.000698 0.002002 0.002083 +18781 1 0.000264 1560.000000 -0.003126 -0.001565 0.004392 +18782 1 0.000287 1560.000000 -0.000613 0.003358 0.009844 +18783 1 0.000208 1560.000000 0.001434 -0.003033 0.007834 +18784 1 0.000193 1560.000000 0.001140 0.000206 0.009197 +18785 1 0.000256 1560.000000 0.001270 -0.000822 0.006842 +18786 1 0.000269 1560.000000 0.002658 -0.002167 0.006494 +18787 1 0.000231 1560.000000 -0.002208 0.002315 0.004893 +18788 1 0.000227 1560.000000 -0.001498 -0.002669 0.009298 +18789 1 0.000249 1560.000000 0.002631 -0.000456 0.001831 +18790 1 0.000254 1560.000000 -0.000684 -0.000988 0.001438 +18791 1 0.000260 1560.000000 -0.000317 -0.003406 0.004591 +18792 1 0.000210 1560.000000 0.001002 -0.000757 0.003450 +18793 1 0.000285 1560.000000 0.000640 0.001987 0.004845 +18794 1 0.000196 1560.000000 -0.003573 0.000586 0.006007 +18795 1 0.000279 1560.000000 -0.001911 -0.002662 0.003741 +18796 1 0.000279 1560.000000 0.000533 -0.003790 0.007925 +18797 1 0.000203 1560.000000 0.001844 0.001586 0.008624 +18798 1 0.000228 1560.000000 0.001583 -0.002018 0.006984 +18799 1 0.000230 1560.000000 -0.003716 -0.000988 0.003923 +18800 1 0.000245 1560.000000 -0.000542 0.002106 0.004541 +18801 1 0.000210 1560.000000 -0.003522 0.001540 0.007475 +18802 1 0.000195 1560.000000 0.000192 -0.000108 0.000922 +18803 1 0.000273 1560.000000 0.001336 -0.001191 0.001227 +18804 1 0.000246 1560.000000 -0.001812 -0.000285 0.007242 +18805 1 0.000198 1560.000000 -0.001891 0.000684 0.005334 +18806 1 0.000195 1560.000000 0.000295 -0.000869 0.001299 +18807 1 0.000262 1560.000000 -0.002595 0.001386 0.001781 +18808 1 0.000250 1560.000000 0.000050 -0.000795 0.009782 +18809 1 0.000220 1560.000000 -0.001002 0.000350 0.005287 +18810 1 0.000197 1560.000000 -0.002421 -0.002944 0.000815 +18811 1 0.000211 1560.000000 -0.000457 0.002077 0.005376 +18812 1 0.000224 1560.000000 -0.002058 0.002042 0.004488 +18813 1 0.000288 1560.000000 -0.003324 -0.001277 0.008129 +18814 1 0.000193 1560.000000 0.001228 0.001717 0.001599 +18815 1 0.000215 1560.000000 -0.002029 -0.000913 0.006755 +18816 1 0.000267 1560.000000 -0.001364 0.001364 0.004138 +18817 1 0.000247 1560.000000 -0.000017 0.002656 0.009369 +18818 1 0.000241 1560.000000 -0.002878 -0.002179 0.005737 +18819 1 0.000225 1560.000000 -0.002594 0.000793 0.003954 +18820 1 0.000247 1560.000000 -0.002188 -0.000114 0.007930 +18821 1 0.000244 1560.000000 -0.002586 0.000521 0.001826 +18822 1 0.000234 1560.000000 0.001225 0.001599 0.009802 +18823 1 0.000252 1560.000000 -0.001959 0.000847 0.003642 +18824 1 0.000257 1560.000000 -0.003635 0.001224 0.009155 +18825 1 0.000272 1560.000000 -0.000225 -0.002804 0.000138 +18826 1 0.000205 1560.000000 0.002665 0.002762 0.007656 +18827 1 0.000228 1560.000000 0.000496 -0.003621 0.001930 +18828 1 0.000234 1560.000000 -0.000987 0.003217 0.000160 +18829 1 0.000243 1560.000000 -0.000771 -0.003762 0.006171 +18830 1 0.000271 1560.000000 0.003222 0.000389 0.002131 +18831 1 0.000236 1560.000000 0.000553 0.003533 0.005183 +18832 1 0.000246 1560.000000 0.000544 0.001286 0.003085 +18833 1 0.000260 1560.000000 0.002548 -0.000008 0.000584 +18834 1 0.000200 1560.000000 -0.003839 -0.000048 0.002535 +18835 1 0.000278 1560.000000 0.001320 0.003208 0.003454 +18836 1 0.000229 1560.000000 -0.001256 0.003615 0.001688 +18837 1 0.000199 1560.000000 0.002225 0.002459 0.006935 +18838 1 0.000241 1560.000000 0.001869 -0.000751 0.009293 +18839 1 0.000213 1560.000000 -0.003396 0.000103 0.004478 +18840 1 0.000203 1560.000000 -0.000387 0.003185 0.009560 +18841 1 0.000217 1560.000000 0.001367 -0.001789 0.003090 +18842 1 0.000220 1560.000000 0.002946 -0.000726 0.003571 +18843 1 0.000262 1560.000000 -0.000426 -0.001774 0.004254 +18844 1 0.000250 1560.000000 0.001175 -0.000622 0.000729 +18845 1 0.000223 1560.000000 0.002489 0.001391 0.008087 +18846 1 0.000231 1560.000000 -0.002852 -0.001155 0.008617 +18847 1 0.000242 1560.000000 0.000614 0.002607 0.000990 +18848 1 0.000271 1560.000000 -0.000712 0.003777 0.006926 +18849 1 0.000283 1560.000000 0.001213 0.003305 0.008825 +18850 1 0.000232 1560.000000 0.002253 0.002977 0.006816 +18851 1 0.000233 1560.000000 -0.001611 -0.002345 0.005719 +18852 1 0.000243 1560.000000 -0.001504 -0.000247 0.004934 +18853 1 0.000210 1560.000000 -0.001662 -0.000680 0.003372 +18854 1 0.000266 1560.000000 0.001204 -0.002878 0.009817 +18855 1 0.000205 1560.000000 -0.000958 0.003305 0.000788 +18856 1 0.000230 1560.000000 -0.003211 -0.001098 0.007098 +18857 1 0.000284 1560.000000 0.001755 0.000012 0.009470 +18858 1 0.000245 1560.000000 0.000864 -0.002824 0.001189 +18859 1 0.000245 1560.000000 0.002193 0.002037 0.009486 +18860 1 0.000228 1560.000000 0.002580 0.000563 0.005357 +18861 1 0.000259 1560.000000 0.002906 -0.000502 0.000751 +18862 1 0.000257 1560.000000 -0.000868 -0.001038 0.007400 +18863 1 0.000195 1560.000000 -0.001299 0.002817 0.006416 +18864 1 0.000193 1560.000000 -0.001748 0.000243 0.008003 +18865 1 0.000263 1560.000000 0.001385 -0.000161 0.005725 +18866 1 0.000246 1560.000000 -0.002338 -0.001012 0.003888 +18867 1 0.000246 1560.000000 0.002362 0.000945 0.008613 +18868 1 0.000205 1560.000000 -0.002707 0.000550 0.004800 +18869 1 0.000270 1560.000000 -0.001102 0.001341 0.008493 +18870 1 0.000226 1560.000000 -0.002331 -0.002925 0.003956 +18871 1 0.000221 1560.000000 0.002003 0.001099 0.005616 +18872 1 0.000198 1560.000000 -0.001559 -0.001803 0.003625 +18873 1 0.000275 1560.000000 -0.002628 -0.002329 0.002913 +18874 1 0.000245 1560.000000 -0.001186 0.002461 0.001574 +18875 1 0.000231 1560.000000 0.002271 0.000164 0.008796 +18876 1 0.000287 1560.000000 -0.002520 -0.001331 0.006428 +18877 1 0.000247 1560.000000 0.002463 0.000937 0.008153 +18878 1 0.000252 1560.000000 -0.003402 0.000547 0.009398 +18879 1 0.000244 1560.000000 0.000330 0.001799 0.008177 +18880 1 0.000193 1560.000000 0.003090 0.001041 0.001553 +18881 1 0.000202 1560.000000 0.003280 0.001032 0.002301 +18882 1 0.000196 1560.000000 -0.000814 -0.001790 0.004863 +18883 1 0.000205 1560.000000 0.002806 0.001753 0.009030 +18884 1 0.000203 1560.000000 0.000247 0.002269 0.002084 +18885 1 0.000198 1560.000000 0.000137 0.002677 0.000544 +18886 1 0.000258 1560.000000 0.003482 0.000079 0.006148 +18887 1 0.000239 1560.000000 -0.002098 0.001249 0.004279 +18888 1 0.000206 1560.000000 -0.002334 0.000625 0.002382 +18889 1 0.000201 1560.000000 -0.000465 0.000927 0.009126 +18890 1 0.000275 1560.000000 0.002449 0.000506 0.009571 +18891 1 0.000218 1560.000000 0.001090 0.000353 0.001933 +18892 1 0.000223 1560.000000 -0.000652 0.002541 0.002247 +18893 1 0.000208 1560.000000 -0.001813 -0.002540 0.002198 +18894 1 0.000263 1560.000000 -0.000995 -0.003698 0.002309 +18895 1 0.000287 1560.000000 -0.000591 0.001399 0.006291 +18896 1 0.000229 1560.000000 -0.001056 -0.003143 0.008032 +18897 1 0.000195 1560.000000 0.001393 0.002430 0.001103 +18898 1 0.000258 1560.000000 -0.001402 -0.000398 0.009264 +18899 1 0.000211 1560.000000 0.000861 0.003112 0.004217 +18900 1 0.000277 1560.000000 0.002124 -0.000387 0.001428 +18901 1 0.000269 1560.000000 -0.002086 0.000063 0.008103 +18902 1 0.000195 1560.000000 -0.001575 -0.002892 0.000826 +18903 1 0.000210 1560.000000 -0.002475 0.000043 0.004568 +18904 1 0.000194 1560.000000 0.002146 -0.000839 0.001005 +18905 1 0.000235 1560.000000 -0.003312 0.001923 0.003297 +18906 1 0.000220 1560.000000 -0.001910 -0.002722 0.001393 +18907 1 0.000208 1560.000000 -0.001048 0.001033 0.001416 +18908 1 0.000252 1560.000000 0.002414 0.000832 0.004105 +18909 1 0.000251 1560.000000 -0.003213 -0.001219 0.000474 +18910 1 0.000237 1560.000000 0.003417 -0.000710 0.002801 +18911 1 0.000280 1560.000000 0.002265 -0.003074 0.007925 +18912 1 0.000283 1560.000000 -0.000486 0.000993 0.008543 +18913 1 0.000227 1560.000000 -0.002610 -0.002028 0.001567 +18914 1 0.000283 1560.000000 -0.000105 0.002612 0.001052 +18915 1 0.000278 1560.000000 0.002424 0.001674 0.002840 +18916 1 0.000200 1560.000000 0.000620 0.003805 0.005184 +18917 1 0.000237 1560.000000 -0.000162 -0.002441 0.001632 +18918 1 0.000204 1560.000000 -0.000151 -0.001504 0.002610 +18919 1 0.000228 1560.000000 -0.003173 -0.000514 0.006626 +18920 1 0.000240 1560.000000 -0.000643 0.000495 0.007541 +18921 1 0.000210 1560.000000 0.002660 -0.002673 0.001973 +18922 1 0.000200 1560.000000 -0.002982 -0.002382 0.005435 +18923 1 0.000198 1560.000000 -0.000577 -0.000768 0.000104 +18924 1 0.000199 1560.000000 -0.003034 -0.002038 0.009336 +18925 1 0.000260 1560.000000 -0.003150 -0.001316 0.003882 +18926 1 0.000225 1560.000000 0.001145 -0.001454 0.006958 +18927 1 0.000239 1560.000000 -0.001384 -0.003492 0.006685 +18928 1 0.000252 1560.000000 -0.003225 -0.002058 0.004523 +18929 1 0.000248 1560.000000 -0.000687 -0.002104 0.003024 +18930 1 0.000231 1560.000000 0.001116 -0.001739 0.008298 +18931 1 0.000268 1560.000000 -0.003555 -0.000352 0.007130 +18932 1 0.000206 1560.000000 0.002974 0.000338 0.001435 +18933 1 0.000199 1560.000000 0.000582 0.003707 0.001041 +18934 1 0.000239 1560.000000 -0.000600 -0.003098 0.002059 +18935 1 0.000220 1560.000000 -0.000525 0.002265 0.008323 +18936 1 0.000202 1560.000000 0.001054 -0.003086 0.006716 +18937 1 0.000241 1560.000000 0.001971 -0.001975 0.005717 +18938 1 0.000238 1560.000000 0.003346 -0.000694 0.002511 +18939 1 0.000273 1560.000000 0.000828 0.003730 0.004816 +18940 1 0.000236 1560.000000 0.001867 0.002348 0.001721 +18941 1 0.000232 1560.000000 -0.001022 0.003264 0.002114 +18942 1 0.000193 1560.000000 0.001264 -0.002045 0.007855 +18943 1 0.000221 1560.000000 0.000616 0.002933 0.000716 +18944 1 0.000257 1560.000000 -0.003030 0.002384 0.001022 +18945 1 0.000235 1560.000000 0.001926 -0.002741 0.008552 +18946 1 0.000245 1560.000000 -0.001563 0.000147 0.004368 +18947 1 0.000276 1560.000000 0.002183 0.000595 0.002239 +18948 1 0.000194 1560.000000 -0.001386 -0.002655 0.000769 +18949 1 0.000204 1560.000000 -0.002265 -0.000023 0.009711 +18950 1 0.000225 1560.000000 -0.002475 0.000628 0.001304 +18951 1 0.000195 1560.000000 -0.002859 -0.002149 0.008344 +18952 1 0.000195 1560.000000 0.001664 0.003331 0.007512 +18953 1 0.000229 1560.000000 -0.000799 0.003501 0.003801 +18954 1 0.000288 1560.000000 -0.003096 0.001864 0.008927 +18955 1 0.000253 1560.000000 0.002263 -0.002772 0.008178 +18956 1 0.000221 1560.000000 0.001973 -0.001975 0.003197 +18957 1 0.000236 1560.000000 -0.000193 0.003409 0.005553 +18958 1 0.000205 1560.000000 -0.000329 0.002836 0.005513 +18959 1 0.000283 1560.000000 0.001257 -0.002671 0.001849 +18960 1 0.000258 1560.000000 -0.001107 -0.003381 0.009170 +18961 1 0.000284 1560.000000 0.000917 0.003342 0.009783 +18962 1 0.000210 1560.000000 -0.003309 -0.001492 0.009763 +18963 1 0.000194 1560.000000 0.000494 -0.002094 0.006518 +18964 1 0.000222 1560.000000 0.000949 -0.000097 0.003597 +18965 1 0.000212 1560.000000 -0.001100 -0.001083 0.005517 +18966 1 0.000210 1560.000000 -0.000671 0.001918 0.009784 +18967 1 0.000249 1560.000000 -0.002944 -0.001276 0.008426 +18968 1 0.000212 1560.000000 -0.000223 -0.002724 0.004924 +18969 1 0.000287 1560.000000 0.002805 -0.002600 0.008950 +18970 1 0.000240 1560.000000 -0.000873 0.001020 0.004869 +18971 1 0.000279 1560.000000 -0.003479 0.000106 0.007783 +18972 1 0.000282 1560.000000 0.000648 -0.001288 0.004034 +18973 1 0.000213 1560.000000 0.000120 -0.002678 0.008072 +18974 1 0.000233 1560.000000 -0.000899 0.000931 0.009403 +18975 1 0.000219 1560.000000 -0.002637 -0.000586 0.008160 +18976 1 0.000199 1560.000000 0.001661 0.003439 0.005000 +18977 1 0.000261 1560.000000 0.001808 -0.001578 0.000485 +18978 1 0.000222 1560.000000 0.001776 -0.000993 0.002921 +18979 1 0.000206 1560.000000 -0.003044 -0.002291 0.003087 +18980 1 0.000194 1560.000000 0.002332 -0.001190 0.004407 +18981 1 0.000195 1560.000000 0.002153 0.000505 0.005572 +18982 1 0.000200 1560.000000 0.003005 -0.001891 0.009807 +18983 1 0.000229 1560.000000 0.001495 0.000763 0.005647 +18984 1 0.000224 1560.000000 -0.002692 0.001020 0.007746 +18985 1 0.000227 1560.000000 -0.001075 0.003128 0.009469 +18986 1 0.000252 1560.000000 -0.000677 0.002332 0.006846 +18987 1 0.000271 1560.000000 -0.002894 -0.001398 0.009283 +18988 1 0.000247 1560.000000 -0.003252 0.001156 0.000910 +18989 1 0.000225 1560.000000 -0.001911 0.002729 0.007993 +18990 1 0.000200 1560.000000 0.001513 -0.001746 0.006380 +18991 1 0.000208 1560.000000 -0.003600 -0.001320 0.001298 +18992 1 0.000266 1560.000000 -0.003499 0.000758 0.007699 +18993 1 0.000211 1560.000000 0.000142 -0.003845 0.002333 +18994 1 0.000240 1560.000000 0.000476 -0.001481 0.000915 +18995 1 0.000252 1560.000000 -0.000540 -0.002772 0.008993 +18996 1 0.000213 1560.000000 0.001371 0.000254 0.004666 +18997 1 0.000258 1560.000000 -0.002525 0.000080 0.000873 +18998 1 0.000206 1560.000000 0.000700 0.002785 0.006472 +18999 1 0.000249 1560.000000 0.002345 0.000094 0.004688 +19000 1 0.000264 1560.000000 -0.003344 0.000554 0.004338 +19001 1 0.000230 1560.000000 -0.003220 0.001314 0.002179 +19002 1 0.000249 1560.000000 0.003364 0.001778 0.001655 +19003 1 0.000194 1560.000000 -0.001491 0.000943 0.009737 +19004 1 0.000199 1560.000000 0.003435 -0.000041 0.004166 +19005 1 0.000219 1560.000000 -0.000746 -0.002640 0.006296 +19006 1 0.000207 1560.000000 0.003008 0.001358 0.008647 +19007 1 0.000208 1560.000000 -0.000982 0.001355 0.004377 +19008 1 0.000279 1560.000000 -0.003781 -0.000050 0.004817 +19009 1 0.000243 1560.000000 -0.001334 -0.003019 0.004878 +19010 1 0.000214 1560.000000 0.002176 -0.002597 0.006229 +19011 1 0.000209 1560.000000 0.000519 -0.003282 0.002974 +19012 1 0.000215 1560.000000 0.001250 0.000574 0.005617 +19013 1 0.000209 1560.000000 0.003103 -0.000615 0.000289 +19014 1 0.000262 1560.000000 -0.000431 0.001097 0.005052 +19015 1 0.000276 1560.000000 -0.003490 0.001572 0.007203 +19016 1 0.000255 1560.000000 0.002951 -0.001408 0.003204 +19017 1 0.000252 1560.000000 -0.000081 0.003520 0.004742 +19018 1 0.000271 1560.000000 -0.002866 -0.002234 0.002590 +19019 1 0.000203 1560.000000 0.000264 -0.002488 0.001348 +19020 1 0.000217 1560.000000 -0.002652 0.000048 0.000650 +19021 1 0.000247 1560.000000 0.001262 0.001478 0.004885 +19022 1 0.000265 1560.000000 -0.001743 0.001128 0.004316 +19023 1 0.000283 1560.000000 -0.002310 0.000340 0.005772 +19024 1 0.000206 1560.000000 -0.000223 0.001432 0.006681 +19025 1 0.000224 1560.000000 0.000070 -0.002418 0.005292 +19026 1 0.000213 1560.000000 0.003345 -0.001324 0.009247 +19027 1 0.000253 1560.000000 0.001108 0.003145 0.002720 +19028 1 0.000244 1560.000000 -0.001193 -0.001770 0.002245 +19029 1 0.000218 1560.000000 -0.001010 -0.001461 0.000148 +19030 1 0.000203 1560.000000 -0.001111 -0.002691 0.009710 +19031 1 0.000269 1560.000000 0.003077 -0.001097 0.008617 +19032 1 0.000227 1560.000000 0.001074 0.001242 0.006896 +19033 1 0.000229 1560.000000 0.001933 -0.001983 0.000751 +19034 1 0.000240 1560.000000 0.002625 0.002683 0.001193 +19035 1 0.000253 1560.000000 -0.000029 -0.002753 0.006484 +19036 1 0.000196 1560.000000 -0.001185 -0.000842 0.000272 +19037 1 0.000253 1560.000000 0.000006 0.000929 0.000431 +19038 1 0.000201 1560.000000 0.000683 0.002525 0.002438 +19039 1 0.000240 1560.000000 -0.000998 -0.002483 0.005653 +19040 1 0.000202 1560.000000 0.002021 -0.001234 0.001515 +19041 1 0.000222 1560.000000 -0.001142 -0.002499 0.007834 +19042 1 0.000284 1560.000000 -0.000392 0.002226 0.004093 +19043 1 0.000265 1560.000000 -0.000232 0.001338 0.004736 +19044 1 0.000232 1560.000000 -0.001370 -0.000187 0.002184 +19045 1 0.000259 1560.000000 -0.001074 0.003044 0.006652 +19046 1 0.000211 1560.000000 0.001060 0.002770 0.006470 +19047 1 0.000234 1560.000000 0.001401 -0.000393 0.004472 +19048 1 0.000248 1560.000000 0.003565 -0.000696 0.009530 +19049 1 0.000193 1560.000000 -0.000731 -0.000904 0.006766 +19050 1 0.000228 1560.000000 -0.001590 0.002787 0.004275 +19051 1 0.000203 1560.000000 -0.001576 -0.002675 0.003447 +19052 1 0.000240 1560.000000 0.003203 -0.001353 0.007594 +19053 1 0.000193 1560.000000 -0.000882 0.001593 0.007421 +19054 1 0.000258 1560.000000 0.001832 -0.001370 0.004458 +19055 1 0.000240 1560.000000 0.002086 0.001821 0.006109 +19056 1 0.000243 1560.000000 -0.000016 -0.003567 0.000531 +19057 1 0.000209 1560.000000 0.000107 0.000718 0.008877 +19058 1 0.000261 1560.000000 -0.002703 0.002741 0.000153 +19059 1 0.000201 1560.000000 -0.003031 0.001160 0.009785 +19060 1 0.000210 1560.000000 -0.001410 -0.001191 0.003707 +19061 1 0.000224 1560.000000 -0.001002 0.000868 0.000581 +19062 1 0.000200 1560.000000 -0.002757 0.001514 0.006864 +19063 1 0.000285 1560.000000 0.000631 -0.002298 0.002166 +19064 1 0.000193 1560.000000 0.003522 0.001173 0.001150 +19065 1 0.000269 1560.000000 -0.002525 0.001639 0.003938 +19066 1 0.000272 1560.000000 -0.000120 0.003721 0.001922 +19067 1 0.000229 1560.000000 0.000949 -0.001676 0.005304 +19068 1 0.000204 1560.000000 -0.000624 -0.000910 0.005899 +19069 1 0.000235 1560.000000 0.002380 -0.001358 0.000542 +19070 1 0.000218 1560.000000 0.000405 0.000976 0.000874 +19071 1 0.000230 1560.000000 0.001986 0.003270 0.004922 +19072 1 0.000215 1560.000000 0.000703 -0.002059 0.001202 +19073 1 0.000284 1560.000000 0.001917 -0.002484 0.009512 +19074 1 0.000199 1560.000000 -0.002796 0.001018 0.003459 +19075 1 0.000208 1560.000000 0.000779 -0.003125 0.007264 +19076 1 0.000246 1560.000000 0.003012 -0.001343 0.008426 +19077 1 0.000228 1560.000000 0.000993 0.001411 0.003462 +19078 1 0.000201 1560.000000 0.001036 0.002211 0.004449 +19079 1 0.000231 1560.000000 -0.002870 -0.002046 0.008737 +19080 1 0.000193 1560.000000 0.000766 -0.000023 0.009664 +19081 1 0.000288 1560.000000 0.002851 -0.002187 0.004637 +19082 1 0.000251 1560.000000 0.001278 -0.001243 0.005325 +19083 1 0.000288 1560.000000 0.002068 -0.003243 0.002189 +19084 1 0.000247 1560.000000 -0.001532 0.000519 0.004629 +19085 1 0.000249 1560.000000 0.000101 -0.001280 0.006792 +19086 1 0.000221 1560.000000 -0.000468 -0.002192 0.001438 +19087 1 0.000247 1560.000000 -0.001193 0.002414 0.005047 +19088 1 0.000261 1560.000000 0.002734 0.000230 0.002443 +19089 1 0.000228 1560.000000 -0.000457 0.002494 0.001385 +19090 1 0.000278 1560.000000 0.002788 0.000979 0.000200 +19091 1 0.000262 1560.000000 0.001702 0.002972 0.001530 +19092 1 0.000214 1560.000000 0.000388 0.003114 0.008480 +19093 1 0.000201 1560.000000 0.001299 0.000194 0.006034 +19094 1 0.000223 1560.000000 -0.003165 -0.000609 0.008882 +19095 1 0.000282 1560.000000 -0.001806 -0.003298 0.000173 +19096 1 0.000236 1560.000000 -0.000158 0.003337 0.006898 +19097 1 0.000201 1560.000000 -0.002197 -0.001127 0.002633 +19098 1 0.000271 1560.000000 0.001104 -0.003030 0.006026 +19099 1 0.000245 1560.000000 0.001685 -0.001310 0.005870 +19100 1 0.000265 1560.000000 -0.002798 0.002559 0.002731 +19101 1 0.000225 1560.000000 0.001732 -0.001132 0.000593 +19102 1 0.000214 1560.000000 0.002140 0.003152 0.008666 +19103 1 0.000247 1560.000000 0.003144 0.001564 0.008934 +19104 1 0.000251 1560.000000 0.001492 -0.003525 0.008891 +19105 1 0.000253 1560.000000 0.002609 -0.002046 0.008872 +19106 1 0.000230 1560.000000 0.001421 -0.001411 0.003666 +19107 1 0.000220 1560.000000 -0.000925 0.001040 0.007244 +19108 1 0.000211 1560.000000 0.000764 -0.002831 0.003617 +19109 1 0.000246 1560.000000 -0.000981 -0.001690 0.007763 +19110 1 0.000210 1560.000000 0.000325 0.000570 0.004334 +19111 1 0.000272 1560.000000 -0.001717 0.002922 0.000623 +19112 1 0.000280 1560.000000 0.001026 -0.002501 0.001562 +19113 1 0.000194 1560.000000 0.000028 0.000289 0.000123 +19114 1 0.000241 1560.000000 -0.002499 -0.001397 0.007567 +19115 1 0.000213 1560.000000 0.000119 0.000081 0.005559 +19116 1 0.000204 1560.000000 0.000584 -0.000954 0.004328 +19117 1 0.000205 1560.000000 0.002027 0.000541 0.006110 +19118 1 0.000230 1560.000000 -0.001279 -0.000616 0.002183 +19119 1 0.000254 1560.000000 -0.002461 -0.001421 0.005865 +19120 1 0.000197 1560.000000 0.002348 0.003020 0.009110 +19121 1 0.000222 1560.000000 -0.000132 -0.001151 0.006337 +19122 1 0.000193 1560.000000 0.001095 0.000266 0.006915 +19123 1 0.000203 1560.000000 -0.003373 -0.000423 0.004411 +19124 1 0.000225 1560.000000 -0.001621 0.003322 0.002228 +19125 1 0.000253 1560.000000 0.002997 0.000160 0.001274 +19126 1 0.000244 1560.000000 -0.002899 -0.000897 0.006078 +19127 1 0.000193 1560.000000 0.002198 0.000133 0.008258 +19128 1 0.000209 1560.000000 -0.000936 -0.002103 0.000401 +19129 1 0.000283 1560.000000 -0.000867 -0.000184 0.002296 +19130 1 0.000211 1560.000000 0.000465 -0.003798 0.007128 +19131 1 0.000248 1560.000000 -0.002671 0.000818 0.004800 +19132 1 0.000205 1560.000000 -0.000057 -0.001311 0.009603 +19133 1 0.000269 1560.000000 0.002643 0.000244 0.008951 +19134 1 0.000195 1560.000000 -0.002175 -0.000156 0.001575 +19135 1 0.000286 1560.000000 0.001979 0.002751 0.005248 +19136 1 0.000270 1560.000000 -0.003751 0.000273 0.005132 +19137 1 0.000213 1560.000000 -0.000394 0.001379 0.003274 +19138 1 0.000234 1560.000000 -0.001758 -0.000703 0.005076 +19139 1 0.000221 1560.000000 -0.000474 0.001998 0.007148 +19140 1 0.000214 1560.000000 0.002069 -0.001504 0.002857 +19141 1 0.000264 1560.000000 0.000583 -0.003637 0.000810 +19142 1 0.000227 1560.000000 0.002987 -0.001669 0.002254 +19143 1 0.000193 1560.000000 0.001012 -0.000627 0.005599 +19144 1 0.000214 1560.000000 -0.000986 0.002351 0.001672 +19145 1 0.000238 1560.000000 0.003176 0.000345 0.008330 +19146 1 0.000193 1560.000000 0.003776 0.000322 0.005548 +19147 1 0.000225 1560.000000 -0.002365 0.002147 0.000186 +19148 1 0.000206 1560.000000 -0.002468 -0.002241 0.000857 +19149 1 0.000255 1560.000000 0.003443 -0.001717 0.003551 +19150 1 0.000210 1560.000000 -0.002815 0.001073 0.006980 +19151 1 0.000204 1560.000000 0.003348 -0.001349 0.000193 +19152 1 0.000231 1560.000000 0.000601 -0.002955 0.003882 +19153 1 0.000228 1560.000000 -0.001566 -0.002872 0.006200 +19154 1 0.000242 1560.000000 0.002277 -0.000468 0.000913 +19155 1 0.000196 1560.000000 -0.000001 0.001003 0.003679 +19156 1 0.000206 1560.000000 -0.003098 0.000999 0.004713 +19157 1 0.000204 1560.000000 0.002750 -0.001246 0.006164 +19158 1 0.000203 1560.000000 0.001241 -0.001215 0.009557 +19159 1 0.000198 1560.000000 0.002616 0.001697 0.004645 +19160 1 0.000222 1560.000000 -0.002845 0.001161 0.007978 +19161 1 0.000200 1560.000000 0.002952 0.001746 0.006176 +19162 1 0.000205 1560.000000 -0.003307 0.000252 0.002240 +19163 1 0.000221 1560.000000 0.000766 -0.002453 0.003895 +19164 1 0.000233 1560.000000 -0.000272 -0.002300 0.009414 +19165 1 0.000230 1560.000000 0.002102 0.001228 0.004752 +19166 1 0.000219 1560.000000 -0.003111 -0.000791 0.000402 +19167 1 0.000225 1560.000000 -0.002536 0.000281 0.002993 +19168 1 0.000260 1560.000000 -0.001570 -0.000094 0.001755 +19169 1 0.000201 1560.000000 0.001194 0.002294 0.004258 +19170 1 0.000233 1560.000000 0.000207 0.003830 0.002325 +19171 1 0.000195 1560.000000 0.002256 0.000836 0.007100 +19172 1 0.000203 1560.000000 -0.000776 -0.001301 0.000961 +19173 1 0.000213 1560.000000 -0.000764 -0.000195 0.005044 +19174 1 0.000240 1560.000000 -0.002007 0.000243 0.004534 +19175 1 0.000230 1560.000000 -0.002303 -0.001503 0.004881 +19176 1 0.000203 1560.000000 0.002460 0.000030 0.006057 +19177 1 0.000224 1560.000000 -0.003611 -0.000455 0.002528 +19178 1 0.000234 1560.000000 0.000361 0.002894 0.008390 +19179 1 0.000274 1560.000000 0.003154 0.002169 0.007095 +19180 1 0.000252 1560.000000 0.002586 -0.001942 0.000129 +19181 1 0.000278 1560.000000 0.002308 -0.001400 0.003449 +19182 1 0.000214 1560.000000 -0.000353 0.003820 0.004073 +19183 1 0.000207 1560.000000 0.002142 -0.001768 0.006565 +19184 1 0.000196 1560.000000 -0.000488 -0.000007 0.007106 +19185 1 0.000204 1560.000000 -0.002110 -0.001723 0.001763 +19186 1 0.000195 1560.000000 0.000837 0.001733 0.007832 +19187 1 0.000278 1560.000000 -0.002247 0.000813 0.003855 +19188 1 0.000213 1560.000000 -0.000119 -0.003114 0.007296 +19189 1 0.000205 1560.000000 -0.002635 0.002192 0.004254 +19190 1 0.000239 1560.000000 0.000942 -0.003234 0.007969 +19191 1 0.000215 1560.000000 0.000794 -0.002019 0.007633 +19192 1 0.000194 1560.000000 -0.001888 0.001996 0.004638 +19193 1 0.000264 1560.000000 0.000204 0.003108 0.000843 +19194 1 0.000213 1560.000000 0.001291 -0.000960 0.005923 +19195 1 0.000253 1560.000000 0.003762 0.000201 0.009372 +19196 1 0.000275 1560.000000 -0.003659 -0.001094 0.006440 +19197 1 0.000214 1560.000000 0.002125 0.002556 0.002755 +19198 1 0.000200 1560.000000 -0.001468 0.002125 0.009308 +19199 1 0.000232 1560.000000 -0.003340 0.000410 0.009748 +19200 1 0.000222 1560.000000 -0.002548 0.000967 0.000155 +19201 1 0.000284 1560.000000 -0.003400 0.001671 0.009408 +19202 1 0.000193 1560.000000 -0.002303 -0.003038 0.000531 +19203 1 0.000195 1560.000000 -0.000690 -0.000298 0.008794 +19204 1 0.000196 1560.000000 -0.000522 -0.000832 0.006921 +19205 1 0.000196 1560.000000 -0.002416 -0.000939 0.001843 +19206 1 0.000260 1560.000000 0.002759 -0.000675 0.006298 +19207 1 0.000273 1560.000000 -0.001685 0.000334 0.007324 +19208 1 0.000286 1560.000000 -0.003800 -0.000374 0.009174 +19209 1 0.000245 1560.000000 -0.000779 -0.001795 0.003774 +19210 1 0.000238 1560.000000 -0.001445 0.003368 0.007965 +19211 1 0.000248 1560.000000 0.001064 0.002557 0.001201 +19212 1 0.000268 1560.000000 -0.002204 -0.002524 0.006643 +19213 1 0.000285 1560.000000 0.000693 0.002045 0.009096 +19214 1 0.000218 1560.000000 0.003444 -0.000042 0.007884 +19215 1 0.000208 1560.000000 -0.001486 -0.003541 0.006355 +19216 1 0.000214 1560.000000 -0.001827 -0.000354 0.009767 +19217 1 0.000237 1560.000000 0.002493 -0.001111 0.006813 +19218 1 0.000194 1560.000000 0.000594 0.000026 0.007348 +19219 1 0.000267 1560.000000 -0.000298 0.003769 0.005156 +19220 1 0.000204 1560.000000 0.000844 -0.002842 0.009133 +19221 1 0.000220 1560.000000 0.001299 -0.001592 0.008114 +19222 1 0.000239 1560.000000 -0.002322 0.003014 0.003729 +19223 1 0.000208 1560.000000 0.001072 -0.000652 0.003995 +19224 1 0.000260 1560.000000 0.001090 0.002424 0.009579 +19225 1 0.000229 1560.000000 -0.002188 -0.000072 0.003609 +19226 1 0.000254 1560.000000 -0.003724 0.000698 0.006272 +19227 1 0.000220 1560.000000 0.003402 -0.001310 0.008749 +19228 1 0.000214 1560.000000 -0.001459 0.002864 0.001445 +19229 1 0.000193 1560.000000 0.001128 -0.001778 0.006963 +19230 1 0.000244 1560.000000 -0.003373 0.000841 0.007292 +19231 1 0.000200 1560.000000 -0.002847 0.000111 0.006758 +19232 1 0.000282 1560.000000 0.000153 -0.003808 0.004390 +19233 1 0.000255 1560.000000 0.002750 0.002019 0.002975 +19234 1 0.000254 1560.000000 0.001187 -0.002999 0.008517 +19235 1 0.000247 1560.000000 -0.003188 -0.000489 0.002676 +19236 1 0.000283 1560.000000 0.000755 0.002728 0.009056 +19237 1 0.000213 1560.000000 0.001928 -0.001943 0.004348 +19238 1 0.000266 1560.000000 -0.002788 0.000824 0.006126 +19239 1 0.000247 1560.000000 0.003229 0.000018 0.003388 +19240 1 0.000239 1560.000000 0.000490 0.000389 0.001588 +19241 1 0.000206 1560.000000 -0.003019 -0.002368 0.001884 +19242 1 0.000196 1560.000000 -0.000501 -0.003327 0.007918 +19243 1 0.000287 1560.000000 -0.001835 0.002323 0.002511 +19244 1 0.000242 1560.000000 0.003470 0.001560 0.007362 +19245 1 0.000217 1560.000000 -0.001883 -0.003283 0.007379 +19246 1 0.000232 1560.000000 0.000406 -0.002497 0.005361 +19247 1 0.000220 1560.000000 -0.002298 -0.001916 0.001836 +19248 1 0.000250 1560.000000 -0.000237 0.001069 0.008137 +19249 1 0.000274 1560.000000 -0.001267 -0.002898 0.009019 +19250 1 0.000252 1560.000000 0.003224 0.001851 0.006081 +19251 1 0.000196 1560.000000 -0.002422 -0.000142 0.000131 +19252 1 0.000231 1560.000000 -0.000549 -0.002479 0.002332 +19253 1 0.000258 1560.000000 -0.002929 0.002347 0.009701 +19254 1 0.000199 1560.000000 0.002023 -0.000105 0.008299 +19255 1 0.000228 1560.000000 0.001219 -0.001762 0.008921 +19256 1 0.000199 1560.000000 -0.001698 -0.001696 0.006448 +19257 1 0.000220 1560.000000 -0.003672 -0.001156 0.003166 +19258 1 0.000211 1560.000000 -0.001006 0.002597 0.001526 +19259 1 0.000216 1560.000000 -0.003702 0.001018 0.006530 +19260 1 0.000226 1560.000000 0.002150 -0.001092 0.000649 +19261 1 0.000209 1560.000000 0.003622 0.001048 0.007965 +19262 1 0.000237 1560.000000 -0.000879 0.003733 0.007658 +19263 1 0.000260 1560.000000 -0.003395 0.000424 0.004994 +19264 1 0.000250 1560.000000 -0.002514 -0.001135 0.007671 +19265 1 0.000285 1560.000000 0.003557 -0.001075 0.009824 +19266 1 0.000202 1560.000000 -0.002293 0.001130 0.009272 +19267 1 0.000213 1560.000000 0.002374 -0.001469 0.001117 +19268 1 0.000203 1560.000000 0.003380 0.000340 0.003615 +19269 1 0.000265 1560.000000 0.001545 0.001560 0.003204 +19270 1 0.000210 1560.000000 -0.003299 -0.001897 0.007386 +19271 1 0.000196 1560.000000 0.001017 0.003656 0.004419 +19272 1 0.000219 1560.000000 0.003459 -0.000112 0.000838 +19273 1 0.000192 1560.000000 0.001453 0.000021 0.006486 +19274 1 0.000215 1560.000000 0.000188 -0.000936 0.001737 +19275 1 0.000259 1560.000000 -0.001720 -0.003060 0.003436 +19276 1 0.000195 1560.000000 -0.000133 -0.002284 0.008733 +19277 1 0.000250 1560.000000 -0.002483 -0.002584 0.002303 +19278 1 0.000223 1560.000000 0.000518 0.001932 0.006372 +19279 1 0.000271 1560.000000 0.001421 -0.001907 0.000162 +19280 1 0.000195 1560.000000 0.002391 -0.001368 0.003072 +19281 1 0.000243 1560.000000 0.003800 0.000270 0.007823 +19282 1 0.000198 1560.000000 -0.000375 -0.000169 0.009542 +19283 1 0.000218 1560.000000 0.000243 0.001308 0.003654 +19284 1 0.000208 1560.000000 0.001417 -0.002236 0.006964 +19285 1 0.000260 1560.000000 0.002337 0.000454 0.006227 +19286 1 0.000212 1560.000000 -0.002143 -0.000390 0.005095 +19287 1 0.000229 1560.000000 -0.001231 0.001377 0.001381 +19288 1 0.000205 1560.000000 -0.003399 -0.001097 0.002739 +19289 1 0.000214 1560.000000 0.001055 0.000893 0.009729 +19290 1 0.000192 1560.000000 -0.001166 -0.002863 0.006067 +19291 1 0.000273 1560.000000 -0.003576 0.000420 0.008351 +19292 1 0.000233 1560.000000 0.000159 0.000492 0.001176 +19293 1 0.000206 1560.000000 -0.000059 0.002001 0.008053 +19294 1 0.000210 1560.000000 -0.002970 0.000434 0.007514 +19295 1 0.000237 1560.000000 -0.002910 -0.001481 0.001387 +19296 1 0.000285 1560.000000 -0.003769 0.000608 0.005042 +19297 1 0.000229 1560.000000 0.000985 0.000909 0.009106 +19298 1 0.000209 1560.000000 0.000976 0.002874 0.009113 +19299 1 0.000195 1560.000000 0.001345 0.003358 0.009020 +19300 1 0.000248 1560.000000 0.001815 0.000626 0.008435 +19301 1 0.000214 1560.000000 0.001563 -0.001249 0.001040 +19302 1 0.000237 1560.000000 0.002959 -0.001936 0.007886 +19303 1 0.000213 1560.000000 -0.003837 -0.000180 0.001909 +19304 1 0.000273 1560.000000 0.003230 0.002106 0.008423 +19305 1 0.000215 1560.000000 0.001508 0.001051 0.009684 +19306 1 0.000215 1560.000000 -0.003803 0.000582 0.007193 +19307 1 0.000214 1560.000000 -0.000020 -0.002298 0.000229 +19308 1 0.000261 1560.000000 -0.002771 -0.000446 0.008575 +19309 1 0.000201 1560.000000 -0.001873 0.002727 0.004050 +19310 1 0.000250 1560.000000 0.003810 0.000523 0.008018 +19311 1 0.000262 1560.000000 -0.001665 0.001630 0.006170 +19312 1 0.000246 1560.000000 -0.001444 0.003559 0.008499 +19313 1 0.000196 1560.000000 -0.000308 0.000914 0.003800 +19314 1 0.000281 1560.000000 -0.000819 0.003019 0.005575 +19315 1 0.000257 1560.000000 0.001386 0.000156 0.005518 +19316 1 0.000194 1560.000000 -0.002240 0.001579 0.006520 +19317 1 0.000209 1560.000000 0.001236 0.002138 0.000753 +19318 1 0.000266 1560.000000 0.001212 0.002178 0.003443 +19319 1 0.000235 1560.000000 -0.002726 0.000345 0.001048 +19320 1 0.000241 1560.000000 0.001666 -0.002493 0.001447 +19321 1 0.000247 1560.000000 0.001798 0.001507 0.003118 +19322 1 0.000261 1560.000000 -0.000827 -0.001925 0.001267 +19323 1 0.000201 1560.000000 -0.002719 0.000974 0.003116 +19324 1 0.000209 1560.000000 0.002514 0.002132 0.000590 +19325 1 0.000200 1560.000000 -0.000400 -0.000822 0.001871 +19326 1 0.000205 1560.000000 -0.002659 -0.002096 0.002418 +19327 1 0.000239 1560.000000 0.003235 -0.001633 0.007204 +19328 1 0.000239 1560.000000 -0.001204 0.001809 0.000133 +19329 1 0.000202 1560.000000 0.000220 0.000972 0.008783 +19330 1 0.000222 1560.000000 -0.003090 0.002097 0.009185 +19331 1 0.000242 1560.000000 0.001595 -0.000112 0.004728 +19332 1 0.000259 1560.000000 0.000630 0.002149 0.009472 +19333 1 0.000194 1560.000000 -0.001715 0.003114 0.007925 +19334 1 0.000204 1560.000000 0.000484 -0.001171 0.001884 +19335 1 0.000288 1560.000000 0.000568 0.003766 0.009826 +19336 1 0.000275 1560.000000 -0.000718 -0.001613 0.001417 +19337 1 0.000203 1560.000000 0.002503 0.000726 0.008996 +19338 1 0.000244 1560.000000 0.002685 -0.000279 0.003937 +19339 1 0.000281 1560.000000 0.002570 0.001766 0.001349 +19340 1 0.000194 1560.000000 0.001752 0.003084 0.008251 +19341 1 0.000198 1560.000000 0.002219 -0.002763 0.006884 +19342 1 0.000282 1560.000000 0.001029 -0.003698 0.001476 +19343 1 0.000269 1560.000000 -0.000879 0.000360 0.003257 +19344 1 0.000229 1560.000000 0.001553 0.002448 0.001461 +19345 1 0.000256 1560.000000 0.000212 0.001535 0.009617 +19346 1 0.000227 1560.000000 0.002150 -0.000420 0.007513 +19347 1 0.000198 1560.000000 -0.003777 -0.000360 0.007731 +19348 1 0.000205 1560.000000 0.000078 -0.001470 0.007629 +19349 1 0.000241 1560.000000 0.002755 0.001355 0.000739 +19350 1 0.000259 1560.000000 0.001759 -0.000001 0.007654 +19351 1 0.000213 1560.000000 0.001540 0.000586 0.003064 +19352 1 0.000229 1560.000000 -0.001528 0.002384 0.001559 +19353 1 0.000199 1560.000000 0.000219 -0.000131 0.002765 +19354 1 0.000212 1560.000000 0.000000 0.003212 0.007886 +19355 1 0.000218 1560.000000 -0.000358 -0.000406 0.003951 +19356 1 0.000245 1560.000000 0.001941 -0.000413 0.008240 +19357 1 0.000208 1560.000000 0.003149 0.001309 0.002256 +19358 1 0.000240 1560.000000 0.003160 0.001175 0.003931 +19359 1 0.000198 1560.000000 0.000110 0.002633 0.007831 +19360 1 0.000253 1560.000000 0.002463 -0.002005 0.003448 +19361 1 0.000265 1560.000000 0.001731 0.001257 0.009139 +19362 1 0.000197 1560.000000 -0.002658 -0.000514 0.008358 +19363 1 0.000243 1560.000000 -0.002406 -0.002674 0.008556 +19364 1 0.000212 1560.000000 0.003160 0.000481 0.000802 +19365 1 0.000223 1560.000000 -0.000346 -0.000428 0.009816 +19366 1 0.000285 1560.000000 0.003819 0.000528 0.009259 +19367 1 0.000271 1560.000000 -0.001033 -0.002687 0.004451 +19368 1 0.000252 1560.000000 0.000805 -0.002658 0.008529 +19369 1 0.000206 1560.000000 -0.002708 0.000609 0.007551 +19370 1 0.000272 1560.000000 -0.002305 0.000712 0.005684 +19371 1 0.000253 1560.000000 -0.002126 0.000182 0.005231 +19372 1 0.000201 1560.000000 -0.002242 0.002647 0.005102 +19373 1 0.000226 1560.000000 -0.000247 -0.003629 0.003611 +19374 1 0.000232 1560.000000 -0.000276 0.002610 0.002138 +19375 1 0.000229 1560.000000 -0.003392 -0.000399 0.007634 +19376 1 0.000210 1560.000000 -0.003444 0.001705 0.006201 +19377 1 0.000206 1560.000000 -0.002870 -0.000813 0.002760 +19378 1 0.000223 1560.000000 0.002733 0.001613 0.001791 +19379 1 0.000244 1560.000000 -0.002431 0.001427 0.002916 +19380 1 0.000203 1560.000000 -0.002014 0.000459 0.003104 +19381 1 0.000196 1560.000000 -0.000049 -0.001333 0.001549 +19382 1 0.000258 1560.000000 0.002199 0.002000 0.001217 +19383 1 0.000237 1560.000000 -0.000803 -0.000573 0.007767 +19384 1 0.000239 1560.000000 0.003413 -0.000780 0.001726 +19385 1 0.000195 1560.000000 0.002651 0.001138 0.003960 +19386 1 0.000212 1560.000000 0.002406 0.002169 0.006267 +19387 1 0.000259 1560.000000 -0.001671 -0.002284 0.007407 +19388 1 0.000263 1560.000000 0.002287 0.003090 0.009436 +19389 1 0.000228 1560.000000 -0.002157 -0.002775 0.008002 +19390 1 0.000231 1560.000000 -0.001111 -0.002004 0.005844 +19391 1 0.000255 1560.000000 -0.003489 -0.000968 0.003462 +19392 1 0.000242 1560.000000 -0.001230 -0.000403 0.002081 +19393 1 0.000239 1560.000000 0.000049 -0.001426 0.005017 +19394 1 0.000195 1560.000000 -0.000827 -0.001995 0.001704 +19395 1 0.000220 1560.000000 -0.001164 0.001377 0.004844 +19396 1 0.000196 1560.000000 0.003706 0.000503 0.000844 +19397 1 0.000239 1560.000000 -0.001733 -0.001658 0.005236 +19398 1 0.000266 1560.000000 0.000363 -0.002853 0.009793 +19399 1 0.000231 1560.000000 0.001576 -0.001097 0.008087 +19400 1 0.000278 1560.000000 -0.003830 0.000070 0.008867 +19401 1 0.000230 1560.000000 -0.000069 0.002902 0.004638 +19402 1 0.000239 1560.000000 0.001025 0.000794 0.008691 +19403 1 0.000227 1560.000000 0.003625 -0.001150 0.005005 +19404 1 0.000218 1560.000000 0.001858 0.002078 0.003541 +19405 1 0.000285 1560.000000 0.002562 0.001221 0.009258 +19406 1 0.000224 1560.000000 0.001801 0.002694 0.000889 +19407 1 0.000200 1560.000000 -0.000148 -0.001285 0.007015 +19408 1 0.000245 1560.000000 0.000978 -0.003717 0.004227 +19409 1 0.000232 1560.000000 0.002350 0.002422 0.003419 +19410 1 0.000192 1560.000000 -0.000574 0.001779 0.002028 +19411 1 0.000197 1560.000000 -0.001688 -0.000160 0.002719 +19412 1 0.000199 1560.000000 0.001132 -0.000414 0.006336 +19413 1 0.000229 1560.000000 0.000878 0.000218 0.002947 +19414 1 0.000210 1560.000000 0.001628 0.000222 0.007154 +19415 1 0.000283 1560.000000 0.000589 0.003243 0.003389 +19416 1 0.000200 1560.000000 -0.002126 -0.002597 0.008407 +19417 1 0.000280 1560.000000 -0.000973 0.003697 0.003719 +19418 1 0.000230 1560.000000 -0.000254 -0.001265 0.007949 +19419 1 0.000272 1560.000000 0.001368 0.002080 0.007436 +19420 1 0.000205 1560.000000 0.000360 0.003383 0.008844 +19421 1 0.000241 1560.000000 0.000783 0.001389 0.002809 +19422 1 0.000197 1560.000000 0.003447 0.000128 0.000190 +19423 1 0.000226 1560.000000 -0.000700 -0.003227 0.008127 +19424 1 0.000241 1560.000000 0.001302 -0.000490 0.005607 +19425 1 0.000247 1560.000000 -0.001390 -0.003379 0.001053 +19426 1 0.000223 1560.000000 0.000299 -0.001639 0.001162 +19427 1 0.000197 1560.000000 -0.003748 0.000826 0.002901 +19428 1 0.000251 1560.000000 -0.000046 -0.002948 0.007441 +19429 1 0.000243 1560.000000 0.000976 0.002821 0.004425 +19430 1 0.000212 1560.000000 -0.000244 0.000908 0.008967 +19431 1 0.000248 1560.000000 0.003230 -0.000703 0.005464 +19432 1 0.000205 1560.000000 -0.001713 0.002307 0.004279 +19433 1 0.000196 1560.000000 -0.002971 -0.000640 0.009033 +19434 1 0.000280 1560.000000 0.001865 -0.003313 0.000519 +19435 1 0.000223 1560.000000 -0.003720 0.000134 0.002590 +19436 1 0.000200 1560.000000 -0.002007 0.000260 0.008597 +19437 1 0.000226 1560.000000 -0.002327 -0.001557 0.002375 +19438 1 0.000253 1560.000000 -0.003844 0.000291 0.002960 +19439 1 0.000204 1560.000000 0.000197 -0.001244 0.004740 +19440 1 0.000276 1560.000000 -0.001767 -0.000211 0.003845 +19441 1 0.000225 1560.000000 0.001188 0.003205 0.003753 +19442 1 0.000279 1560.000000 0.002246 -0.000909 0.008125 +19443 1 0.000279 1560.000000 -0.001822 -0.001704 0.009849 +19444 1 0.000224 1560.000000 -0.002271 0.001062 0.008528 +19445 1 0.000272 1560.000000 0.002866 -0.000204 0.008777 +19446 1 0.000238 1560.000000 0.001180 0.003649 0.000270 +19447 1 0.000250 1560.000000 -0.000014 -0.003104 0.000150 +19448 1 0.000227 1560.000000 0.000103 -0.001851 0.006847 +19449 1 0.000207 1560.000000 0.001969 0.000059 0.003494 +19450 1 0.000201 1560.000000 -0.000500 0.001628 0.004641 +19451 1 0.000245 1560.000000 0.002833 -0.001538 0.003791 +19452 1 0.000243 1560.000000 0.000099 -0.003445 0.008321 +19453 1 0.000209 1560.000000 -0.002187 -0.000246 0.002278 +19454 1 0.000235 1560.000000 -0.002966 -0.000121 0.003904 +19455 1 0.000219 1560.000000 -0.000597 -0.002851 0.004154 +19456 1 0.000205 1560.000000 -0.001199 0.002514 0.005606 +19457 1 0.000275 1560.000000 -0.002050 -0.002542 0.002617 +19458 1 0.000207 1560.000000 0.002745 0.002336 0.003962 +19459 1 0.000226 1560.000000 0.001301 -0.001647 0.001470 +19460 1 0.000228 1560.000000 0.000624 -0.002298 0.004384 +19461 1 0.000196 1560.000000 0.002490 -0.002918 0.000128 +19462 1 0.000208 1560.000000 0.002986 0.000936 0.008235 +19463 1 0.000202 1560.000000 -0.000606 -0.001003 0.006212 +19464 1 0.000241 1560.000000 0.000601 0.000034 0.006152 +19465 1 0.000272 1560.000000 -0.002257 -0.001768 0.009781 +19466 1 0.000215 1560.000000 -0.002187 -0.000923 0.001972 +19467 1 0.000240 1560.000000 -0.000262 -0.000805 0.003070 +19468 1 0.000207 1560.000000 -0.002874 0.001736 0.009293 +19469 1 0.000203 1560.000000 0.001696 0.001683 0.005274 +19470 1 0.000251 1560.000000 0.002451 -0.001413 0.007921 +19471 1 0.000269 1560.000000 -0.001918 0.003301 0.003541 +19472 1 0.000194 1560.000000 0.003286 0.000161 0.008203 +19473 1 0.000245 1560.000000 -0.000292 0.003160 0.006125 +19474 1 0.000275 1560.000000 -0.003420 -0.000552 0.000158 +19475 1 0.000252 1560.000000 -0.000968 -0.000737 0.000926 +19476 1 0.000210 1560.000000 -0.002328 -0.000281 0.000492 +19477 1 0.000221 1560.000000 0.000203 -0.001293 0.002303 +19478 1 0.000229 1560.000000 -0.000990 0.001061 0.003744 +19479 1 0.000216 1560.000000 0.003829 0.000000 0.007576 +19480 1 0.000201 1560.000000 -0.003251 -0.000935 0.008532 +19481 1 0.000210 1560.000000 -0.000310 -0.002171 0.006666 +19482 1 0.000217 1560.000000 0.001659 0.001097 0.006369 +19483 1 0.000270 1560.000000 0.001708 0.000981 0.005244 +19484 1 0.000220 1560.000000 -0.000739 -0.003759 0.007432 +19485 1 0.000238 1560.000000 0.002114 0.000590 0.000978 +19486 1 0.000209 1560.000000 -0.002028 -0.002283 0.004175 +19487 1 0.000208 1560.000000 0.001201 -0.003251 0.002634 +19488 1 0.000216 1560.000000 -0.003144 -0.001663 0.007526 +19489 1 0.000222 1560.000000 -0.001387 0.000618 0.002339 +19490 1 0.000262 1560.000000 0.003103 -0.002207 0.006867 +19491 1 0.000200 1560.000000 0.001658 -0.000908 0.002601 +19492 1 0.000238 1560.000000 -0.001005 0.001825 0.001815 +19493 1 0.000221 1560.000000 0.001304 -0.000311 0.009760 +19494 1 0.000237 1560.000000 -0.001140 0.003661 0.000893 +19495 1 0.000217 1560.000000 -0.003666 -0.001013 0.008809 +19496 1 0.000277 1560.000000 0.001819 0.000559 0.002119 +19497 1 0.000200 1560.000000 0.003541 0.000751 0.008872 +19498 1 0.000195 1560.000000 -0.001699 -0.003252 0.006029 +19499 1 0.000205 1560.000000 -0.002175 0.001377 0.001253 +19500 1 0.000239 1560.000000 0.000627 0.000761 0.001633 +19501 1 0.000203 1560.000000 0.001377 -0.003228 0.004083 +19502 1 0.000288 1560.000000 -0.001085 0.003697 0.009764 +19503 1 0.000235 1560.000000 -0.003004 -0.000234 0.008674 +19504 1 0.000256 1560.000000 0.002436 -0.002175 0.009352 +19505 1 0.000269 1560.000000 -0.003213 0.002108 0.003454 +19506 1 0.000228 1560.000000 0.000365 0.000805 0.001564 +19507 1 0.000247 1560.000000 -0.002857 -0.001750 0.005567 +19508 1 0.000203 1560.000000 0.002459 -0.002134 0.000358 +19509 1 0.000278 1560.000000 0.001262 -0.003300 0.004428 +19510 1 0.000204 1560.000000 -0.001498 0.001037 0.003377 +19511 1 0.000200 1560.000000 -0.001250 -0.001704 0.007443 +19512 1 0.000274 1560.000000 -0.001629 -0.003246 0.005488 +19513 1 0.000201 1560.000000 -0.003367 0.001801 0.000401 +19514 1 0.000262 1560.000000 -0.000486 -0.002155 0.009831 +19515 1 0.000240 1560.000000 0.002256 -0.000995 0.003104 +19516 1 0.000198 1560.000000 0.003452 -0.001020 0.008847 +19517 1 0.000222 1560.000000 -0.002255 0.000431 0.005222 +19518 1 0.000209 1560.000000 -0.000174 0.000630 0.007549 +19519 1 0.000227 1560.000000 0.000401 0.000832 0.005398 +19520 1 0.000263 1560.000000 -0.000693 -0.002209 0.006736 +19521 1 0.000245 1560.000000 0.000864 0.003720 0.002099 +19522 1 0.000227 1560.000000 -0.000396 0.000418 0.006226 +19523 1 0.000245 1560.000000 -0.002720 -0.000225 0.007178 +19524 1 0.000224 1560.000000 0.000123 -0.003641 0.002039 +19525 1 0.000217 1560.000000 -0.000137 0.002196 0.004530 +19526 1 0.000269 1560.000000 0.001476 0.002977 0.004360 +19527 1 0.000205 1560.000000 -0.000403 -0.000537 0.001855 +19528 1 0.000205 1560.000000 -0.001763 -0.002656 0.002001 +19529 1 0.000195 1560.000000 0.001369 0.002668 0.000920 +19530 1 0.000283 1560.000000 -0.003547 0.001482 0.001583 +19531 1 0.000228 1560.000000 0.001346 0.000851 0.003379 +19532 1 0.000287 1560.000000 -0.003587 -0.001330 0.007484 +19533 1 0.000200 1560.000000 -0.001974 0.000032 0.002459 +19534 1 0.000206 1560.000000 0.002311 0.000077 0.004267 +19535 1 0.000229 1560.000000 -0.003765 -0.000651 0.004050 +19536 1 0.000218 1560.000000 0.002503 -0.000732 0.009490 +19537 1 0.000207 1560.000000 0.001380 0.001929 0.004107 +19538 1 0.000197 1560.000000 -0.001389 -0.002550 0.002307 +19539 1 0.000231 1560.000000 0.000891 -0.001467 0.004128 +19540 1 0.000219 1560.000000 0.001414 -0.003105 0.004918 +19541 1 0.000221 1560.000000 0.000259 -0.002275 0.006805 +19542 1 0.000266 1560.000000 0.002445 0.000086 0.001443 +19543 1 0.000250 1560.000000 -0.001207 0.000426 0.004071 +19544 1 0.000222 1560.000000 0.000611 -0.000703 0.001504 +19545 1 0.000197 1560.000000 -0.001358 0.002998 0.000420 +19546 1 0.000238 1560.000000 0.001638 0.002277 0.002970 +19547 1 0.000200 1560.000000 0.002733 0.000007 0.000950 +19548 1 0.000195 1560.000000 -0.002835 -0.002219 0.007039 +19549 1 0.000219 1560.000000 0.000380 -0.003814 0.004707 +19550 1 0.000258 1560.000000 0.003727 0.000961 0.006437 +19551 1 0.000207 1560.000000 0.002774 -0.001905 0.005797 +19552 1 0.000219 1560.000000 0.001003 -0.003285 0.005710 +19553 1 0.000271 1560.000000 0.001581 -0.002154 0.002848 +19554 1 0.000209 1560.000000 -0.001717 0.002592 0.000747 +19555 1 0.000270 1560.000000 0.003324 0.001928 0.005211 +19556 1 0.000261 1560.000000 0.002567 0.002066 0.007163 +19557 1 0.000233 1560.000000 -0.001977 -0.002400 0.000170 +19558 1 0.000282 1560.000000 -0.002302 0.003071 0.004390 +19559 1 0.000283 1560.000000 0.002305 -0.003087 0.005409 +19560 1 0.000237 1560.000000 0.002425 0.002752 0.000429 +19561 1 0.000211 1560.000000 -0.000226 0.000713 0.003729 +19562 1 0.000202 1560.000000 -0.002137 -0.001532 0.001014 +19563 1 0.000226 1560.000000 0.000550 -0.001415 0.002146 +19564 1 0.000199 1560.000000 -0.003348 0.001627 0.000986 +19565 1 0.000240 1560.000000 0.002601 0.000140 0.005080 +19566 1 0.000247 1560.000000 -0.003121 0.000805 0.006739 +19567 1 0.000194 1560.000000 0.001805 0.001421 0.007684 +19568 1 0.000201 1560.000000 -0.001889 -0.002891 0.004588 +19569 1 0.000213 1560.000000 0.001744 -0.003388 0.007557 +19570 1 0.000221 1560.000000 -0.002198 0.000857 0.004638 +19571 1 0.000206 1560.000000 0.002425 0.000240 0.002083 +19572 1 0.000214 1560.000000 0.001851 -0.002986 0.004612 +19573 1 0.000216 1560.000000 -0.002601 0.000446 0.000566 +19574 1 0.000205 1560.000000 -0.001287 -0.003387 0.006080 +19575 1 0.000232 1560.000000 -0.003005 -0.001122 0.000670 +19576 1 0.000260 1560.000000 0.002361 -0.002452 0.000692 +19577 1 0.000239 1560.000000 -0.001528 -0.002187 0.000578 +19578 1 0.000263 1560.000000 0.000179 -0.003803 0.005508 +19579 1 0.000258 1560.000000 -0.003003 -0.000279 0.009397 +19580 1 0.000204 1560.000000 -0.003312 -0.000083 0.000297 +19581 1 0.000210 1560.000000 -0.001224 0.003275 0.003916 +19582 1 0.000272 1560.000000 0.002379 -0.000130 0.009007 +19583 1 0.000200 1560.000000 0.000711 -0.001749 0.003887 +19584 1 0.000238 1560.000000 0.002020 0.001381 0.009286 +19585 1 0.000224 1560.000000 -0.001880 0.002623 0.003383 +19586 1 0.000236 1560.000000 0.000283 -0.000978 0.004580 +19587 1 0.000253 1560.000000 0.002301 -0.003034 0.002588 +19588 1 0.000194 1560.000000 -0.000572 -0.003106 0.004187 +19589 1 0.000217 1560.000000 -0.002196 0.000921 0.001049 +19590 1 0.000256 1560.000000 -0.000314 0.002170 0.007985 +19591 1 0.000247 1560.000000 -0.002255 0.000745 0.003321 +19592 1 0.000254 1560.000000 -0.001535 0.002838 0.004673 +19593 1 0.000219 1560.000000 -0.003109 0.001502 0.005540 +19594 1 0.000205 1560.000000 -0.002694 0.002605 0.009047 +19595 1 0.000280 1560.000000 -0.000637 -0.002499 0.008042 +19596 1 0.000197 1560.000000 0.002549 0.000761 0.008043 +19597 1 0.000207 1560.000000 -0.003667 -0.000200 0.005383 +19598 1 0.000213 1560.000000 -0.001380 0.003442 0.002901 +19599 1 0.000195 1560.000000 -0.000759 0.001673 0.006091 +19600 1 0.000221 1560.000000 -0.001296 0.001171 0.003264 +19601 1 0.000251 1560.000000 0.002154 -0.002437 0.001699 +19602 1 0.000220 1560.000000 -0.000831 0.003314 0.006488 +19603 1 0.000272 1560.000000 0.002908 0.001861 0.002793 +19604 1 0.000231 1560.000000 0.000898 0.003038 0.008471 +19605 1 0.000270 1560.000000 -0.001235 -0.003040 0.003206 +19606 1 0.000199 1560.000000 0.001440 0.002181 0.003865 +19607 1 0.000257 1560.000000 0.001700 -0.000500 0.000375 +19608 1 0.000205 1560.000000 0.000663 -0.002280 0.003355 +19609 1 0.000277 1560.000000 0.002997 -0.002312 0.002277 +19610 1 0.000224 1560.000000 0.002569 0.002507 0.003738 +19611 1 0.000220 1560.000000 0.000667 -0.003177 0.004489 +19612 1 0.000197 1560.000000 -0.001555 0.000384 0.001479 +19613 1 0.000204 1560.000000 0.000629 -0.002804 0.004464 +19614 1 0.000211 1560.000000 0.001924 -0.000206 0.001470 +19615 1 0.000279 1560.000000 -0.000702 0.000382 0.007993 +19616 1 0.000198 1560.000000 0.001397 -0.002990 0.000466 +19617 1 0.000242 1560.000000 -0.000316 -0.003332 0.007384 +19618 1 0.000276 1560.000000 0.000235 -0.003368 0.007263 +19619 1 0.000196 1560.000000 -0.001056 0.000732 0.001557 +19620 1 0.000274 1560.000000 -0.002615 -0.001319 0.009841 +19621 1 0.000214 1560.000000 -0.001414 0.000227 0.002731 +19622 1 0.000192 1560.000000 0.001315 0.001507 0.002387 +19623 1 0.000243 1560.000000 -0.003708 0.001010 0.009769 +19624 1 0.000196 1560.000000 -0.000246 -0.001932 0.001493 +19625 1 0.000243 1560.000000 0.000804 -0.000412 0.002151 +19626 1 0.000236 1560.000000 0.000937 0.001003 0.004942 +19627 1 0.000271 1560.000000 0.002759 0.000366 0.005519 +19628 1 0.000269 1560.000000 0.000493 0.003485 0.006937 +19629 1 0.000279 1560.000000 0.002844 -0.001830 0.006270 +19630 1 0.000195 1560.000000 0.000263 -0.003693 0.003712 +19631 1 0.000270 1560.000000 -0.002179 -0.001290 0.008691 +19632 1 0.000248 1560.000000 0.002005 0.000944 0.002402 +19633 1 0.000197 1560.000000 -0.000730 -0.002905 0.002214 +19634 1 0.000212 1560.000000 0.000138 0.002083 0.001200 +19635 1 0.000233 1560.000000 -0.000677 0.002390 0.009805 +19636 1 0.000193 1560.000000 -0.000025 -0.003839 0.009608 +19637 1 0.000203 1560.000000 -0.000660 -0.002954 0.002655 +19638 1 0.000223 1560.000000 0.001129 0.003661 0.003586 +19639 1 0.000247 1560.000000 -0.003561 0.000539 0.002510 +19640 1 0.000278 1560.000000 -0.000228 -0.003486 0.009794 +19641 1 0.000210 1560.000000 -0.003207 0.000487 0.009277 +19642 1 0.000217 1560.000000 0.000676 -0.001468 0.005428 +19643 1 0.000197 1560.000000 0.000494 -0.001238 0.005790 +19644 1 0.000201 1560.000000 -0.001535 -0.003102 0.002619 +19645 1 0.000245 1560.000000 -0.000985 -0.001052 0.001892 +19646 1 0.000193 1560.000000 -0.000274 0.000493 0.001722 +19647 1 0.000230 1560.000000 0.000451 0.000342 0.000816 +19648 1 0.000212 1560.000000 0.000899 0.002762 0.004188 +19649 1 0.000211 1560.000000 0.000128 -0.003727 0.000184 +19650 1 0.000209 1560.000000 0.000149 -0.002149 0.008167 +19651 1 0.000276 1560.000000 -0.003622 0.001305 0.005941 +19652 1 0.000270 1560.000000 0.003260 -0.001929 0.005140 +19653 1 0.000251 1560.000000 0.001765 0.002992 0.009459 +19654 1 0.000195 1560.000000 -0.000925 -0.003410 0.004644 +19655 1 0.000257 1560.000000 0.003431 -0.000979 0.007542 +19656 1 0.000286 1560.000000 0.003702 -0.001073 0.002415 +19657 1 0.000208 1560.000000 0.000786 -0.003444 0.006467 +19658 1 0.000242 1560.000000 0.001520 -0.002130 0.000889 +19659 1 0.000192 1560.000000 -0.002944 0.001465 0.000784 +19660 1 0.000211 1560.000000 -0.003055 -0.002169 0.003683 +19661 1 0.000195 1560.000000 -0.001297 -0.002261 0.005484 +19662 1 0.000266 1560.000000 -0.003497 0.000944 0.000355 +19663 1 0.000276 1560.000000 -0.003452 0.001678 0.005858 +19664 1 0.000271 1560.000000 -0.003019 0.002319 0.007580 +19665 1 0.000268 1560.000000 0.001884 0.003314 0.007985 +19666 1 0.000278 1560.000000 -0.003149 0.002222 0.001432 +19667 1 0.000272 1560.000000 -0.002924 -0.002069 0.000199 +19668 1 0.000227 1560.000000 -0.002583 -0.000950 0.004965 +19669 1 0.000196 1560.000000 0.000431 0.000303 0.005816 +19670 1 0.000210 1560.000000 -0.003081 -0.001682 0.006237 +19671 1 0.000255 1560.000000 -0.002378 -0.000207 0.008129 +19672 1 0.000250 1560.000000 -0.002224 0.002640 0.000130 +19673 1 0.000195 1560.000000 -0.000443 0.002830 0.008017 +19674 1 0.000204 1560.000000 0.001853 -0.003334 0.008990 +19675 1 0.000249 1560.000000 0.003061 -0.000914 0.007489 +19676 1 0.000193 1560.000000 -0.000500 0.001247 0.002240 +19677 1 0.000251 1560.000000 0.000237 -0.001920 0.009823 +19678 1 0.000278 1560.000000 -0.002943 -0.000518 0.001599 +19679 1 0.000214 1560.000000 -0.002655 0.001145 0.002137 +19680 1 0.000233 1560.000000 -0.002210 0.000915 0.001777 +19681 1 0.000283 1560.000000 0.000212 -0.003796 0.009496 +19682 1 0.000237 1560.000000 -0.001740 0.001305 0.007323 +19683 1 0.000269 1560.000000 -0.003400 0.001767 0.005534 +19684 1 0.000231 1560.000000 -0.001598 -0.000864 0.006779 +19685 1 0.000284 1560.000000 0.000477 -0.001909 0.004289 +19686 1 0.000246 1560.000000 0.000917 0.002074 0.006535 +19687 1 0.000277 1560.000000 0.003449 -0.000916 0.000575 +19688 1 0.000227 1560.000000 0.000244 -0.002010 0.007733 +19689 1 0.000203 1560.000000 0.000902 -0.000312 0.007394 +19690 1 0.000200 1560.000000 0.000838 -0.001412 0.003768 +19691 1 0.000221 1560.000000 -0.001596 -0.002971 0.001894 +19692 1 0.000269 1560.000000 -0.001561 -0.002402 0.001195 +19693 1 0.000242 1560.000000 -0.002346 -0.000659 0.006380 +19694 1 0.000211 1560.000000 0.003585 0.000677 0.009546 +19695 1 0.000231 1560.000000 -0.000428 0.003783 0.007750 +19696 1 0.000221 1560.000000 0.000272 -0.003473 0.004931 +19697 1 0.000218 1560.000000 0.002981 0.001503 0.005807 +19698 1 0.000240 1560.000000 0.002959 0.000316 0.007494 +19699 1 0.000225 1560.000000 0.003674 0.000775 0.002652 +19700 1 0.000246 1560.000000 0.000880 -0.002728 0.007985 +19701 1 0.000201 1560.000000 0.002426 -0.000032 0.000145 +19702 1 0.000268 1560.000000 -0.001131 -0.002308 0.003141 +19703 1 0.000271 1560.000000 0.002844 -0.001017 0.008208 +19704 1 0.000263 1560.000000 0.001311 0.002682 0.006926 +19705 1 0.000214 1560.000000 0.000211 -0.000552 0.009290 +19706 1 0.000248 1560.000000 -0.002181 0.002029 0.003810 +19707 1 0.000261 1560.000000 0.003486 -0.001530 0.000535 +19708 1 0.000216 1560.000000 0.000610 -0.002452 0.009546 +19709 1 0.000262 1560.000000 -0.003547 -0.000698 0.002127 +19710 1 0.000218 1560.000000 -0.001036 0.002712 0.008588 +19711 1 0.000245 1560.000000 -0.001077 -0.002334 0.000244 +19712 1 0.000197 1560.000000 -0.001791 -0.001228 0.005413 +19713 1 0.000248 1560.000000 -0.002869 0.001866 0.006936 +19714 1 0.000237 1560.000000 0.000735 0.001161 0.000146 +19715 1 0.000262 1560.000000 -0.002197 0.001522 0.004394 +19716 1 0.000213 1560.000000 -0.000674 0.002211 0.003410 +19717 1 0.000199 1560.000000 0.000835 -0.001033 0.001377 +19718 1 0.000230 1560.000000 -0.001912 -0.001190 0.001441 +19719 1 0.000205 1560.000000 -0.002057 -0.000555 0.001258 +19720 1 0.000226 1560.000000 -0.001536 0.001530 0.009359 +19721 1 0.000204 1560.000000 -0.003337 -0.001345 0.000129 +19722 1 0.000230 1560.000000 0.001455 -0.002425 0.004799 +19723 1 0.000218 1560.000000 -0.003744 0.000760 0.003223 +19724 1 0.000260 1560.000000 0.003456 0.000718 0.005866 +19725 1 0.000238 1560.000000 -0.002707 -0.002622 0.003946 +19726 1 0.000240 1560.000000 -0.000875 0.002727 0.004351 +19727 1 0.000258 1560.000000 -0.001532 0.003440 0.005139 +19728 1 0.000213 1560.000000 -0.000301 -0.001386 0.006601 +19729 1 0.000239 1560.000000 0.000000 0.002705 0.005448 +19730 1 0.000244 1560.000000 -0.002338 0.002689 0.004828 +19731 1 0.000224 1560.000000 -0.001029 -0.001848 0.004746 +19732 1 0.000238 1560.000000 0.002167 0.000795 0.007735 +19733 1 0.000200 1560.000000 0.000397 -0.000407 0.005995 +19734 1 0.000207 1560.000000 -0.002584 0.002252 0.003942 +19735 1 0.000256 1560.000000 0.001597 0.000923 0.000642 +19736 1 0.000194 1560.000000 -0.000618 -0.002727 0.000607 +19737 1 0.000267 1560.000000 -0.001585 0.003471 0.008296 +19738 1 0.000274 1560.000000 -0.002648 -0.002332 0.003577 +19739 1 0.000199 1560.000000 -0.001028 -0.002211 0.002555 +19740 1 0.000263 1560.000000 -0.001768 0.002281 0.002792 +19741 1 0.000222 1560.000000 0.002085 0.000188 0.005150 +19742 1 0.000196 1560.000000 0.000642 0.000756 0.001382 +19743 1 0.000240 1560.000000 0.001798 0.001604 0.001180 +19744 1 0.000263 1560.000000 -0.002772 0.001314 0.005183 +19745 1 0.000225 1560.000000 0.003081 -0.000371 0.001508 +19746 1 0.000217 1560.000000 0.001275 0.003282 0.009634 +19747 1 0.000201 1560.000000 0.000065 0.000119 0.000935 +19748 1 0.000194 1560.000000 0.001698 -0.000202 0.005207 +19749 1 0.000236 1560.000000 0.000101 -0.001821 0.001400 +19750 1 0.000272 1560.000000 0.001700 -0.002356 0.007801 +19751 1 0.000219 1560.000000 -0.002793 -0.001120 0.002692 +19752 1 0.000201 1560.000000 0.001657 -0.002647 0.003124 +19753 1 0.000259 1560.000000 0.002633 0.002354 0.001033 +19754 1 0.000236 1560.000000 0.002233 0.002668 0.000600 +19755 1 0.000280 1560.000000 0.000744 0.002121 0.005541 +19756 1 0.000202 1560.000000 -0.002753 -0.002678 0.004479 +19757 1 0.000203 1560.000000 -0.000447 0.000596 0.001448 +19758 1 0.000203 1560.000000 0.002073 0.002824 0.003880 +19759 1 0.000258 1560.000000 0.002479 -0.001655 0.000595 +19760 1 0.000249 1560.000000 0.002364 0.000369 0.002914 +19761 1 0.000264 1560.000000 0.001506 -0.001624 0.002477 +19762 1 0.000240 1560.000000 0.001932 0.002402 0.004535 +19763 1 0.000262 1560.000000 0.003691 0.000537 0.006238 +19764 1 0.000220 1560.000000 -0.000634 0.000749 0.006791 +19765 1 0.000268 1560.000000 -0.002313 -0.001427 0.004270 +19766 1 0.000244 1560.000000 0.000543 0.000662 0.001995 +19767 1 0.000215 1560.000000 0.000980 0.000464 0.008646 +19768 1 0.000230 1560.000000 -0.000055 -0.003813 0.002507 +19769 1 0.000276 1560.000000 -0.000268 0.000877 0.000671 +19770 1 0.000193 1560.000000 -0.001897 0.003334 0.000117 +19771 1 0.000262 1560.000000 -0.001710 -0.003451 0.002574 +19772 1 0.000246 1560.000000 0.003492 0.000017 0.001567 +19773 1 0.000194 1560.000000 -0.000541 0.003587 0.002827 +19774 1 0.000243 1560.000000 0.000993 -0.001361 0.007910 +19775 1 0.000225 1560.000000 -0.001998 0.000616 0.000904 +19776 1 0.000193 1560.000000 -0.001426 0.001808 0.001380 +19777 1 0.000209 1560.000000 0.000308 -0.001803 0.003423 +19778 1 0.000237 1560.000000 0.002108 0.002238 0.002971 +19779 1 0.000203 1560.000000 0.000318 -0.002835 0.007238 +19780 1 0.000252 1560.000000 0.000161 0.003746 0.005315 +19781 1 0.000270 1560.000000 0.001800 0.000228 0.000509 +19782 1 0.000260 1560.000000 0.001428 -0.003359 0.008255 +19783 1 0.000274 1560.000000 -0.001341 -0.002660 0.000149 +19784 1 0.000238 1560.000000 0.003444 -0.001127 0.001393 +19785 1 0.000261 1560.000000 0.001621 0.002660 0.005654 +19786 1 0.000254 1560.000000 -0.001405 0.001661 0.004561 +19787 1 0.000193 1560.000000 0.000087 0.001581 0.001722 +19788 1 0.000208 1560.000000 0.002036 0.000016 0.000116 +19789 1 0.000227 1560.000000 0.002848 -0.001920 0.007377 +19790 1 0.000200 1560.000000 0.001227 0.001595 0.007545 +19791 1 0.000252 1560.000000 -0.002521 -0.002907 0.004599 +19792 1 0.000276 1560.000000 -0.002099 -0.002937 0.005322 +19793 1 0.000209 1560.000000 0.002477 -0.001036 0.009787 +19794 1 0.000252 1560.000000 -0.001676 0.002100 0.006713 +19795 1 0.000237 1560.000000 -0.001327 -0.000294 0.002684 +19796 1 0.000240 1560.000000 0.002815 -0.000296 0.009013 +19797 1 0.000207 1560.000000 0.000929 -0.002138 0.006042 +19798 1 0.000233 1560.000000 0.000924 -0.000109 0.004590 +19799 1 0.000222 1560.000000 -0.003766 -0.000645 0.009083 +19800 1 0.000231 1560.000000 0.001227 -0.000356 0.000855 +19801 1 0.000274 1560.000000 0.003009 0.002398 0.008193 +19802 1 0.000205 1560.000000 0.001242 -0.003153 0.007862 +19803 1 0.000197 1560.000000 -0.000994 -0.000638 0.009349 +19804 1 0.000210 1560.000000 -0.001691 0.001129 0.002508 +19805 1 0.000232 1560.000000 0.002781 -0.001293 0.009780 +19806 1 0.000287 1560.000000 -0.000940 0.002231 0.008501 +19807 1 0.000218 1560.000000 -0.001155 0.001508 0.002122 +19808 1 0.000225 1560.000000 0.000763 0.002762 0.009486 +19809 1 0.000201 1560.000000 0.000009 -0.000053 0.000105 +19810 1 0.000236 1560.000000 0.001936 -0.002056 0.005113 +19811 1 0.000279 1560.000000 0.000248 -0.002418 0.006168 +19812 1 0.000270 1560.000000 -0.003555 0.000849 0.009163 +19813 1 0.000225 1560.000000 0.002795 0.002146 0.002362 +19814 1 0.000236 1560.000000 0.001843 -0.000945 0.009807 +19815 1 0.000277 1560.000000 -0.002440 -0.002890 0.009489 +19816 1 0.000266 1560.000000 -0.003812 -0.000413 0.006080 +19817 1 0.000221 1560.000000 0.001485 0.000509 0.007025 +19818 1 0.000202 1560.000000 0.000131 0.000609 0.006390 +19819 1 0.000225 1560.000000 -0.003348 0.000758 0.005300 +19820 1 0.000284 1560.000000 0.001767 0.000957 0.008259 +19821 1 0.000241 1560.000000 -0.002046 0.000037 0.006388 +19822 1 0.000261 1560.000000 -0.002180 0.002349 0.005166 +19823 1 0.000234 1560.000000 -0.001502 -0.003046 0.007437 +19824 1 0.000230 1560.000000 -0.003722 0.000898 0.008304 +19825 1 0.000226 1560.000000 0.000044 -0.000630 0.002863 +19826 1 0.000217 1560.000000 0.002597 0.001760 0.003101 +19827 1 0.000214 1560.000000 -0.002721 0.001364 0.001538 +19828 1 0.000203 1560.000000 0.002187 0.000501 0.008456 +19829 1 0.000195 1560.000000 -0.002455 0.001340 0.008322 +19830 1 0.000207 1560.000000 -0.000372 -0.000538 0.002504 +19831 1 0.000214 1560.000000 0.002913 -0.000619 0.003780 +19832 1 0.000221 1560.000000 -0.000094 0.003842 0.007756 +19833 1 0.000259 1560.000000 0.001908 -0.000666 0.000717 +19834 1 0.000209 1560.000000 -0.002513 0.000468 0.008139 +19835 1 0.000227 1560.000000 0.000051 -0.002301 0.007306 +19836 1 0.000231 1560.000000 0.000921 0.001558 0.005006 +19837 1 0.000200 1560.000000 -0.000348 -0.001185 0.009613 +19838 1 0.000266 1560.000000 -0.002276 -0.003097 0.004220 +19839 1 0.000258 1560.000000 0.002051 0.000099 0.007673 +19840 1 0.000281 1560.000000 -0.001832 0.000160 0.004914 +19841 1 0.000262 1560.000000 0.000359 -0.002289 0.002966 +19842 1 0.000212 1560.000000 -0.003179 0.001263 0.001932 +19843 1 0.000199 1560.000000 -0.002120 -0.002842 0.004074 +19844 1 0.000256 1560.000000 -0.001740 0.002552 0.003662 +19845 1 0.000193 1560.000000 0.000965 0.002119 0.000611 +19846 1 0.000267 1560.000000 -0.003238 -0.001469 0.001295 +19847 1 0.000201 1560.000000 0.000459 0.002858 0.008164 +19848 1 0.000245 1560.000000 -0.001078 0.003245 0.003476 +19849 1 0.000267 1560.000000 0.000129 0.003118 0.003736 +19850 1 0.000212 1560.000000 0.001331 0.001678 0.007153 +19851 1 0.000204 1560.000000 -0.001559 0.003518 0.005852 +19852 1 0.000201 1560.000000 -0.002266 0.000548 0.007871 +19853 1 0.000263 1560.000000 0.001847 -0.002994 0.005103 +19854 1 0.000217 1560.000000 -0.002631 -0.000769 0.001013 +19855 1 0.000262 1560.000000 -0.000953 0.003716 0.007085 +19856 1 0.000266 1560.000000 0.000368 0.002188 0.007568 +19857 1 0.000278 1560.000000 0.000856 -0.003394 0.007214 +19858 1 0.000223 1560.000000 -0.003084 -0.001764 0.001024 +19859 1 0.000249 1560.000000 0.000306 0.002475 0.003698 +19860 1 0.000255 1560.000000 0.003577 0.001421 0.009192 +19861 1 0.000212 1560.000000 0.000762 -0.002327 0.006008 +19862 1 0.000211 1560.000000 0.001389 -0.000569 0.003430 +19863 1 0.000256 1560.000000 0.001763 0.001475 0.008409 +19864 1 0.000252 1560.000000 0.000068 0.003522 0.002778 +19865 1 0.000235 1560.000000 0.002333 0.001416 0.006597 +19866 1 0.000260 1560.000000 0.000477 0.000903 0.003732 +19867 1 0.000265 1560.000000 -0.003470 -0.001237 0.004527 +19868 1 0.000202 1560.000000 0.000248 0.003032 0.008062 +19869 1 0.000228 1560.000000 -0.000355 -0.003719 0.009813 +19870 1 0.000262 1560.000000 0.001305 -0.002528 0.001263 +19871 1 0.000202 1560.000000 -0.001497 0.002137 0.006361 +19872 1 0.000199 1560.000000 0.001276 0.001167 0.005151 +19873 1 0.000283 1560.000000 0.002432 -0.002360 0.001251 +19874 1 0.000235 1560.000000 -0.001186 -0.002115 0.003657 +19875 1 0.000207 1560.000000 -0.003598 -0.001306 0.002310 +19876 1 0.000234 1560.000000 0.001433 0.000572 0.005103 +19877 1 0.000214 1560.000000 0.003109 -0.001663 0.003644 +19878 1 0.000212 1560.000000 0.002451 0.001334 0.008956 +19879 1 0.000228 1560.000000 0.003358 0.001892 0.004306 +19880 1 0.000283 1560.000000 0.001955 -0.003317 0.002822 +19881 1 0.000268 1560.000000 0.001801 0.002668 0.000141 +19882 1 0.000227 1560.000000 -0.001714 -0.001474 0.003364 +19883 1 0.000256 1560.000000 0.002800 0.002008 0.004547 +19884 1 0.000203 1560.000000 0.002055 0.002817 0.004351 +19885 1 0.000203 1560.000000 0.000774 0.000678 0.003527 +19886 1 0.000231 1560.000000 0.003102 -0.000806 0.003761 +19887 1 0.000219 1560.000000 -0.003288 0.000534 0.001300 +19888 1 0.000230 1560.000000 -0.001880 0.000189 0.005221 +19889 1 0.000239 1560.000000 -0.001069 0.003072 0.004067 +19890 1 0.000263 1560.000000 0.001011 -0.002359 0.008554 +19891 1 0.000234 1560.000000 0.001311 -0.000576 0.008131 +19892 1 0.000269 1560.000000 0.000493 0.003014 0.009831 +19893 1 0.000277 1560.000000 -0.000175 0.003401 0.004380 +19894 1 0.000218 1560.000000 -0.001773 0.002981 0.004790 +19895 1 0.000265 1560.000000 0.001280 -0.001593 0.004065 +19896 1 0.000203 1560.000000 -0.000657 -0.001780 0.003404 +19897 1 0.000267 1560.000000 0.001486 0.002818 0.008011 +19898 1 0.000194 1560.000000 0.002294 -0.002620 0.006404 +19899 1 0.000277 1560.000000 0.000693 -0.003448 0.000507 +19900 1 0.000256 1560.000000 0.001558 0.002635 0.006536 +19901 1 0.000220 1560.000000 -0.000129 -0.003419 0.004075 +19902 1 0.000213 1560.000000 0.000023 0.003202 0.008543 +19903 1 0.000285 1560.000000 -0.002539 0.002544 0.003400 +19904 1 0.000270 1560.000000 -0.000615 -0.001670 0.001913 +19905 1 0.000215 1560.000000 -0.000196 -0.001848 0.008866 +19906 1 0.000194 1560.000000 -0.001573 -0.001931 0.005858 +19907 1 0.000287 1560.000000 0.001826 -0.000944 0.000988 +19908 1 0.000215 1560.000000 -0.001178 -0.002268 0.001799 +19909 1 0.000192 1560.000000 -0.000542 0.001476 0.008003 +19910 1 0.000196 1560.000000 0.001782 -0.000300 0.000216 +19911 1 0.000235 1560.000000 -0.000422 -0.000149 0.007324 +19912 1 0.000213 1560.000000 -0.001505 -0.001229 0.002803 +19913 1 0.000214 1560.000000 -0.001881 -0.002535 0.005837 +19914 1 0.000209 1560.000000 -0.000194 -0.000957 0.004538 +19915 1 0.000196 1560.000000 0.000877 0.000388 0.003723 +19916 1 0.000215 1560.000000 -0.000762 -0.001214 0.001397 +19917 1 0.000248 1560.000000 -0.001226 0.001842 0.009600 +19918 1 0.000281 1560.000000 0.003226 0.002031 0.002732 +19919 1 0.000256 1560.000000 -0.003042 -0.001805 0.009470 +19920 1 0.000212 1560.000000 -0.003245 -0.001670 0.006907 +19921 1 0.000225 1560.000000 0.000487 -0.001905 0.007535 +19922 1 0.000278 1560.000000 -0.001848 0.001598 0.009574 +19923 1 0.000288 1560.000000 -0.001485 -0.002399 0.007973 +19924 1 0.000216 1560.000000 0.001232 -0.002443 0.000415 +19925 1 0.000198 1560.000000 -0.003117 0.001250 0.009208 +19926 1 0.000264 1560.000000 -0.000575 -0.001821 0.005444 +19927 1 0.000270 1560.000000 0.001688 0.002553 0.007853 +19928 1 0.000225 1560.000000 0.000693 -0.000524 0.003969 +19929 1 0.000229 1560.000000 -0.002572 0.000256 0.003634 +19930 1 0.000236 1560.000000 -0.001192 -0.001354 0.008475 +19931 1 0.000277 1560.000000 -0.001318 0.003361 0.009592 +19932 1 0.000273 1560.000000 0.002254 0.000847 0.006608 +19933 1 0.000253 1560.000000 -0.003229 -0.001493 0.000548 +19934 1 0.000221 1560.000000 0.002321 0.001015 0.000164 +19935 1 0.000209 1560.000000 0.001845 -0.001675 0.009434 +19936 1 0.000258 1560.000000 -0.001460 -0.000778 0.008982 +19937 1 0.000195 1560.000000 -0.000105 0.000456 0.000441 +19938 1 0.000199 1560.000000 -0.000410 0.002059 0.007657 +19939 1 0.000204 1560.000000 -0.002126 -0.001814 0.001987 +19940 1 0.000258 1560.000000 -0.000047 -0.000555 0.000962 +19941 1 0.000227 1560.000000 0.001002 0.001685 0.008393 +19942 1 0.000228 1560.000000 0.002008 -0.001421 0.001786 +19943 1 0.000271 1560.000000 0.001714 -0.002089 0.002291 +19944 1 0.000205 1560.000000 -0.000968 0.002884 0.000611 +19945 1 0.000204 1560.000000 -0.001227 -0.002210 0.005301 +19946 1 0.000221 1560.000000 0.002629 -0.001472 0.009817 +19947 1 0.000287 1560.000000 0.003698 -0.001076 0.004690 +19948 1 0.000201 1560.000000 0.000283 -0.002481 0.001119 +19949 1 0.000238 1560.000000 0.002664 -0.002754 0.000929 +19950 1 0.000203 1560.000000 0.001186 0.003634 0.001679 +19951 1 0.000258 1560.000000 0.001354 0.000712 0.003762 +19952 1 0.000236 1560.000000 -0.003424 -0.001632 0.005202 +19953 1 0.000196 1560.000000 -0.002017 0.002288 0.008486 +19954 1 0.000258 1560.000000 0.000699 -0.002127 0.009174 +19955 1 0.000280 1560.000000 -0.003516 0.001573 0.002196 +19956 1 0.000252 1560.000000 0.000559 -0.002283 0.008425 +19957 1 0.000248 1560.000000 0.001080 -0.001452 0.000342 +19958 1 0.000200 1560.000000 -0.001178 -0.000749 0.007211 +19959 1 0.000252 1560.000000 0.001848 0.000370 0.003364 +19960 1 0.000202 1560.000000 -0.001756 0.001309 0.005660 +19961 1 0.000287 1560.000000 0.002276 0.001964 0.009240 +19962 1 0.000270 1560.000000 -0.002722 0.002377 0.000138 +19963 1 0.000201 1560.000000 0.000273 0.001734 0.002117 +19964 1 0.000247 1560.000000 -0.001234 0.002693 0.007387 +19965 1 0.000216 1560.000000 -0.000574 -0.001814 0.003056 +19966 1 0.000214 1560.000000 0.001082 -0.000118 0.007543 +19967 1 0.000198 1560.000000 0.000872 -0.000828 0.000617 +19968 1 0.000239 1560.000000 0.002587 0.000932 0.006981 +19969 1 0.000193 1560.000000 0.001119 0.003664 0.006192 +19970 1 0.000208 1560.000000 -0.002833 0.002046 0.003041 +19971 1 0.000208 1560.000000 -0.000632 -0.002640 0.004118 +19972 1 0.000288 1560.000000 -0.001971 -0.000101 0.009826 +19973 1 0.000213 1560.000000 -0.000835 -0.001877 0.000953 +19974 1 0.000192 1560.000000 0.000357 -0.000454 0.001912 +19975 1 0.000218 1560.000000 0.003063 -0.001638 0.008629 +19976 1 0.000273 1560.000000 -0.002426 -0.001254 0.002722 +19977 1 0.000280 1560.000000 -0.002609 0.001609 0.005802 +19978 1 0.000225 1560.000000 0.000432 -0.000884 0.004952 +19979 1 0.000222 1560.000000 -0.002711 0.001824 0.001354 +19980 1 0.000219 1560.000000 0.001300 -0.001689 0.001094 +19981 1 0.000196 1560.000000 0.002649 0.002044 0.008054 +19982 1 0.000278 1560.000000 0.000433 0.003322 0.008212 +19983 1 0.000216 1560.000000 -0.001584 -0.001766 0.002120 +19984 1 0.000204 1560.000000 0.001143 0.000976 0.001686 +19985 1 0.000208 1560.000000 -0.002481 0.001943 0.005111 +19986 1 0.000270 1560.000000 -0.002097 0.002391 0.003665 +19987 1 0.000213 1560.000000 0.002486 -0.001057 0.001452 +19988 1 0.000258 1560.000000 -0.003282 -0.001986 0.001270 +19989 1 0.000231 1560.000000 0.002804 -0.000974 0.004409 +19990 1 0.000193 1560.000000 0.000048 -0.001120 0.006233 +19991 1 0.000240 1560.000000 0.000898 0.002289 0.006843 +19992 1 0.000231 1560.000000 0.001333 0.002892 0.005815 +19993 1 0.000201 1560.000000 -0.000500 0.000185 0.006474 +19994 1 0.000253 1560.000000 -0.002348 0.000513 0.001093 +19995 1 0.000204 1560.000000 -0.001873 -0.000625 0.007402 +19996 1 0.000221 1560.000000 0.003591 -0.000732 0.002128 +19997 1 0.000241 1560.000000 0.002089 0.003237 0.000305 +19998 1 0.000219 1560.000000 -0.002840 0.000644 0.009180 +19999 1 0.000200 1560.000000 -0.003677 -0.000670 0.006216 +20000 1 0.000201 1560.000000 0.002765 0.002443 0.001843 diff --git a/examples/granular/spheresSTLgeneration.data b/examples/granular/spheresSTLgeneration.data new file mode 100644 index 0000000000..960c7d357b --- /dev/null +++ b/examples/granular/spheresSTLgeneration.data @@ -0,0 +1,21 @@ +#LAMMPS data file created by matlab. +10 atoms + +1 atom types + +-0.005000 0.005000 xlo xhi +-0.005000 0.005000 ylo yhi +-0.001000 0.020000 zlo zhi + +Atoms + +1 1 0.000249 1560.000000 0.000469 -0.000120 0.008380 +2 1 0.000260 1560.000000 -0.001811 0.000425 0.004090 +3 1 0.000225 1560.000000 -0.001371 0.000426 0.002952 +4 1 0.000252 1560.000000 0.000928 -0.000089 0.004118 +5 1 0.000210 1560.000000 0.000208 0.000384 0.000842 +6 1 0.000218 1560.000000 -0.002456 -0.000587 0.003834 +7 1 0.000201 1560.000000 -0.000278 0.003459 0.003445 +8 1 0.000231 1560.000000 -0.002123 0.003188 0.004799 +9 1 0.000268 1560.000000 -0.000338 -0.001557 0.007382 +10 1 0.000244 1560.000000 0.002537 0.002151 0.005999 diff --git a/src/GRANULAR/fix_wall_gran.cpp b/src/GRANULAR/fix_wall_gran.cpp index 3336a8a4d7..41db281568 100644 --- a/src/GRANULAR/fix_wall_gran.cpp +++ b/src/GRANULAR/fix_wall_gran.cpp @@ -496,6 +496,7 @@ void FixWallGran::post_force(int /*vflag*/) model->dx[2] = dz; model->radi = radius[i]; model->radj = rwall; + if (model->beyond_contact) model->touch = history_one[i][0]; touchflag = model->check_contact(); diff --git a/src/GRANULAR/fix_wall_gran.h b/src/GRANULAR/fix_wall_gran.h index cd1e8778c3..f8d351051c 100644 --- a/src/GRANULAR/fix_wall_gran.h +++ b/src/GRANULAR/fix_wall_gran.h @@ -50,14 +50,15 @@ class FixWallGran : public Fix { int maxsize_restart() override; void reset_dt() override; + // for granular model choices + class Granular_NS::GranularModel *model; // MOVED HERE FROM PROTECTED FOR MDR MODEL + void clear_stored_contacts(); // MOVED HERE FROM PROTECTED FOR MDR MODEL + protected: int wallstyle, wiggle, wshear, axis; int nlevels_respa; bigint time_origin; - // for granular model choices - class Granular_NS::GranularModel *model; - double lo, hi, cylradius; double amplitude, period, omega, vshear; double dt; @@ -86,7 +87,7 @@ class FixWallGran : public Fix { int store; - void clear_stored_contacts(); + }; } // namespace LAMMPS_NS diff --git a/src/GRANULAR/fix_wall_gran_region.cpp b/src/GRANULAR/fix_wall_gran_region.cpp index b90620f3aa..7eba3bdfb3 100644 --- a/src/GRANULAR/fix_wall_gran_region.cpp +++ b/src/GRANULAR/fix_wall_gran_region.cpp @@ -29,6 +29,7 @@ #include "region.h" #include "update.h" #include "variable.h" +#include using namespace LAMMPS_NS; using namespace Granular_NS; @@ -129,6 +130,8 @@ void FixWallGranRegion::post_force(int /*vflag*/) if (update->setupflag) history_update = 0; model->history_update = history_update; + //std::cout << (uint64_t)this << ", " << (uint64_t)model << std::endl; + // if just reneighbored: // update rigid body masses for owned atoms if using FixRigid // body[i] = which body atom I is in, -1 if none @@ -228,6 +231,9 @@ void FixWallGranRegion::post_force(int /*vflag*/) model->radi = radius[i]; model->radj = region->contact[ic].radius; model->r = region->contact[ic].r; + model->i = i; // Added for MDR + model->j = ic; // Added for MDR + if (model->beyond_contact) model->touch = history_many[i][c2r[ic]][0]; touchflag = model->check_contact(); diff --git a/src/GRANULAR/fix_wall_gran_region.h b/src/GRANULAR/fix_wall_gran_region.h index 72e1080268..e9e24415bc 100644 --- a/src/GRANULAR/fix_wall_gran_region.h +++ b/src/GRANULAR/fix_wall_gran_region.h @@ -44,23 +44,29 @@ class FixWallGranRegion : public FixWallGran { int size_restart(int) override; int maxsize_restart() override; + class Region *region; // MOVED FROM PRIVATE TO PUBLIC FOR MDR MODEL + void update_contacts(int, int); // MOVED FROM PRIVATE TO PUBLIC FOR MDR MODEL + int *ncontact; // MOVED FROM PRIVATE TO PUBLIC FOR MDR MODEL + int **walls; // MOVED FROM PRIVATE TO PUBLIC FOR MDR MODEL + int *c2r; // MOVED FROM PRIVATE TO PUBLIC FOR MDR MODEL + double ***history_many; // MOVED FROM PRIVATE TO PUBLIC FOR MDR MODEL + int tmax; // MOVED FROM PRIVATE TO PUBLIC FOR MDR MODEL + private: - class Region *region; + int nregion; // shear history for multiple contacts per particle - int tmax; // max # of region walls one particle can touch - int *ncontact; // # of shear contacts per particle - int **walls; // which wall each contact is with - double ***history_many; // history per particle per contact - int *c2r; // contact to region mapping + + + // c2r[i] = index of Ith contact in // region-contact[] list of contacts int motion_resetflag; // used by restart to indicate that region // vel info is to be reset - void update_contacts(int, int); + }; } // namespace LAMMPS_NS diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index f049d2b5e2..bf3d045c2f 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -16,8 +16,14 @@ #include "error.h" #include "granular_model.h" #include "math_const.h" +#include "atom.h" +#include "csv_writer.h" +#include "update.h" #include +#include +#include +#include using namespace LAMMPS_NS; using namespace Granular_NS; @@ -381,3 +387,767 @@ void GranSubModNormalJKR::set_fncrit() { Fncrit = fabs(Fne + 2.0 * F_pulloff); } + +/* ---------------------------------------------------------------------- + MDR contact model + + Contributing authors: + William Zunker (MIT), Sachith Dunatunga (MIT), + Dan Bolintineanu (SNL), Joel Clemmer (SNL) +------------------------------------------------------------------------- */ + +GranSubModNormalMDR::GranSubModNormalMDR(GranularModel *gm, LAMMPS *lmp) : + GranSubModNormal(gm, lmp) +{ + num_coeffs = 6; // Young's Modulus, Poisson's ratio, yield stress, effective surface energy, psi_b, coefficent of restitution + contact_radius_flag = 1; + size_history = 26; + + nondefault_history_transfer = 1; + transfer_history_factor = new double[size_history]; + //transfer_history_factor[0] = +1; + for (int i = 0; i < size_history; i++) { + transfer_history_factor[i] = +1; + } +} + +/* ---------------------------------------------------------------------- */ + +void GranSubModNormalMDR::coeffs_to_local() +{ + E = coeffs[0]; // Young's modulus + nu = coeffs[1]; // Poisson's ratio + Y = coeffs[2]; // yield stress + gamma = coeffs[3]; // effective surface energy + psi_b = coeffs[4]; // bulk response trigger based on ratio of remaining free area: A_{free}/A_{total} + CoR = coeffs[5]; // coefficent of restitution + + if (E <= 0.0) error->all(FLERR, "Illegal MDR normal model, Young's modulus must be greater than 0"); + if (nu < 0.0 || nu > 0.5) error->all(FLERR, "Illegal MDR normal model, Poisson's ratio must be between 0 and 0.5"); + if (Y < 0.0) error->all(FLERR, "Illegal MDR normal model, yield stress must be greater than or equal to 0"); + if (gamma < 0.0) error->all(FLERR, "Illegal MDR normal model, effective surface energy must be greater than or equal to 0"); + if (psi_b < 0.0 || psi_b > 1.0) error->all(FLERR, "Illegal MDR normal model, psi_b must be between 0 and 1.0"); + if (CoR < 0.0 || CoR > 1.0) error->all(FLERR, "Illegal MDR normal model, coefficent of restitution must be between 0 and 1.0"); +} + +/* ---------------------------------------------------------------------- */ + +double GranSubModNormalMDR::calculate_forces() + +{ + // To understand the structure of the overall code it is important to consider + // the following: + // + // The MDR contact model was developed by imagining individual particles being + // squished between a number of rigid flats (references below). To allow + // for many interacting particles, we extend the idea of isolated particles surrounded + // by rigid flats. In particular, we imagine placing rigid flats at the overlap + // midpoints between particles. The force is calculated seperately on both sides + // of the contact assuming interaction with a rigid flat. The two forces are then + // averaged on either side of the contact to determine the final force. If the + // contact is between a particle and wall then only one force evaluation is required. + // + // Zunker and Kamrin, 2024, Part I: https://doi.org/10.1016/j.jmps.2023.105492 + // Zunker and Kamrin, 2024, Part II: https://doi.org/10.1016/j.jmps.2023.105493 + + const int itag_true = atom->tag[gm->i]; // true i particle tag + const int jtag_true = atom->tag[gm->j]; // true j particle tag + const int i_true = gm->i; // true i particle index + const int j_true = gm->j; // true j particle index + const double radi_true = gm->radi; // true i particle initial radius + const double radj_true = gm->radj; // true j particle initial radius + + F = 0.0; // average force + double F0 = 0.0; // force on contact side 0 + double F1 = 0.0; // force on contact side 1 + double R0 = 0.0; + double R1 = 0.0; + int i0 = 0; + int i1 = 0; + double delta = gm->delta; // apparent overlap + + //if (gm->contact_type == PAIR) delta = gm->delta/2.0; // half displacement to imagine interaction with rigid flat + //std::cout << "Normal force is called for: " << i_true << ", " << j_true << std::endl; + //std::cout << "Contact model has been entered " << gm->contact_type << ", " << PAIR << ", " << WALL << ", " << WALLREGION << ", " << gm->itype << ", " << gm->jtype << ", " << gm->delta << std::endl; + + // initialize indexing in history array of different constact history variables + const int delta_offset_0 = 0; // apparent overlap + const int delta_offset_1 = 1; + const int deltao_offset_0 = 2; // displacement + const int deltao_offset_1 = 3; + const int delta_MDR_offset_0 = 4; // MDR apparent overlap + const int delta_MDR_offset_1 = 5; + const int delta_BULK_offset_0 = 6; // bulk displacement + const int delta_BULK_offset_1 = 7; + const int deltamax_MDR_offset_0 = 8; // maximum MDR apparent overlap + const int deltamax_MDR_offset_1 = 9; + const int Yflag_offset_0 = 10; // yield flag + const int Yflag_offset_1 = 11; + const int deltaY_offset_0 = 12; // yield displacement + const int deltaY_offset_1 = 13; + const int cA_offset_0 = 14; // contact area intercept + const int cA_offset_1 = 15; + const int aAdh_offset_0 = 16; // adhesive contact radius + const int aAdh_offset_1 = 17; + const int Ac_offset_0 = 18; // contact area + const int Ac_offset_1 = 19; + const int eps_bar_offset_0 = 20; // volume-averaged infinitesimal strain tensor + const int eps_bar_offset_1 = 21; + const int penalty_offset_ = 22; // contact penalty + const int deltamax_offset_ = 23; + const int deltap_offset_0 = 24; + const int deltap_offset_1 = 25; + + + // initialize particle history variables + int tmp1, tmp2; + int index_Ro = atom->find_custom("Ro",tmp1,tmp2); // initial radius + int index_Vcaps = atom->find_custom("Vcaps",tmp1,tmp2); // spherical cap volume from intersection of apparent radius particle and contact planes + int index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); // geometric particle volume of apparent particle after removing spherical cap volume + int index_Velas = atom->find_custom("Velas",tmp1,tmp2); // particle volume from linear elasticity + int index_eps_bar = atom->find_custom("eps_bar",tmp1,tmp2); // volume-averaged infinitesimal strain tensor + int index_dRnumerator = atom->find_custom("dRnumerator",tmp1,tmp2); // summation of numerator terms in calculation of dR + int index_dRdenominator = atom->find_custom("dRdenominator",tmp1,tmp2); // summation of denominator terms in calculation of dR + int index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); // total area involved in contacts: Acon^{n} + int index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); // total area involved in contacts: Acon^{n+1} + int index_Atot = atom->find_custom("Atot",tmp1,tmp2); // total particle area + int index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); // running sum of contact area minus cap area + int index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); // change in mean surface displacement + int index_psi = atom->find_custom("psi",tmp1,tmp2); // ratio of free surface area to total surface area + int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); // xx-component of the stress tensor, not necessary for force calculation + int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); // yy-component of the stress tensor, not necessary for force calculation + int index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); // zz-component of the stress tensor, not necessary for force calculation + int index_contacts = atom->find_custom("contacts",tmp1,tmp2); // total contacts on particle + int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); // total contacts on particle + double * Rinitial = atom->dvector[index_Ro]; + double * Vgeo = atom->dvector[index_Vgeo]; + double * Velas = atom->dvector[index_Velas]; + double * Vcaps = atom->dvector[index_Vcaps]; + double * eps_bar = atom->dvector[index_eps_bar]; + double * dRnumerator = atom->dvector[index_dRnumerator]; + double * dRdenominator = atom->dvector[index_dRdenominator]; + double * Acon0 = atom->dvector[index_Acon0]; + double * Acon1 = atom->dvector[index_Acon1]; + double * Atot = atom->dvector[index_Atot]; + double * Atot_sum = atom->dvector[index_Atot_sum]; + double * ddelta_bar = atom->dvector[index_ddelta_bar]; + double * psi = atom->dvector[index_psi]; + double * sigmaxx = atom->dvector[index_sigmaxx]; + double * sigmayy = atom->dvector[index_sigmayy]; + double * sigmazz = atom->dvector[index_sigmazz]; + double * contacts = atom->dvector[index_contacts]; + double * adhesive_length = atom->dvector[index_adhesive_length]; + + + double * history = & gm->history[history_index]; // load in all history variables + + // Rigid flat placement scheme + double * deltamax_offset = & history[deltamax_offset_]; + double deltamax = *deltamax_offset; + double * deltap_offset0 = & history[deltap_offset_0]; + double * deltap_offset1 = & history[deltap_offset_1]; + double deltap0 = *deltap_offset0; + double deltap1 = *deltap_offset1; + + if (gm->delta >= *deltamax_offset) *deltamax_offset = gm->delta; + deltamax = *deltamax_offset; + + for (int contactSide = 0; contactSide < 2; contactSide++) { + + double * delta_offset; + double * deltao_offset; + double * delta_MDR_offset; + double * delta_BULK_offset; + double * deltamax_MDR_offset; + double * Yflag_offset; + double * deltaY_offset; + double * cA_offset; + double * aAdh_offset; + double * Ac_offset; + double * eps_bar_offset; + double * penalty_offset; + double * deltap_offset; + + double overlap_limit = 0.75; + + if (contactSide == 0) { + if (gm->contact_type == PAIR) { + if (itag_true > jtag_true) { + gm->i = i_true; + gm->j = j_true; + gm->radi = radi_true; + gm->radj = radj_true; + } else { + gm->i = j_true; + gm->j = i_true; + gm->radi = radj_true; + gm->radj = radi_true; + } + R0 = gm->radi; + R1 = gm->radj; + i0 = gm->i; + i1 = gm->j; + + double delta_geo; + double delta_geo_alt; + double delta_geoOpt1 = deltamax*(deltamax - 2.0*R1)/(2.0*(deltamax - R0 - R1)); + double delta_geoOpt2 = deltamax*(deltamax - 2.0*R0)/(2.0*(deltamax - R0 - R1)); + (gm->radi < gm->radj) ? delta_geo = MAX(delta_geoOpt1,delta_geoOpt2) : delta_geo = MIN(delta_geoOpt1,delta_geoOpt2); + (gm->radi > gm->radj) ? delta_geo_alt = MAX(delta_geoOpt1,delta_geoOpt2) : delta_geo_alt = MIN(delta_geoOpt1,delta_geoOpt2); + + if (delta_geo/gm->radi > overlap_limit) { + delta_geo = gm->radi*overlap_limit; + } else if (delta_geo_alt/gm->radj > overlap_limit) { + delta_geo = deltamax - gm->radj*overlap_limit; + } + + double deltap = deltap0 + deltap1; + delta = delta_geo + (deltap0 - delta_geo)/(deltap - deltamax)*(gm->delta-deltamax); + + //std::cout << "CS 0: " << gm->radi << ", " << gm->radj << ", gm->delta " << gm->delta << ", delta " << delta << ", deltamax " << deltamax << ", delta_geo " << delta_geo << ", delta_geo_alt " << delta_geo_alt << ", delta_geo/Ri " << delta_geo/gm->radi << ", delta_geo_alt/Rj " << delta_geo_alt/gm->radj << ", delta_geoOpt1 " << delta_geoOpt1 << ", delta_geoOpt2 " << delta_geoOpt2 << ", deltamax-delta " << (deltamax-gm->delta) << std::endl; + } + delta_offset = & history[delta_offset_0]; + deltao_offset = & history[deltao_offset_0]; + delta_MDR_offset = & history[delta_MDR_offset_0]; + delta_BULK_offset = & history[delta_BULK_offset_0]; + deltamax_MDR_offset = & history[deltamax_MDR_offset_0]; + Yflag_offset = & history[Yflag_offset_0]; + deltaY_offset = & history[deltaY_offset_0]; + cA_offset = & history[cA_offset_0]; + aAdh_offset = & history[aAdh_offset_0]; + Ac_offset = & history[Ac_offset_0]; + eps_bar_offset = & history[eps_bar_offset_0]; + deltap_offset = & history[deltap_offset_0]; + } else { + if (gm->contact_type != PAIR) break; // contact with particle-wall requires only one evaluation + if (itag_true < jtag_true) { + gm->i = i_true; + gm->j = j_true; + gm->radi = radi_true; + gm->radj = radj_true; + } else { + gm->i = j_true; + gm->j = i_true; + gm->radi = radj_true; + gm->radj = radi_true; + } + + double delta_geo; + double delta_geo_alt; + double delta_geoOpt1 = deltamax*(deltamax - 2.0*R1)/(2.0*(deltamax - R0 - R1)); + double delta_geoOpt2 = deltamax*(deltamax - 2.0*R0)/(2.0*(deltamax - R0 - R1)); + (gm->radi < gm->radj) ? delta_geo = MAX(delta_geoOpt1,delta_geoOpt2) : delta_geo = MIN(delta_geoOpt1,delta_geoOpt2); + (gm->radi > gm->radj) ? delta_geo_alt = MAX(delta_geoOpt1,delta_geoOpt2) : delta_geo_alt = MIN(delta_geoOpt1,delta_geoOpt2); + + if (delta_geo/gm->radi > overlap_limit) { + delta_geo = gm->radi*overlap_limit; + } else if (delta_geo_alt/gm->radj > overlap_limit) { + delta_geo = deltamax - gm->radj*overlap_limit; + } + + double deltap = deltap0 + deltap1; + delta = delta_geo + (deltap1 - delta_geo)/(deltap - deltamax)*(gm->delta-deltamax); + + //std::cout << "CS 1: " << gm->radi << ", " << gm->radj << ", gm->delta " << gm->delta << ", delta " << delta << ", deltamax " << deltamax << ", delta_geo " << delta_geo << ", delta_geo_alt " << delta_geo_alt << ", delta_geo/Ri " << delta_geo/gm->radi << ", delta_geo_alt/Rj " << delta_geo_alt/gm->radj << ", delta_geoOpt1 " << delta_geoOpt1 << ", delta_geoOpt2 " << delta_geoOpt2 << ", deltamax-delta " << (deltamax-gm->delta) << std::endl; + + delta_offset = & history[delta_offset_1]; + deltao_offset = & history[deltao_offset_1]; + delta_MDR_offset = & history[delta_MDR_offset_1]; + delta_BULK_offset = & history[delta_BULK_offset_1]; + deltamax_MDR_offset = & history[deltamax_MDR_offset_1]; + Yflag_offset = & history[Yflag_offset_1]; + deltaY_offset = & history[deltaY_offset_1]; + cA_offset = & history[cA_offset_1]; + aAdh_offset = & history[aAdh_offset_1]; + Ac_offset = & history[Ac_offset_1]; + eps_bar_offset = & history[eps_bar_offset_1]; + deltap_offset = & history[deltap_offset_1]; + } + + // temporary i and j indices + const int i = gm->i; + const int j = gm->j; + + //std::cout << lmp->update->ntimestep << std::endl; + + // material and geometric property definitions + // E, nu, Y gamma , psi_b, and CoR are already defined. + const double G = E/(2.0*(1.0+nu)); // shear modulus + const double kappa = E/(3.0*(1.0-2.0*nu)); // bulk modulus + const double Eeff = E/(1.0-pow(nu,2.0)); // composite plane strain modulus + + const double Ro = Rinitial[i]; // initial radius + const double R = gm->radi; // apparent radius + + // kinematics + const double ddelta = delta - *delta_offset; + *delta_offset = delta; + + const double deltao = delta - (R - Ro); + const double ddeltao = deltao - *deltao_offset; + *deltao_offset = deltao; + + double ddelta_MDR; + double ddelta_BULK; + if ( psi[i] < psi_b ) { // if true, bulk response has triggered, split displacement increment between the MDR and BULK components + ddelta_MDR = std::min(ddelta-ddelta_bar[i], delta-*delta_MDR_offset); + ddelta_BULK = ddelta_bar[i]; + } else { // if false, no bulk response, full displacement increment goes to the MDR component + ddelta_BULK = 0.0; + ddelta_MDR = ddelta; + } + const double delta_MDR = *delta_MDR_offset + ddelta_MDR; // MDR displacement + *delta_MDR_offset = delta_MDR; // Update old MDR displacement + const double delta_BULK = std::max(0.0,*delta_BULK_offset+ddelta_BULK); // bulk displacement + *delta_BULK_offset = delta_BULK; // update old bulk displacement + + if (delta_MDR > *deltamax_MDR_offset) *deltamax_MDR_offset = delta_MDR; + const double deltamax_MDR = *deltamax_MDR_offset; + + const double pY = Y*(1.75*exp(-4.4*deltamax_MDR/R) + 1.0); // Set value of average pressure along yield surface + if ( *Yflag_offset == 0.0 && delta_MDR >= deltamax_MDR ) { + const double phertz = 4*Eeff*sqrt(delta_MDR)/(3*M_PI*sqrt(R)); + if ( phertz > pY ) { + *Yflag_offset = 1.0; + *deltaY_offset = delta_MDR; + *cA_offset = M_PI*(pow(*deltaY_offset,2.0) - *deltaY_offset*R); + } + } + + //if (i_true == 167 && j_true == 204) { + //std::cout << "i " << i << " | j " << j << " | delta_BULK: " << delta_BULK << " | delta_MDR " << delta_MDR << " | ddelta_BULK " << ddelta_BULK << " | ddelta_MDR " << ddelta_MDR << std::endl; + //} + + //std::cout << "Yield Flag: " << *Yflag_offset << ", " << R << std::endl; + + // MDR force calculation + double F_MDR; + double A; // height of elliptical indenter + double B; // width of elliptical indenter + double deltae1D; // transformed elastic displacement + double deltaR; // displacement correction + double amax; // maximum experienced contact radius + const double cA = *cA_offset; // contact area intercept + + if ( *Yflag_offset == 0.0 ) { // elastic contact + A = 4.0*R; + B = 2.0*R; + deltae1D = delta_MDR; + (deltae1D > 0) ? amax = sqrt(deltae1D*R) : amax = 0.0; + } else { // plastic contact + amax = sqrt((2.0*deltamax_MDR*R - pow(deltamax_MDR,2.0)) + cA/M_PI); + A = 4.0*pY/Eeff*amax; + B = 2.0*amax; + const double deltae1Dmax = A/2.0; // maximum transformed elastic displacement + const double Fmax = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltae1Dmax/A) - (1.0 - 2.0*deltae1Dmax/A)*sqrt(4.0*deltae1Dmax/A - 4.0*pow(deltae1Dmax,2.0)/pow(A,2.0))); // force caused by full submersion of elliptical indenter to depth of A/2 + const double zR = R - (deltamax_MDR - deltae1Dmax); // depth of particle center + deltaR = (Fmax*(2*pow(amax,2.0)*(-1 + nu) - (-1 + 2*nu)*zR*(-zR + sqrt(pow(amax,2.0) + pow(zR,2.0)))))/((M_PI*pow(amax,2.0))*2*G*sqrt(pow(amax,2.0) + pow(zR,2.0))); + deltae1D = (delta_MDR - deltamax_MDR + deltae1Dmax + deltaR)/(1 + deltaR/deltae1Dmax); // transformed elastic displacement + + // added for rigid flat placement + *deltap_offset = deltamax_MDR - (deltae1Dmax + deltaR); + //std::cout << *deltap_offset << std::endl; + } + + //std::cout << psi_b << ", " << psi[i] << ", " << A << ", " << B << ", " << pY << ", " << amax << " || " << deltao << ", " << delta << ", " << ddelta << ", " << *delta_offset << ", " << ddelta_bar[i] << " || " << delta_MDR << ", " << ddelta_MDR << ", " << *delta_MDR_offset << ", " << deltamax_MDR << " || " << delta_BULK << ", " << ddelta_BULK << ", " << *delta_BULK_offset << " || " << R << std::endl; + //std::cout << i << ", " << j << ", " << A << ", " << B << " || " << deltao << ", " << delta << ", " << ddelta << ", " << R << ", " << M_PI*pow(amax,2.0) << std::endl; + + double a_na; + double a_fac = 0.99; + (deltae1D >= 0.0) ? a_na = B*sqrt(A - deltae1D)*sqrt(deltae1D)/A : a_na = 0.0; + double aAdh = *aAdh_offset; + if (aAdh > a_fac*amax) aAdh = a_fac*amax; + + //if (i_true == 4 && j_true == 52){ + //std::cout << "CS: " << contactSide << ", aAdh: " << aAdh << ", deltae1D: " << deltae1D << ", A: " << A << ", B:" << B << ", amax: " << amax << ", deltae1D: " << deltae1D << ", R: " << R << std::endl; + //} + + if ( gamma > 0.0 ) { // adhesive contact + double g_aAdh; + + if (delta_MDR == deltamax_MDR || a_na >= aAdh ) { // case 1: no tensile springs, purely compressive contact + (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltae1D/A) - (1.0 - 2.0*deltae1D/A)*sqrt(4.0*deltae1D/A - 4.0*pow(deltae1D,2.0)/pow(A,2.0))); + if ( std::isnan(F_MDR) ) { + std::cout << "F_MDR is NaN, case 1: no tensile springs" << std::endl; + //std::cout << "Normal model: " << gm->delta << ", " << ddelta << ", " << gm->radi << ", " << gm->radj << " | delta: " << delta0 << ", " << delta1 << " | delta2_offset: " << *delta2_offset0 << ", " << *delta2_offset1 << "| dde: " << dde0 << ", " << dde1 << "| Fold: " << F0old << ", " << F1old << " | a: " << a0 << ", " << a1 << " | k_BULK: " << k_BULK0 << ", " << k_BULK1 << " | h_BULK: " << h_BULK0 << ", " << h_BULK1 << std::endl; + std::cout << "i_true: " << i_true << ", j_true: " << j_true << ", i_tag: " << atom->tag[i_true] << ", j_tag: " << atom->tag[j_true] << ", contact type: " << gm->contact_type << ", deltae1D: " << deltae1D << ", A: " << A << ", B: " << B << ", amax: " << amax << ", deltamax_MDR: " << deltamax_MDR << ", R: " << R << std::endl; + std::exit(1); + } + *aAdh_offset = a_fac*a_na; + } else { + const double lmax = sqrt(2.0*M_PI*aAdh*gamma/Eeff); + g_aAdh = A/2 - A/B*sqrt(pow(B,2.0)/4 - pow(aAdh,2.0)); + const double acrit = (-((pow(B,2)*gamma*M_PI)/(pow(A,2)*Eeff)) + (pow(2,0.3333333333333333)*pow(B,4)*pow(gamma,2)*pow(M_PI,1.6666666666666667))/ + (pow(A,2)*pow(Eeff,2)*pow((27*pow(A,4)*pow(B,4)*gamma)/Eeff - (2*pow(B,6)*pow(gamma,3)*pow(M_PI,2))/pow(Eeff,3) + (3*sqrt(3)*sqrt(27*pow(A,8)*pow(B,8)*pow(Eeff,2)*pow(gamma,2) - + 4*pow(A,4)*pow(B,10)*pow(gamma,4)*pow(M_PI,2)))/pow(Eeff,2),0.3333333333333333)) + (pow(M_PI/2.,0.3333333333333333)*pow((27*pow(A,4)*pow(B,4)*gamma)/Eeff - + (2*pow(B,6)*pow(gamma,3)*pow(M_PI,2))/pow(Eeff,3) + (3*sqrt(3)*sqrt(27*pow(A,8)*pow(B,8)*pow(Eeff,2)*pow(gamma,2) - 4*pow(A,4)*pow(B,10)*pow(gamma,4)*pow(M_PI,2)))/ + pow(Eeff,2),0.3333333333333333))/pow(A,2))/6; + + if ( (deltae1D + lmax - g_aAdh) >= 0.0) { // case 2: tensile springs, but not exceeding critical length --> deltae + lmax - g(aAdhes) >= 0 + //if (contactSide == 0) { + //std::cout << "Case 2 tensile springs not exceeding critical length, R " << R << "deltae1D " << deltae1D << " , lmax " << lmax << " , g_adh" << g_aAdh << " sum " << (deltae1D + lmax - g_aAdh) << std::endl; + //} + const double deltaeAdh = g_aAdh; + const double F_na = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltaeAdh/A) - (1.0 - 2.0*deltaeAdh/A)*sqrt(4.0*deltaeAdh/A - 4.0*pow(deltaeAdh,2.0)/pow(A,2.0))); + const double F_Adhes = 2.0*Eeff*(deltae1D - deltaeAdh)*aAdh; + F_MDR = F_na + F_Adhes; + if ( std::isnan(F_MDR) ) std::cout << "F_MDR is NaN, case 2: tensile springs, but not exceeding critical length" << std::endl; + + } else { // case 3: tensile springs exceed critical length --> deltae + lmax - g(aAdhes) = 0 + //if (contactSide == 0) { + //std::cout << "Case 3 tensile springs exceed critical length, R " << R << " deltae1D " << deltae1D << " , lmax " << lmax << " , g_adh " << g_aAdh << " sum " << (deltae1D + lmax - g_aAdh) << std::endl; + //} + + if ( aAdh < acrit ) { + aAdh = 0.0; + F_MDR = 0.0; + } else { + // newton-raphson to find aAdh + const double maxIterations = 100; + const double error = 1e-10; + const double error2 = 1e-16; + double aAdh_tmp = aAdh; + double fa; + double fa2; + double dfda; + for (int lv1 = 0; lv1 < maxIterations; ++lv1) { + fa = deltae1D + sqrt(2.0*M_PI*aAdh_tmp*gamma/Eeff) - ( A/2 - A/B*sqrt(pow(B,2.0)/4 - pow(aAdh_tmp,2.0)) ); + if (abs(fa) < error) { + break; + } + dfda = -((aAdh_tmp*A)/(B*sqrt(-pow(aAdh_tmp,2.0) + pow(B,2.0)/4.0))) + (gamma*sqrt(M_PI/2.0))/(Eeff*sqrt((aAdh_tmp*gamma)/Eeff)); + aAdh_tmp = aAdh_tmp - fa/dfda; + fa2 = deltae1D + sqrt(2.0*M_PI*aAdh_tmp*gamma/Eeff) - ( A/2 - A/B*sqrt(pow(B,2.0)/4 - pow(aAdh_tmp,2.0)) ); + if (abs(fa-fa2) < error2) { + break; + } + if (lv1 == maxIterations-1){ + aAdh_tmp = 0.0; + } + } + aAdh = aAdh_tmp; + + g_aAdh = A/2.0 - A/B*sqrt(pow(B,2.0)/4.0 - pow(aAdh,2.0)); + const double deltaeAdh = g_aAdh; + const double F_na = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltaeAdh/A) - (1.0 - 2.0*deltaeAdh/A)*sqrt(4.0*deltaeAdh/A - 4.0*pow(deltaeAdh,2.0)/pow(A,2.0))); + const double F_Adhes = 2.0*Eeff*(deltae1D - deltaeAdh)*aAdh; + F_MDR = F_na + F_Adhes; + if ( std::isnan(F_MDR) ) std::cout << "F_MDR is NaN, case 3: tensile springs exceed critical length" << std::endl; + } + *aAdh_offset = aAdh; + } + } + } else { // non-adhesive contact + *aAdh_offset = a_na; + (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltae1D/A) - (1.0 - 2.0*deltae1D/A)*sqrt(4.0*deltae1D/A - 4.0*pow(deltae1D,2.0)/pow(A,2.0))); + if ( std::isnan(F_MDR) ) { + std::cout << "F_MDR is NaN, non-adhesive case" << std::endl; + //std::cout << "Normal model: " << gm->delta << ", " << ddelta << ", " << gm->radi << ", " << gm->radj << " | delta: " << delta0 << ", " << delta1 << " | delta2_offset: " << *delta2_offset0 << ", " << *delta2_offset1 << "| dde: " << dde0 << ", " << dde1 << "| Fold: " << F0old << ", " << F1old << " | a: " << a0 << ", " << a1 << " | k_BULK: " << k_BULK0 << ", " << k_BULK1 << " | h_BULK: " << h_BULK0 << ", " << h_BULK1 << std::endl; + std::cout << "i_true: " << i_true << ", j_true: " << j_true << ", i_tag: " << atom->tag[i_true] << ", j_tag: " << atom->tag[j_true] << ", deltae1D: " << deltae1D << ", A: " << A << ", B: " << B << ", amax: " << amax << ", deltamax_MDR: " << deltamax_MDR << ", R: " << R << std::endl; + std::exit(1); + } + } + + //std::cout << gm->i << ", " << gm->j << ", aAdh_offset: " << *aAdh_offset << ", aAdh: " << aAdh << ", a_na: " << a_na << std::endl; + + contacts[i] += 1; + adhesive_length[i] += aAdh; + + // contact penalty scheme + penalty_offset = & history[penalty_offset_]; + double pij = *penalty_offset; + const double wij = std::max(1.0-pij,0.0); + + //std::cout << gm->i << ", " << gm->j << ", " << gm->contact_type << ", " << *gm->xi[1] << ", " << *gm->xj[1] << std::endl; + + // area related calculations + double Ac; + (*Yflag_offset == 0.0) ? Ac = M_PI*delta*R : Ac = M_PI*((2.0*delta*R - pow(delta,2.0)) + cA/M_PI); + if (Ac < 0.0 ) Ac = 0.0; + Atot_sum[i] += wij*(Ac - 2.0*M_PI*R*(deltamax_MDR + delta_BULK)); + Acon1[i] += wij*Ac; + + // bulk force calculation + double F_BULK; + (delta_BULK <= 0.0) ? F_BULK = 0.0 : F_BULK = (1.0/Vgeo[i])*Acon0[i]*delta_BULK*kappa*Ac; + + //if (atom->tag[i_true] == 4135 && lmp->update->ntimestep > 10935000 && gm->contact_type == 2) { + // std::cout << "CS: " << contactSide << ", i_true: " << i_true << ", j_true: " << j_true << ", i_tag: " << atom->tag[i_true] << ", j_tag: " << atom->tag[j_true] << ", deltae1D: " << deltae1D << ", A: " << A << ", B: " << B << ", amax: " << amax << ", deltamax_MDR: " << deltamax_MDR << ", R: " << R << ", F_MDR: " << F_MDR << ", F_BULK: " << F_BULK << ", wij: " << wij << ", gm->delta: " << gm->delta << ", delta: " << delta << ", delmax: " << deltamax << ", deltap: " << *deltap_offset << std::endl; + //} + + //if (i == 35 && lmp->update->ntimestep % 1000 == 0) { + //double **x = atom->x; + //const double xi = x[i_true][0]; + // std::cout << "i: " << i << ", j: " << j << "i_true: " << i_true << ", i_tag: " << atom->tag[i_true] << ", j_true: " << j_true << ", j_tag " << atom->tag[j_true] << ", radi_true: " << radi_true << ", radj_true " << radj_true << ", gm->radi: " << gm->radi << ", gm->radj: " << gm->radj << ", R: " << R << ", Ro: " << Ro << std::endl; + //} + + //if (i_true == 35 && lmp->update->ntimestep >= 736002 && lmp->update->ntimestep <= 736005) { + // //double **x = atom->x; + // //const double xi = x[i_true][0]; + // std::cout << "i_true: " << i_true << ", i_tag: " << atom->tag[i_true] << ", R: " << R << ", Ro: " << Ro << std::endl; + //} + + //if ( ((atom->tag[i_true] == 4 && atom->tag[j_true] == 11) || (atom->tag[i_true] == 11 && atom->tag[j_true] == 4)) && lmp->update->ntimestep == 45000) { + // std::cout << "CS: " << contactSide << ", contact_type: " << gm->contact_type << ", pair: " << PAIR << ", wall: " << WALL << ", WALLREGION " << WALLREGION << ", itag_true: " << atom->tag[i_true] << ", jtag_true: " << atom->tag[j_true] << ", F_MDR: " << F_MDR << ", F_BULK: " << F_BULK << ", wij: " << wij << ", gm->delta: " << gm->delta << ", delta: " << delta << ", delmax: " << deltamax << ", deltap: " << *deltap_offset << std::endl; + //} + + //if ( ((atom->tag[i_true] == 4301) || (atom->tag[j_true] == 4076)) && lmp->update->ntimestep > 1016700) { + // std::cout << "i: " << i << ", j: " << j << "i_true: " << i_true << ", i_tag: " << atom->tag[i_true] << ", j_true: " << j_true << ", j_tag " << atom->tag[j_true] << ", radi_true: " << radi_true << ", radj_true " << radj_true << ", gm->radi: " << gm->radi << ", gm->radj: " << gm->radj << ", R: " << R << ", Ro: " << Ro << ", F_MDR: " << F_MDR << ", F_BULK: " << F_BULK << ", wij: " << wij << ", gm->delta: " << gm->delta << ", delta: " << delta << ", delmax: " << deltamax << ", deltap: " << *deltap_offset << std::endl; + //} + + //if ( ((atom->tag[i_true] == 4) || (atom->tag[j_true] == 4)) && lmp->update->ntimestep == 45000) { + // int rank = 0; + // MPI_Comm_rank(MPI_COMM_WORLD, &rank); + // double **x = atom->x; + // const double xi = x[i][0]; + // const double xj = x[j][0]; + // const double yi = x[i][1]; + // const double yj = x[j][1]; + // const double zi = x[i][2]; + // const double zj = x[j][2]; + // std::cout << "CS: " << contactSide << ", rank, " << rank << ", CT: " << gm->contact_type << ", itag_true: " << atom->tag[i_true] << ", jtag_true: " << atom->tag[j_true] << ", i: " << i << ", j: " << j << ", nlocal: " << atom->nlocal << ", nghost: " << atom->nghost << ", wij: " << wij << ", gm->delta: " << gm->delta << ", delta: " << delta << ", delmax: " << deltamax << ", deltap: " << *deltap_offset << ", R: " << R << ", xi: " << xi << ", xj: " << xj << ", yi: " << yi << ", yj: " << yj << ", zi: " << zi << ", zj: " << zj << std::endl; + //} + + //int rank = 0; + //MPI_Comm_rank(MPI_COMM_WORLD, &rank); + //double **x = atom->x; + //const double xi = x[i][0]; + //const double xj = x[j][0]; + //const double yi = x[i][1]; + //const double yj = x[j][1]; + //const double zi = x[i][2]; + //const double zj = x[j][2]; + //const double dis = sqrt(pow((xi-xj),2.0) + pow((yi-yj),2.0) + pow((zi-zj),2.0)); + //const double delta_test = gm->radi + gm->radj - dis; + //if (delta_test < 0.0 && gm->contact_type != 2) { + // std::cout << "Particles are not touching but a force is evaluated, CS: " << contactSide << ", rank, " << rank << ", contact_type: " << gm->contact_type << ", pair: " << PAIR << ", wall: " << WALL << ", WALLREGION " << WALLREGION << ", itag_true: " << atom->tag[i_true] << ", jtag_true: " << atom->tag[j_true] << ", i: " << i << ", j: " << j << ", nlocal: " << atom->nlocal << ", nghost: " << atom->nghost << ", wij: " << wij << ", gm->delta: " << gm->delta << ", delta: " << delta << ", delmax: " << deltamax << ", deltap: " << *deltap_offset << ", R: " << R << ", xi: " << xi << ", xj: " << xj << ", yi: " << yi << ", yj: " << yj << ", zi: " << zi << ", zj: " << zj << std::endl; + // std::exit(1); + //} + + //if (F_BULK > 0.0) { + // std::cout << "F_BULK is: " << F_BULK << std::endl; + //} + + //std::cout << delta_BULK << ", " << F_BULK << ", " << (1.0/Vgeo[i])*Acon0[i]*delta_BULK*kappa*Ac << std::endl; + + //int rank = 0; + //MPI_Comm_rank(MPI_COMM_WORLD, &rank); + //std::cout << "Step: " << lmp->update->ntimestep << ", CS: " << contactSide << ", itag: " << atom->tag[i] << ", jtag: " << atom->tag[j] << ", rank: " << rank << ", gm->delta: " << gm->delta << ", delta: " << delta << ", ddelta: " << ddelta << ", delta_bar: " << ddelta_bar[i] << ", R: " << R << ", F_MDR: " << F_MDR << ", F_BULK: " << F_BULK << std::endl; + + //std::cout << gm->i << ", " << gm->j << ", " << Vgeo[i] << ", " << Acon0[i] << ", " << Acon1[i] << ", " << Ac << ", " << kappa << " || " << psi[i] << ", " << ddelta_bar[i] << ", " << ddelta << ", " << ddelta_MDR << ", " << ddelta_BULK << ", " << delta << ", " << delta_MDR << ", " << delta_BULK << ", " << F_MDR << ", " << F_BULK << ", " << R << " || " << deltae1D << ", " << A << ", " << B << std::endl; + + //std::cout << gm->i << ", " << gm->j << ", " << (1.0/Vgeo[i])*Acon0[i]*delta_BULK*kappa*Ac << std::endl; + + // total force calculation + (contactSide == 0) ? F0 = F_MDR + F_BULK : F1 = F_MDR + F_BULK; + + + + //std::cout << gm->i << ", " << gm->j << " | " << deltao << ", " << ddelta_bar[i] << ", " << R << ", " << psi[i] << ", " << psi_b << ", " << Ac << " | " << pij << ", " << wij << std::endl; + + // mean surface dipslacement calculation + *Ac_offset = wij*Ac; + + // radius update scheme quantity calculation + Vcaps[i] += (M_PI/3.0)*pow(delta,2.0)*(3.0*R - delta); + + const double Fntmp = wij*(F_MDR + F_BULK); + const double fx = Fntmp*gm->nx[0]; + const double fy = Fntmp*gm->nx[1]; + const double fz = Fntmp*gm->nx[2]; + const double bx = -(Ro - deltao)*gm->nx[0]; + const double by = -(Ro - deltao)*gm->nx[1]; + const double bz = -(Ro - deltao)*gm->nx[2]; + const double eps_bar_contact = (1.0/(3*kappa*Velas[i]))*(fx*bx + fy*by + fz*bz); + eps_bar[i] += eps_bar_contact; + + //double **x = atom->x; + //const double xi = x[i_true][0]; + //const double xj = x[j_true][0]; + //std::cout << i_true << ", " << j_true << ", " << xi << ", " << xj << ", " << gm->nx[0] << ", " << gm->nx[1] << ", " << gm->nx[2] << std::endl; + + //if ( (i == 0 && j == 2 && gm->contact_type == 0) || (i == 2 && j == 0 && gm->contact_type == 0)) { + //std::cout << i << ", " << j << ", " << gm->contact_type << " || " << delta << ", " << *delta_offset << ", " << (uintptr_t)(delta_offset) << " || " << deltao << ", " << *deltao_offset << ", " << (uintptr_t)(deltao_offset) << " || " << delta_MDR << ", " << *delta_MDR_offset << ", " << (uintptr_t)(delta_MDR_offset) << " || " << *Yflag_offset << ", " << (uintptr_t)(Yflag_offset) << " || " << R << std::endl; + //std::cout << i << ", " << j << ", " << gm->contact_type << " || " << fx << ", " << fy << ", " << fz << " || " << bx << ", " << by << ", " << bz << ", " << Velas[i] << std::endl; + //std::cout << i << ", " << j << ", " << gm->contact_type << " || " << eps_bar_contact << ", " << *eps_bar_offset << ", " << (uintptr_t)(eps_bar_offset) << " || " << wij << ", " << ddeltao << ", " << deltao << ", " << delta << ", " << *delta_offset << " || " << Ro << ", " << R << std::endl; + //} + + //if () { + // std::cout << j << ", " << -Vo*(eps_bar_contact - *eps_bar_offset) - wij*M_PI*ddeltao*( 2.0*deltao*Ro - pow(deltao,2.0) + pow(R,2.0) - pow(Ro,2.0) ) << ", " << -Vo*(eps_bar_contact - *eps_bar_offset) << ", " << wij*M_PI*ddeltao*( 2.0*deltao*Ro - pow(deltao,2.0) + pow(R,2.0) - pow(Ro,2.0) ) << std::endl; + //std::cout << i << ", " << j << ", " << gm->contact_type << " || " << eps_bar_contact << ", " << *eps_bar_offset << ", " << (uintptr_t)(eps_bar_offset) << " || " << wij << ", " << ddeltao << ", " << deltao << " || " << Ro << ", " << R << std::endl; + //} + + + double desp_bar_contact = eps_bar_contact - *eps_bar_offset; // && desp_bar_contact < 0.0 + if(delta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0){ + const double Vo = (4.0/3.0)*M_PI*pow(Ro,3.0); + dRnumerator[i] += -Vo*(eps_bar_contact - *eps_bar_offset) - wij*M_PI*ddeltao*( 2.0*deltao*Ro - pow(deltao,2.0) + pow(R,2.0) - pow(Ro,2.0) ); + dRdenominator[i] += wij*2.0*M_PI*R*(deltao + R - Ro); + + //if ( (atom->tag[i] == 9) ) { + // std::cout << "CT: " << gm->contact_type << ", " << PAIR << "i_tag: " << atom->tag[i] << ", j_tag: " << atom->tag[j] << ", deltae1D: " << deltae1D << ", R: " << R << ", Ro: " << Ro << ", F_MDR: " << F_MDR << ", F_BULK: " << F_BULK << ", wij: " << wij << ", deltao: " << deltao << ", ddeltao: " << ddeltao << ", desp_bar: " << eps_bar_contact - *eps_bar_offset << std::endl; + //} + } + *eps_bar_offset = eps_bar_contact; + + sigmaxx[i] += (1.0/Velas[i])*(fx*bx); + sigmayy[i] += (1.0/Velas[i])*(fy*by); + sigmazz[i] += (1.0/Velas[i])*(fz*bz); + //std::cout << psi_b << ", " << psi[i] << ", " << A << ", " << B << ", " << pY << ", " << amax << " || " << deltao << ", " << delta << ", " << ddelta << ", " << *delta_offset << ", " << ddelta_bar[i] << " || " << delta_MDR << ", " << ddelta_MDR << ", " << *delta_MDR_offset << ", " << deltamax_MDR << " || " << delta_BULK << ", " << ddelta_BULK << ", " << *delta_BULK_offset << " || " << R << " || " << Ac << ", " << *Ac_offset << ", " << Acon0[i] << ", " << Acon1[i] << " || " << F_MDR << ", " << F_BULK << ", " << Vgeo[i] << std::endl; + + //std::cout << gm->i << ", " << gm->j << ", " << gm->radi << ", " << gm->radj << " | " << delta << ", " << F_MDR << " | " << deltae1D << ", " << A << ", " << B << std::endl; + + //if (atom->tag[i] == 1 && lmp->update->ntimestep == 45000) { + // double nx; + // double ny; + // double nz; + // if (i == j_true) { + // nx = gm->nx[0]; + // ny = gm->nx[1]; + // nz = gm->nx[2]; + // } else { + // nx = -gm->nx[0]; + // ny = -gm->nx[1]; + // nz = -gm->nx[2]; + // } + // double deltae = deltamax_MDR - *deltap_offset; + // CSVWriter csvWriter("/Users/willzunker/lammps_mdr_develop/sims/MPFEM/deformed_particle_shape_data.csv"); + // std::stringstream rowDataStream; + // rowDataStream << std::scientific << std::setprecision(8); // Set the format and precision + // rowDataStream << nx << ", " << ny << ", " << nz << ", " << Ro << ", " << R << ", " << delta << ", " << deltae << ", " << A << ", " << B << ", " << a_na; + // std::string rowData = rowDataStream.str(); + // csvWriter.writeRow(rowData); + //} + + } + + gm->i = i_true; + gm->j = j_true; + gm->radi = radi_true; + gm->radj = radj_true; + + double * penalty_offset = & history[penalty_offset_]; + const double pij = *penalty_offset; + const double wij = std::max(1.0-pij,0.0); + *penalty_offset = 0.0; + + //std::cout << gm->i << ", " << gm->j << ", " << xi << ", " << xj << std::endl; + + // force magnifiers to prevent over penetration + double * deltao_offset = & history[deltao_offset_0]; + //const double wallForceMagnifer = std::exp(10.0*(*deltao_offset)/Rinitial[gm->i] - 10.0) + 1.0; + const double wallForceMagnifer = 1.0; + + // assign final force + //(gm->contact_type != PAIR) ? F = wij*F0*wallForceMagnifer : F = wij*(F0 + F1)/2; // F = 2*wij*pow(1/F0 + 1/F1,-1); + + if (gm->contact_type != PAIR) { + F = wij*F0*wallForceMagnifer; + } else { + F = wij*(F0 + F1)/2.0; + } + + //std::cout << F << ", " << F0 << ", " << F1 << " | " << R0 << ", " << R1 << std::endl; + + // calculate damping force + if (F > 0.0) { + double Eeff; + double Reff; + if (gm->contact_type == PAIR) { + Eeff = E/(2.0*(1.0-pow(nu,2.0))); + Reff = pow((1/gm->radi + 1/gm->radj),-1); + } else { + Eeff = E/(1.0-pow(nu,2.0)); + Reff = gm->radi; + } + const double kn = Eeff*Reff; + const double beta = -log(CoR)/sqrt(pow(log(CoR),2.0) + M_PI*M_PI); + const double damp_prefactor = beta*sqrt(gm->meff*kn); + const double F_DAMP = -damp_prefactor*(gm->vnnr); + + //std:: cout << gm->contact_type << ", " << Eeff << " , " << Reff << ", " << gm->radi << ", " << gm->radj << " || " << kn << ", " << beta << ", " << gm->meff << " || " << F_DAMP << ", " << F << std::endl; + F += wij*F_DAMP; + } + + //double **x = atom->x; + //const double xi = x[gm->i][0]; + //const double xj = x[gm->j][0]; + //const double del = 20.0 - abs(xi-xj); + + //if (i_true == 146 && j_true == 152) { + // CSVWriter csvWriter("/Users/willzunker/lammps_mdr_develop/sims/avicelTableting/rigid_flat_output.csv"); + // std::stringstream rowDataStream; + // rowDataStream << std::scientific << std::setprecision(6); // Set the format and precision + // rowDataStream << gm->delta << ", " << delta0 << ", " << delta1 << ", " << dde0 << ", " << dde1 << ", " << (dde0 + dde1) << ", " << F0old << ", " << F1old << ", " << a0 << ", " << a1 << ", " << h0 << ", " << h1 << ", " << k_BULK0 << ", " << k_BULK1 << ", " << h_BULK0 << ", " << h_BULK1; + // std::string rowData = rowDataStream.str(); + // csvWriter.writeRow(rowData); + //} + + //if (i_true == 0 && j_true == 1) { + // CSVWriter csvWriter("/Users/willzunker/lammps_mdr_develop/sims/twoParticleDifferingRadii/rigid_flat_output.csv"); + // std::stringstream rowDataStream; + // rowDataStream << std::scientific << std::setprecision(6); // Set the format and precision + // rowDataStream << gm->delta << ", " << delta0 << ", " << delta1 << ", " << dde0 << ", " << dde1 << ", " << (dde0 + dde1) << ", " << F0old << ", " << F1old << ", " << a0 << ", " << a1 << ", " << h0 << ", " << h1 << ", " << k_BULK0 << ", " << k_BULK1 << ", " << h_BULK0 << ", " << h_BULK1 << ", " << R0 << ", " << R1; + // std::string rowData = rowDataStream.str(); + // csvWriter.writeRow(rowData); + //} + + //if (i_true == 0 && j_true == 1) { + // CSVWriter csvWriter("/Users/willzunker/lammps_mdr_develop/sims/twoParticleDifferingRadii/rigid_flat_output_fit.csv"); + // std::stringstream rowDataStream; + // rowDataStream << std::scientific << std::setprecision(6); // Set the format and precision + // rowDataStream << gm->delta << ", " << delta0 << ", " << delta1 << ", " << delta01; + // std::string rowData = rowDataStream.str(); + // csvWriter.writeRow(rowData); + //} + + //if (gm->i == 0 && gm->j == 2) { + // CSVWriter csvWriter("/Users/willzunker/lammps/sims/compressionSleeve/pairContactsBotCen.csv"); + // std::stringstream rowDataStream; + // rowDataStream << std::scientific << std::setprecision(4); // Set the format and precision + // rowDataStream << del << ", " << F; + // std::string rowData = rowDataStream.str(); + // csvWriter.writeRow(rowData); + //} + + //std:: cout << "The force F is: " << F << std::endl; + + return F; +} + +/* ---------------------------------------------------------------------- */ + +void GranSubModNormalMDR::set_fncrit() +{ + Fncrit = fabs(F); +} + +//std::cout << sidata.i << ", " << sidata.j << ", " << R << ", " << deltan << ", " << deltao << ", " << dRsums_i[0] << ", " << dRsums_i[1] << ", " << numQuant << std::endl; +//std::cout << gm->i << ", " << gm->j << " | " << gm->nx[0] << ", " << gm->nx[1] << ", " << gm->nx[2] << std::endl; +//std::cout << "F is: " << F << std::endl; +//std::cout << "Ro from particle history is: " << Ro[gm->i] << std::endl; +//std::cout << "MDR contact model has been entered." << std::endl; +// std::cout << "F is: " << F << std::endl; +//std::cout << "gamma > 0.0: " << F_MDR << ", " << gm->i << ", " << gm->j << std::endl; +//std::cout << "deltae1D <= 0.0: " << F_MDR << ", " << gm->i << ", " << gm->j << std::endl; +//std::cout << "F_MDR should be > 0: " << F_MDR << ", " << gm->i << ", " << gm->j << std::endl; +//std::cout << gm->i << ", " << gm->j << " || " << delta << ", " << delta_MDR << ", " << deltamax_MDR << ", " << deltae1D << " || " << A << ", " << B << std::endl; + +//std::cout << i_true << ", " << j_true << std::endl; + + //std::cout << history_index << ", " << history[0] << ", " << history[1] << ", " << history[2] << std::endl; + + // initialize all history variables + //double delta_offset; + //double deltao_offset; + //double delta_MDR_offset; + //double delta_BULK_offset; + //double deltamax_MDR_offset; + //double Yflag; + //double deltaY_offset; + //double Ac_offset; + //double aAdh_offset; + //double deltap_offset; + //double cA_offset; + //double eps_bar_offset; + //double wall_contact_flag_offset; \ No newline at end of file diff --git a/src/GRANULAR/gran_sub_mod_normal.h b/src/GRANULAR/gran_sub_mod_normal.h index c1ed36b6e1..bfd6121ec8 100644 --- a/src/GRANULAR/gran_sub_mod_normal.h +++ b/src/GRANULAR/gran_sub_mod_normal.h @@ -19,6 +19,7 @@ GranSubModStyle(hertz,GranSubModNormalHertz,NORMAL); GranSubModStyle(hertz/material,GranSubModNormalHertzMaterial,NORMAL); GranSubModStyle(dmt,GranSubModNormalDMT,NORMAL); GranSubModStyle(jkr,GranSubModNormalJKR,NORMAL); +GranSubModStyle(mdr,GranSubModNormalMDR,NORMAL); // clang-format on #else @@ -133,6 +134,20 @@ namespace Granular_NS { int mixed_coefficients; }; + /* ---------------------------------------------------------------------- */ + + class GranSubModNormalMDR : public GranSubModNormal { + public: + GranSubModNormalMDR(class GranularModel *, class LAMMPS *); + void coeffs_to_local() override; + double calculate_forces() override; + void set_fncrit() override; + double psi_b; + + protected: + double E, nu, Y, gamma, CoR, F; + }; + } // namespace Granular_NS } // namespace LAMMPS_NS diff --git a/src/GRANULAR/gran_sub_mod_rolling.cpp b/src/GRANULAR/gran_sub_mod_rolling.cpp index 88647c3f45..b236b9a142 100644 --- a/src/GRANULAR/gran_sub_mod_rolling.cpp +++ b/src/GRANULAR/gran_sub_mod_rolling.cpp @@ -17,6 +17,7 @@ #include "gran_sub_mod_normal.h" #include "granular_model.h" #include "math_extra.h" +#include #include @@ -46,7 +47,7 @@ GranSubModRollingNone::GranSubModRollingNone(GranularModel *gm, LAMMPS *lmp) : ------------------------------------------------------------------------- */ GranSubModRollingSDS::GranSubModRollingSDS(GranularModel *gm, LAMMPS *lmp) : - GranSubModRolling(gm, lmp) + GranSubModRolling(gm, lmp), k{0.0}, mu{0.0}, gamma{0.0} { num_coeffs = 3; size_history = 3; @@ -81,6 +82,8 @@ void GranSubModRollingSDS::calculate_forces() hist_temp[1] = gm->history[rhist1]; hist_temp[2] = gm->history[rhist2]; + //std::cout << "Frcrit rolling is: " << Frcrit << std::endl; + if (gm->history_update) { rolldotn = dot3(hist_temp, gm->nx); diff --git a/src/GRANULAR/granular_model.cpp b/src/GRANULAR/granular_model.cpp index 9764ec42e9..d4fb6f66a8 100644 --- a/src/GRANULAR/granular_model.cpp +++ b/src/GRANULAR/granular_model.cpp @@ -243,7 +243,7 @@ void GranularModel::init() // Must have valid normal, damping, and tangential models if (normal_model->name == "none") error->all(FLERR, "Must specify normal granular model"); - if (damping_model->name == "none") error->all(FLERR, "Must specify damping granular model"); + //if (damping_model->name == "none") error->all(FLERR, "Must specify damping granular model"); TURNED OFF FOR MDR if (tangential_model->name == "none") error->all(FLERR, "Must specify tangential granular model"); // Twisting, rolling, and heat are optional diff --git a/src/GRANULAR/granular_model.h b/src/GRANULAR/granular_model.h index a2e1f14776..35364eb1a2 100644 --- a/src/GRANULAR/granular_model.h +++ b/src/GRANULAR/granular_model.h @@ -74,6 +74,9 @@ class GranularModel : protected Pointers { int beyond_contact, limit_damping, history_update; ContactType contact_type; + // Particle indices + int i, j, itype, jtype; + // History variables int size_history, nondefault_history_transfer; double *transfer_history_factor; diff --git a/src/GRANULAR/pair_granular.cpp b/src/GRANULAR/pair_granular.cpp index cb19a8c025..04d06c296f 100644 --- a/src/GRANULAR/pair_granular.cpp +++ b/src/GRANULAR/pair_granular.cpp @@ -32,11 +32,14 @@ #include "math_extra.h" #include "memory.h" #include "modify.h" +#include "group.h" #include "neigh_list.h" #include "neighbor.h" #include "update.h" +#include "gran_sub_mod_normal.h" #include +#include using namespace LAMMPS_NS; using namespace Granular_NS; @@ -78,6 +81,8 @@ PairGranular::PairGranular(LAMMPS *lmp) : Pair(lmp) fix_history = nullptr; fix_dummy = dynamic_cast(modify->add_fix("NEIGH_HISTORY_GRANULAR_DUMMY all DUMMY")); + + fix_flag = 0; } /* ---------------------------------------------------------------------- */ @@ -194,11 +199,28 @@ void PairGranular::compute(int eflag, int vflag) jtype = type[j]; model = models_list[types_indices[itype][jtype]]; + //std::cout << "Pair Granular: " << i << ", " << j << std::endl; + // Reset model and copy initial geometric data model->xi = x[i]; model->xj = x[j]; model->radi = radius[i]; model->radj = radius[j]; + model->i = i; + model->j = j; + model->itype = itype; + model->jtype = jtype; + + /* + if (radius[i] < 0.00065 || radius[j] < 0.00065) { + std::cout << "Pair Granular: " << i << ", " << j << " || " << radius[i] << ", " << radius[j] << std::endl; + } + + if (std::isnan(radius[i]) || std::isnan(radius[j])) { + std::cout << "Pair Granular: " << i << ", " << j << " || " << radius[i] << ", " << radius[j] << std::endl; + } + */ + if (use_history) model->touch = touch[jj]; touchflag = model->check_contact(); @@ -468,6 +490,67 @@ void PairGranular::init_style() if (!fix_history) error->all(FLERR,"Could not find pair fix neigh history ID"); } + /* + // Example + //Store persistent per atom quantities + if (! fix_flag) { + int tmp1, tmp2; + id_fix = "BOND_BPM_PLASTIC_FIX_PROP_ATOM"; + modify->add_fix( + fmt::format("{} all property/atom d_plastic d_plastic_temp d_viscous_temp d_plastic_heat d_viscous_heat ghost yes", id_fix)); + index_plastic = atom->find_custom("plastic",tmp1,tmp2); + index_pq = atom->find_custom("plastic_heat",tmp1,tmp2); + index_pt = atom->find_custom("plastic_temp",tmp1,tmp2); + index_vq = atom->find_custom("viscous_heat",tmp1,tmp2); + index_vt = atom->find_custom("viscous_temp",tmp1,tmp2); + fix_flag = 1; + } + */ + + if (model->normal_model->name == "mdr") { + + std::cout << "MDR history variables have been initialized" << std::endl; + + // FOR MDR CONTACT MODEL + //Store persistent per atom quantities + if (! fix_flag) { + int tmp1, tmp2; + const char * id_fix = "MDR_PARTICLE_HISTORY_VARIABLES"; + modify->add_fix(fmt::format("{} all property/atom d_Ro d_Vcaps d_Vgeo d_Velas d_eps_bar d_dRnumerator d_dRdenominator d_Acon0 d_Acon1 d_Atot d_Atot_sum d_ddelta_bar d_psi d_psi_b d_history_setup_flag d_sigmaxx d_sigmayy d_sigmazz d_contacts d_adhesive_length ghost yes", id_fix)); + // d2_volSums 4 --> allows an array of 4 to defined. + index_Ro = atom->find_custom("Ro",tmp1,tmp2); // initial radius + index_Vcaps = atom->find_custom("Vcaps",tmp1,tmp2); // spherical cap volume from intersection of apparent radius particle and contact planes + index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); // geometric particle volume of apparent particle after removing spherical cap volume + index_Velas = atom->find_custom("Velas",tmp1,tmp2); // particle volume from linear elasticity + index_eps_bar = atom->find_custom("eps_bar",tmp1,tmp2); // volume-averaged infinitesimal strain tensor + index_dRnumerator = atom->find_custom("dRnumerator",tmp1,tmp2); // summation of numerator terms in calculation of dR + index_dRdenominator = atom->find_custom("dRdenominator",tmp1,tmp2); // summation of denominator terms in calculation of dR + index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); // total area involved in contacts: Acon^{n} + index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); // total area involved in contacts: Acon^{n+1} + index_Atot = atom->find_custom("Atot",tmp1,tmp2); // total particle area + index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); // running sum of contact area minus cap area + index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); // change in mean surface displacement + index_psi = atom->find_custom("psi",tmp1,tmp2); // ratio of free surface area to total surface area + index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); // TEMPORARY, SINCE PSI_B IS ALREADY DEFINED IN THE INPUT SCRIPT + index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); // flag to check if history variables have been initialized + index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); // xx-component of the stress tensor, not necessary for force calculation + index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); // yy-component of the stress tensor, not necessary for force calculation + index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); // zz-component of the stress tensor, not necessary for force calculation + index_contacts = atom->find_custom("contacts",tmp1,tmp2); // total contacts on particle + index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); // total contacts on particle + + std::cout << "MDR history variables have been initialized 2" << ", " << index_Ro << std::endl; + + //index_volSums = atom->find_custom("volSums",tmp1,tmp2); + + // Initiate MDR radius update fix + modify->add_fix("fix_mdr_radius_update all mdr/radius/update"); + modify->add_fix("fix_mdr_mean_surf_disp all mdr/mean/surf/disp"); + + fix_flag = 1; + } + } + // check for FixFreeze and set freeze_group_bit auto fixlist = modify->get_fix_by_style("^freeze"); @@ -703,6 +786,8 @@ double PairGranular::single(int i, int j, int itype, int jtype, class GranularModel* model = models_list[types_indices[itype][jtype]]; + + // Reset model and copy initial geometric data double **x = atom->x; double *radius = atom->radius; @@ -925,3 +1010,8 @@ void PairGranular::prune_models() nmodels -= 1; } } + +size_t PairGranular::get_size_history() const +{ + return size_history; +} diff --git a/src/GRANULAR/pair_granular.h b/src/GRANULAR/pair_granular.h index f94f4f5dff..16a97250b8 100644 --- a/src/GRANULAR/pair_granular.h +++ b/src/GRANULAR/pair_granular.h @@ -46,6 +46,16 @@ class PairGranular : public Pair { double memory_usage() override; double atom2cut(int) override; double radii2cut(double, double) override; + size_t get_size_history() const; + + // granular models + // MOVED HERE FROM PRIVATE FOR MDR MODEL + class Granular_NS::GranularModel** models_list; + int **types_indices; + int nmodels, maxmodels; + + class FixStoreAtom * fix_store; + protected: int freeze_group_bit; @@ -59,6 +69,29 @@ class PairGranular : public Pair { class FixDummy *fix_dummy; class FixNeighHistory *fix_history; + // MDR particle history variables + int fix_flag; + int index_Ro; + int index_Vcaps; + int index_Vgeo; + int index_Velas; + int index_eps_bar; + int index_dRnumerator; + int index_dRdenominator; + int index_Acon0; + int index_Acon1; + int index_Atot; + int index_Atot_sum; + int index_ddelta_bar; + int index_psi; + int index_psi_b; + int index_history_setup_flag; + int index_sigmaxx; + int index_sigmayy; + int index_sigmazz; + int index_contacts; + int index_adhesive_length; + // storage of rigid body masses for use in granular interactions class Fix *fix_rigid; // ptr to rigid body fix, null pointer if none @@ -73,11 +106,6 @@ class PairGranular : public Pair { int size_history; int heat_flag; - // granular models - int nmodels, maxmodels; - class Granular_NS::GranularModel **models_list; - int **types_indices; - // optional user-specified global cutoff, per-type user-specified cutoffs double **cutoff_type; double cutoff_global; diff --git a/src/SRD/fix_srd.cpp b/src/SRD/fix_srd.cpp index 9b153a1c28..054ef83349 100644 --- a/src/SRD/fix_srd.cpp +++ b/src/SRD/fix_srd.cpp @@ -40,6 +40,7 @@ #include #include +#include using namespace LAMMPS_NS; using namespace FixConst; @@ -54,7 +55,7 @@ enum { SHIFT_NO, SHIFT_YES, SHIFT_POSSIBLE }; static constexpr double EINERTIA = 0.2; // moment of inertia prefactor for ellipsoid -static constexpr int ATOMPERBIN = 30; +static constexpr int ATOMPERBIN = 100; static constexpr double BIG = 1.0e20; static constexpr int VBINSIZE = 5; static constexpr double TOLERANCE = 0.00001; @@ -1321,6 +1322,7 @@ void FixSRD::collisions_single() #endif if (t_remain > dt) { + print_collision(i, j, ibounce, t_remain, dt, xscoll, xbcoll, norm, type); ninside++; if (insideflag == INSIDE_ERROR || insideflag == INSIDE_WARN) { std::string mesg; @@ -2603,14 +2605,17 @@ void FixSRD::parameterize() for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) { if (rmass) { - if (mass_srd == 0.0) + if (mass_srd == 0.0) { mass_srd = rmass[i]; - else if (rmass[i] != mass_srd) + std::cout << "mass if #1: " << rmass[i] << std::endl; + std::cout << "srd radius is: " << radius[i] << std::endl; + } else if (rmass[i] != mass_srd) flag = 1; } else { - if (mass_srd == 0.0) + if (mass_srd == 0.0) { mass_srd = mass[type[i]]; - else if (mass[type[i]] != mass_srd) + std::cout << "mass if #2: " << mass[type[i]] << std::endl; + } else if (mass[type[i]] != mass_srd) flag = 1; } } @@ -2712,6 +2717,7 @@ void FixSRD::parameterize() if (dimension == 3) { volsrd = (domain->xprd * domain->yprd * domain->zprd) - volbig; density_srd = nsrd * mass_srd / (domain->xprd * domain->yprd * domain->zprd - volbig); + std::cout << nsrd << ", " << mass_srd << ", " << domain->xprd << ", " << domain->yprd << ", " << domain->zprd << ", " << volbig << std::endl; } else { volsrd = (domain->xprd * domain->yprd) - volbig; density_srd = nsrd * mass_srd / (domain->xprd * domain->yprd - volbig); @@ -2773,7 +2779,7 @@ void FixSRD::parameterize() gridsrd, binsize3x, binsize3y, binsize3z); mesg += fmt::format(" SRD per actual grid cell = {:.8}\n", srd_per_cell); mesg += fmt::format(" SRD viscosity = {:.8}\n", viscosity); - mesg += fmt::format(" big/SRD mass density ratio = {:.8}\n", mdratio); + mesg += fmt::format(" big/SRD mass density ratio = {:.8} | big density = {:.8}, small density = {:.8}\n", mdratio,density_big,density_srd); utils::logmesg(lmp, mesg); } diff --git a/src/csv_writer.h b/src/csv_writer.h new file mode 100644 index 0000000000..0a01604393 --- /dev/null +++ b/src/csv_writer.h @@ -0,0 +1,25 @@ +#include +#include +#include + +class CSVWriter { +public: + CSVWriter(const std::string& filename) : filename_(filename) {} + + void writeRow(const std::string& data) { + std::ofstream file; + // Use the append mode to add data to the end of the file if it exists + file.open(filename_, std::ios::out | std::ios::app); + + if (!file.is_open()) { + std::cerr << "Failed to open file: " << filename_ << std::endl; + return; + } + + file << data << std::endl; + file.close(); + } + +private: + std::string filename_; +}; \ No newline at end of file diff --git a/src/fix_ave_chunk.cpp b/src/fix_ave_chunk.cpp index 6a3c2e2032..8757363933 100644 --- a/src/fix_ave_chunk.cpp +++ b/src/fix_ave_chunk.cpp @@ -431,6 +431,8 @@ FixAveChunk::~FixAveChunk() /* ---------------------------------------------------------------------- */ +// FOR MDR + int FixAveChunk::setmask() { int mask = 0; @@ -499,6 +501,8 @@ void FixAveChunk::setup(int /*vflag*/) /* ---------------------------------------------------------------------- */ +// FOR MDR, DO WHATEVER YOUR FIX NEEDS TO DO. + void FixAveChunk::end_of_step() { int i,j,m,index; diff --git a/src/fix_ave_chunk.h b/src/fix_ave_chunk.h index 0919a17acf..a25ade9654 100644 --- a/src/fix_ave_chunk.h +++ b/src/fix_ave_chunk.h @@ -31,7 +31,7 @@ class FixAveChunk : public Fix { int setmask() override; void init() override; void setup(int) override; - void end_of_step() override; + void end_of_step() override; // FOR MDR double compute_array(int, int) override; double memory_usage() override; diff --git a/src/fix_mdr_mean_surf_disp.cpp b/src/fix_mdr_mean_surf_disp.cpp new file mode 100644 index 0000000000..4165299b05 --- /dev/null +++ b/src/fix_mdr_mean_surf_disp.cpp @@ -0,0 +1,539 @@ +// clang-format off +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + LAMMPS development team: developers@lammps.org + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing authors: + William Zunker (MIT), Sachith Dunatunga (MIT), + Dan Bolintineanu (SNL), Joel Clemmer (SNL) +----------------------------------------------------------------------- */ + +#include "fix_mdr_mean_surf_disp.h" + +#include "atom.h" +#include "error.h" +#include "force.h" +#include "input.h" +#include "memory.h" +#include "modify.h" +#include "variable.h" +#include "fix_neigh_history.h" +#include "pair.h" +#include "pair_granular.h" +#include "granular_model.h" +#include "neigh_list.h" +#include "region.h" +#include "update.h" +#include "fix_wall_gran_region.h" +#include "comm.h" +#include +#include + +using namespace LAMMPS_NS; +using namespace FixConst; +using namespace Granular_NS; + +/* ---------------------------------------------------------------------- */ + +FixMDRmeanSurfDisp::FixMDRmeanSurfDisp(LAMMPS *lmp, int narg, char **arg) : + Fix(lmp, narg, arg) +{ + comm_forward = 1; // value needs to match number of values you communicate +} + +// FOR MDR + +int FixMDRmeanSurfDisp::setmask() +{ + int mask = 0; + mask |= PRE_FORCE; + return mask; +} + +void FixMDRmeanSurfDisp::setup_pre_force(int /*vflag*/) +{ + int tmp1, tmp2; + int index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); + int index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); + Acon0 = atom->dvector[index_Acon0]; + ddelta_bar = atom->dvector[index_ddelta_bar]; + + pre_force(0); +} + +int FixMDRmeanSurfDisp::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/,int * /*pbc*/) +{ + int m = 0; + for (int i = 0; i < n; i++) { + int j = list[i]; + buf[m++] = ddelta_bar[j]; + //buf[m++] = Acon0[j]; + } + return m; +} + +void FixMDRmeanSurfDisp::unpack_forward_comm(int n, int first, double *buf) +{ + int m = 0; + int last = first + n; + for (int i = first; i < last; i++) { + ddelta_bar[i] = buf[m++]; + //Acon0[i] = buf[m++]; + } +} + +void FixMDRmeanSurfDisp::pre_force(int) +{ + FixNeighHistory * fix_history = dynamic_cast(modify->get_fix_by_id("NEIGH_HISTORY_GRANULAR")); + PairGranular * pair = dynamic_cast(force->pair_match("granular",1)); + NeighList * list = pair->list; + + const int size_history = pair->get_size_history(); + + //std::cout << " " << std::endl; + //std::cout << "New Step" << std::endl; + + { + int i,j,k,lv1,ii,jj,inum,jnum,itype,jtype,ktype; + + int *ilist,*jlist,*numneigh,**firstneigh; + int *touch,**firsttouch; + double *history_ij,*history_ik,*history_jk,*history_kj,*allhistory,*allhistory_j,*allhistory_k,**firsthistory; + + bool touchflag = false; + + //class GranularModel* model; + //class GranularModel** models_list = pair->models_list; + //int ** types_indices = pair->types_indices; + + double **x = atom->x; + int *type = atom->type; + double *radius = atom->radius; + int nlocal = atom->nlocal; + + inum = list->inum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + firsttouch = fix_history->firstflag; + firsthistory = fix_history->firstvalue; + + // contact penalty calculation + for (int ii = 0; ii < inum; ii++) { + const int i = ilist[ii]; + const double xtmp = x[i][0]; + const double ytmp = x[i][1]; + const double ztmp = x[i][2]; + allhistory = firsthistory[i]; + double radi = radius[i]; + jlist = firstneigh[i]; + jnum = numneigh[i]; + for (int jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + j &= NEIGHMASK; + jtype = type[j]; + double radj = radius[j]; + const double delx_ij = x[j][0] - xtmp; + const double dely_ij = x[j][1] - ytmp; + const double delz_ij = x[j][2] - ztmp; + const double rsq_ij = delx_ij*delx_ij + dely_ij*dely_ij + delz_ij*delz_ij; + const double r_ij = sqrt(rsq_ij); + const double rinv_ij = 1.0/r_ij; + const double radsum_ij = radi + radj; + const double deltan_ij = radsum_ij - r_ij; + if (deltan_ij >= 0.0) { + for (int kk = jj; kk < jnum; kk++) { + k = jlist[kk]; + k &= NEIGHMASK; + ktype = type[k]; + if (kk != jj) { + const double delx_ik = x[k][0] - xtmp; + const double dely_ik = x[k][1] - ytmp; + const double delz_ik = x[k][2] - ztmp; + const double rsq_ik = delx_ik*delx_ik + dely_ik*dely_ik + delz_ik*delz_ik; + const double r_ik = sqrt(rsq_ik); + const double rinv_ik = 1.0/r_ik; + const double radk = radius[k]; + const double radsum_ik = radi + radk; + const double deltan_ik = radsum_ik - r_ik; + const double delx_jk = x[k][0] - x[j][0]; + const double dely_jk = x[k][1] - x[j][1]; + const double delz_jk = x[k][2] - x[j][2]; + const double rsq_jk = delx_jk*delx_jk + dely_jk*dely_jk + delz_jk*delz_jk; + const double r_jk = sqrt(rsq_jk); + const double rinv_jk = 1.0/r_jk; + const double radsum_jk = radj + radk; + const double deltan_jk = radsum_jk - r_jk; + if (deltan_ik >= 0.0 && deltan_jk >= 0.0) { + + // pull ij history + history_ij = &allhistory[size_history * jj]; + double * pij = &history_ij[22]; // penalty for contact i and j + + // pull ik history + history_ik = &allhistory[size_history * kk]; + double * pik = &history_ik[22]; // penalty for contact i and k + + // we don't know if who owns the contact ahead of time, k might be in j's neigbor list or vice versa, so we need to manually search to figure out the owner + // check if k is in the neighbor list of j + double * pjk = NULL; + int * const jklist = firstneigh[j]; + const int jknum = numneigh[j]; + for (int jk = 0; jk < jknum; jk++) { + const int kneigh = jklist[jk] & NEIGHMASK; + if (k == kneigh) { + allhistory_j = firsthistory[j]; + history_jk = &allhistory_j[size_history * jk]; + pjk = &history_jk[22]; // penalty for contact j and k + //int rank = 0; + //MPI_Comm_rank(MPI_COMM_WORLD, &rank); + //std::cout << "Print 183 pjk: " << rank << ", " << pjk << std::endl; + //std::cout << "Print 183 pjk[0]: " << rank << ", " << pjk[0] << std::endl; + break; + } + } + + // check if j is in the neighbor list of k + if (pjk == NULL) { + int * const kjlist = firstneigh[k]; + const int kjnum = numneigh[k]; + for (int kj = 0; kj < kjnum; kj++) { + const int jneigh = kjlist[kj] & NEIGHMASK; + if (j == jneigh) { + allhistory_k = firsthistory[k]; + history_kj = &allhistory_k[size_history * kj]; + pjk = &history_kj[22]; // penalty for contact j and k + //int rank = 0; + //MPI_Comm_rank(MPI_COMM_WORLD, &rank); + //std::cout << "Print 198 pjk: " << rank << ", " << pjk << std::endl; + //std::cout << "Print 198 pjk[0]: " << rank << ", " << pjk[0] << std::endl; + break; + } + } + } + + //std::cout << "Print: " << __LINE__ << std::endl; + std::vector distances = {r_ij,r_ik,r_jk}; + auto maxElement = std::max_element(distances.begin(), distances.end()); + double maxValue = *maxElement; + int maxIndex = std::distance(distances.begin(), maxElement); + if (maxIndex == 0) { // the central particle is k + const double enx_ki = -delx_ik * rinv_ik; + const double eny_ki = -dely_ik * rinv_ik; + const double enz_ki = -delz_ik * rinv_ik; + const double enx_kj = -delx_jk * rinv_jk; + const double eny_kj = -dely_jk * rinv_jk; + const double enz_kj = -delz_jk * rinv_jk; + const double alpha = std::acos(enx_ki*enx_kj + eny_ki*eny_kj + enz_ki*enz_kj); + pij[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/M_PI - 1.0/2.0)) ); + } else if (maxIndex == 1) { // the central particle is j + const double enx_ji = -delx_ij * rinv_ij; + const double eny_ji = -dely_ij * rinv_ij; + const double enz_ji = -delz_ij * rinv_ij; + const double enx_jk = delx_jk * rinv_jk; + const double eny_jk = dely_jk * rinv_jk; + const double enz_jk = delz_jk * rinv_jk; + const double alpha = std::acos(enx_ji*enx_jk + eny_ji*eny_jk + enz_ji*enz_jk); + pik[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/M_PI - 1.0/2.0)) ); + } else { // the central particle is i + if (j < atom->nlocal || k < atom->nlocal) { + const double enx_ij = delx_ij * rinv_ij; + const double eny_ij = dely_ij * rinv_ij; + const double enz_ij = delz_ij * rinv_ij; + const double enx_ik = delx_ik * rinv_ik; + const double eny_ik = dely_ik * rinv_ik; + const double enz_ik = delz_ik * rinv_ik; + const double alpha = std::acos(enx_ij*enx_ik + eny_ij*eny_ik + enz_ij*enz_ik); + //std::cout << "Print: " << __LINE__ << std::endl; + pjk[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/M_PI - 1.0/2.0)) ); + //std::cout << "Print: " << __LINE__ << std::endl; + } + } + } + } + } + } + } + } + } + + + { + int i,j,k,ii,jj,inum,jnum,itype,jtype; + + int *ilist,*jlist,*numneigh,**firstneigh; + int *touch,**firsttouch; + double *history,*allhistory,**firsthistory; + + bool touchflag = false; + + class GranularModel* model; + class GranularModel** models_list = pair->models_list; + int ** types_indices = pair->types_indices; + + double **x = atom->x; + int *type = atom->type; + double *radius = atom->radius; + int nlocal = atom->nlocal; + + + inum = list->inum; + ilist = list->ilist; + numneigh = list->numneigh; + firstneigh = list->firstneigh; + firsttouch = fix_history->firstflag; + firsthistory = fix_history->firstvalue; + + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + itype = type[i]; + touch = firsttouch[i]; + allhistory = firsthistory[i]; + jlist = firstneigh[i]; + jnum = numneigh[i]; + + for (jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + j &= NEIGHMASK; + + jtype = type[j]; + model = models_list[types_indices[itype][jtype]]; + + // Reset model and copy initial geometric data + model->xi = x[i]; + model->xj = x[j]; + model->radi = radius[i]; + model->radj = radius[j]; + model->i = i; + model->j = j; + model->touch = touch[jj]; + touchflag = model->check_contact(); + + // is it necessary to clear the history here??? + if (!touchflag) { + touch[jj] = 0; + history = &allhistory[size_history * jj]; + for (k = 0; k < size_history; k++) history[k] = 0.0; + continue; + } + + touch[jj] = 1; + + history = &allhistory[size_history * jj]; + model->history = history; + + //const double pij = history[22]; + //const double wij = std::max(1.0-pij,0.0); + const double delta = model->radsum - sqrt(model->rsq); + + const int delta_offset_0 = 0; // apparent overlap + const int delta_offset_1 = 1; + const int Ac_offset_0 = 18; // contact area + const int Ac_offset_1 = 19; + const int deltamax_offset_ = 23; + const int deltap_offset_0 = 24; + const int deltap_offset_1 = 25; + + double deltamax = history[deltamax_offset_]; + double deltap0 = history[deltap_offset_0]; + double deltap1 = history[deltap_offset_1]; + + if (delta > deltamax) deltamax = delta; + + double delta0old = history[delta_offset_0]; + double delta1old = history[delta_offset_1]; + + int i0; + int i1; + if (atom->tag[i] > atom->tag[j]) { + i0 = i; + i1 = j; + } else { + i0 = j; + i1 = i; + } + + int rank = 0; + MPI_Comm_rank(MPI_COMM_WORLD, &rank); + int i_ghost; + int j_ghost; + (i >= atom->nlocal) ? i_ghost = 1 : i_ghost = 0; + (j >= atom->nlocal) ? j_ghost = 1 : j_ghost = 0; + if (i_ghost == 1) { + std::cout << "rank: " << rank << ", i: " << i << ", j: " << j << ", i is ghost? " << i_ghost << ", j is ghost? " << j_ghost << ", nlocal: " << atom->nlocal << ", itag: " << atom->tag[i] << ", jtag: " << atom->tag[j] << std::endl; + } + + //int i0 = std::max(i,j); + //int i1 = std::min(i,j); + double R0 = radius[i0]; + double R1 = radius[i1]; + + double delta_geo0; + double delta_geo1; + double deltaOpt1 = deltamax*(deltamax - 2.0*R1)/(2.0*(deltamax - R0 - R1)); + double deltaOpt2 = deltamax*(deltamax - 2.0*R0)/(2.0*(deltamax - R0 - R1)); + (R0 < R1) ? delta_geo0 = MAX(deltaOpt1,deltaOpt2) : delta_geo0 = MIN(deltaOpt1,deltaOpt2); + (R0 < R1) ? delta_geo1 = MIN(deltaOpt1,deltaOpt2) : delta_geo1 = MAX(deltaOpt1,deltaOpt2); + + double overlap_limit = 0.75; + + if (delta_geo0/R0 > overlap_limit) { + delta_geo0 = R0*overlap_limit; + delta_geo1 = deltamax - delta_geo0; + } else if (delta_geo1/R1 > overlap_limit) { + delta_geo1 = R1*overlap_limit; + delta_geo0 = deltamax - delta_geo1; + } + + double deltap = deltap0 + deltap1; + + double delta0 = delta_geo0 + (deltap0 - delta_geo0)/(deltap - deltamax)*(delta-deltamax); + double delta1 = delta_geo1 + (deltap1 - delta_geo1)/(deltap - deltamax)*(delta-deltamax); + + double ddel0 = delta0 - delta0old; + double ddel1 = delta1 - delta1old; + + if (Acon0[i0] != 0.0) { + const double Ac_offset0 = history[Ac_offset_0]; + ddelta_bar[i0] += Ac_offset0/Acon0[i0]*ddel0; // Multiply by 0.5 since displacement is shared equally between deformable particles. + } + + if (Acon0[i1] != 0.0) { + const double Ac_offset1 = history[Ac_offset_1]; + ddelta_bar[i1] += Ac_offset1/Acon0[i1]*ddel1; + } + + //int rank = 0; + //MPI_Comm_rank(MPI_COMM_WORLD, &rank); + //std::cout << "delta_bar calc: Step: " << lmp->update->ntimestep << ", itag: " << atom->tag[i] << ", jtag: " << atom->tag[j] << ", i: " << i << ", j: " << j << ", rank: " << rank << ", Ac_offset0: " << history[Ac_offset_0] << ", Ac_offset1: " << history[Ac_offset_1] << ", Acon[i0]: " << Acon0[i0] << ", Acon[i1]: " << Acon0[i1] << ", ddel0: " << ddel0 << ", ddel1: " << ddel1 << ", ddelta_bar[i0]: " << ddelta_bar[i0] << ", ddelta_bar[i1]: " << ddelta_bar[i1] << std::endl; + + //if (Acon0[j] != 0.0) { + // const double delta_offset0 = history[0]; + // const double ddelta = delta/2.0 - delta_offset0; // Divide by 2.0 since we are storing 1/2 deltan in main MDR script + // const double Ac_offset0 = history[18]; + // ddelta_bar[j] += Ac_offset0/Acon0[j]*ddelta; // Multiply by 0.5 since displacement is shared equally between deformable particles. + //} +// + //if (Acon0[i] != 0.0) { + // const double delta_offset1 = history[1]; + // const double ddelta = delta/2.0 - delta_offset1; // Divide by 2.0 since we are storing 1/2 deltan in main MDR script + // const double Ac_offset1 = history[19]; + // ddelta_bar[i] += Ac_offset1/Acon0[i]*ddelta; + //} + + } + } +} + + auto fix_list = modify->get_fix_by_style("wall/gran/region"); + + for (int w = 0; w < fix_list.size(); w++) { + + FixWallGranRegion* fix = dynamic_cast(fix_list[w]); + GranularModel * model = fix->model; + Region * region = fix->region; + + { + int i, m, nc, iwall; + double vwall[3]; + bool touchflag = false; + + int history_update = 1; + model->history_update = history_update; + + int regiondynamic = region->dynamic_check(); + if (!regiondynamic) vwall[0] = vwall[1] = vwall[2] = 0.0; + + double **x = atom->x; + double *radius = atom->radius; + int *mask = atom->mask; + int nlocal = atom->nlocal; + + if (regiondynamic) { + region->prematch(); + region->set_velocity(); + } + + if (fix->peratom_flag) fix->clear_stored_contacts(); + + model->radj = 0.0; + + for (i = 0; i < nlocal; i++) { + if (!(mask[i] & groupbit)) continue; + if (! region->match(x[i][0], x[i][1], x[i][2])) continue; + + nc = region->surface(x[i][0], x[i][1], x[i][2], radius[i] + model->pulloff_distance(radius[i], 0.0)); + + if (nc == 0) { + fix->ncontact[i] = 0; + continue; + } + if (nc == 1) { + fix->c2r[0] = 0; + iwall = region->contact[0].iwall; + if (fix->ncontact[i] == 0) { + fix->ncontact[i] = 1; + fix->walls[i][0] = iwall; + for (m = 0; m < size_history; m++) fix->history_many[i][0][m] = 0.0; + } else if (fix->ncontact[i] > 1 || iwall != fix->walls[i][0]) + fix->update_contacts(i, nc); + } else + fix->update_contacts(i, nc); + + + // process current contacts + for (int ic = 0; ic < nc; ic++) { + + // Reset model and copy initial geometric data + model->dx[0] = region->contact[ic].delx; + model->dx[1] = region->contact[ic].dely; + model->dx[2] = region->contact[ic].delz; + model->radi = radius[i]; + model->radj = region->contact[ic].radius; + model->r = region->contact[ic].r; + + if (model->beyond_contact) model->touch = fix->history_many[i][fix->c2r[ic]][0]; + + touchflag = model->check_contact(); + + const double wij = 1.0; + + if (Acon0[i] != 0.0) { + const double delta = model->radsum - model->r; + const double delta_offset0 = fix->history_many[i][fix->c2r[ic]][0]; + const double ddelta = delta - delta_offset0; + const double Ac_offset0 = fix->history_many[i][fix->c2r[ic]][18]; + ddelta_bar[i] += wij*Ac_offset0/Acon0[i]*ddelta; // Multiply by 0.5 since displacement is shared equally between deformable particles. + //std::cout << delta << ", " << delta_offset0 << " || " << Ac_offset0 << ", " << Acon0[i] << ", " << ddelta << ", " << ddelta_bar[i] << std::endl; + } + } + } + } + } + + comm->forward_comm(this); + +//and the function delcarations in the header: + +//int pack_forward_comm(int, int *, double *, int, int *) override; +//void unpack_forward_comm(int, int, double *) override; + +//Then the methods would look like:: + +//where comm_stage is a public flag to control hich quantity is being communicated + +} + +//std::cout << radius[i] << ", " << dR << ", " << dRnumerator[i] << ", " << dRdenominator[i] << ", " << dRdenominator[i] - 4.0*M_PI*pow(R,2.0) << std::endl; +//std::cout << "Fix radius update setup has been entered !!!" << std::endl; +//std::cout << Ro[0] << ", " << Vgeo[0] << ", " << Velas[0] << std::endl; \ No newline at end of file diff --git a/src/fix_mdr_mean_surf_disp.h b/src/fix_mdr_mean_surf_disp.h new file mode 100644 index 0000000000..be5be15907 --- /dev/null +++ b/src/fix_mdr_mean_surf_disp.h @@ -0,0 +1,46 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + LAMMPS development team: developers@lammps.org + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef FIX_CLASS +// clang-format off +FixStyle(mdr/mean/surf/disp,FixMDRmeanSurfDisp); +// clang-format on +#else + +#ifndef LMP_FIX_MDR_MEAN_SURF_DISP_H +#define LMP_FIX_MDR_MEAN_SURF_DISP_H + +#include "fix.h" + +namespace LAMMPS_NS { + +class FixMDRmeanSurfDisp : public Fix { + public: + double * Acon0; + double * ddelta_bar; + + FixMDRmeanSurfDisp(class LAMMPS *, int, char **); + int setmask() override; + void setup_pre_force(int) override; + void pre_force(int) override; // FOR MDR + int pack_forward_comm(int, int *, double *, int, int *) override; + void unpack_forward_comm(int, int, double *) override; + + private: + +}; + +} // namespace LAMMPS_NS + +#endif +#endif diff --git a/src/fix_mdr_radius_update.cpp b/src/fix_mdr_radius_update.cpp new file mode 100644 index 0000000000..010fad64d5 --- /dev/null +++ b/src/fix_mdr_radius_update.cpp @@ -0,0 +1,384 @@ +// clang-format off +/* ---------------------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + LAMMPS development team: developers@lammps.org + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +/* ---------------------------------------------------------------------- + Contributing authors: + William Zunker (MIT), Sachith Dunatunga (MIT), + Dan Bolintineanu (SNL), Joel Clemmer (SNL) +----------------------------------------------------------------------- */ + +#include "fix_mdr_radius_update.h" + +#include "atom.h" +#include "error.h" +#include "force.h" +#include "input.h" +#include "memory.h" +#include "modify.h" +#include "variable.h" +#include +#include "csv_writer.h" +#include "granular_model.h" +#include "pair_granular.h" +#include "pair.h" +#include "gran_sub_mod_normal.h" +#include "update.h" +#include "comm.h" +#include +#include + +using namespace LAMMPS_NS; +using namespace Granular_NS; +using namespace FixConst; + +/* ---------------------------------------------------------------------- */ + +FixMDRradiusUpdate::FixMDRradiusUpdate(LAMMPS *lmp, int narg, char **arg) : + Fix(lmp, narg, arg) +{ + comm_forward = 20; // value needs to match number of values you communicate +} + +// FOR MDR + +int FixMDRradiusUpdate::setmask() +{ + int mask = 0; + mask |= PRE_FORCE | END_OF_STEP; + return mask; +} + +void FixMDRradiusUpdate::setup_pre_force(int /*vflag*/) +{ + int tmp1, tmp2; + int index_Ro = atom->find_custom("Ro",tmp1,tmp2); + int index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); + int index_Velas = atom->find_custom("Velas",tmp1,tmp2); + int index_Vcaps = atom->find_custom("Vcaps",tmp1,tmp2); + int index_eps_bar = atom->find_custom("eps_bar",tmp1,tmp2); + int index_dRnumerator = atom->find_custom("dRnumerator",tmp1,tmp2); + int index_dRdenominator = atom->find_custom("dRdenominator",tmp1,tmp2); + int index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); + int index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); + int index_Atot = atom->find_custom("Atot",tmp1,tmp2); + int index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); + int index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); + int index_psi = atom->find_custom("psi",tmp1,tmp2); + int index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); + int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); + int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); + int index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); + int index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); + int index_contacts = atom->find_custom("contacts",tmp1,tmp2); + int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); + Ro = atom->dvector[index_Ro]; + Vgeo = atom->dvector[index_Vgeo]; + Velas = atom->dvector[index_Velas]; + Vcaps = atom->dvector[index_Vcaps]; + eps_bar = atom->dvector[index_eps_bar]; + dRnumerator = atom->dvector[index_dRnumerator]; + dRdenominator = atom->dvector[index_dRdenominator]; + Acon0 = atom->dvector[index_Acon0]; + Acon1 = atom->dvector[index_Acon1]; + Atot = atom->dvector[index_Atot]; + Atot_sum = atom->dvector[index_Atot_sum]; + ddelta_bar = atom->dvector[index_ddelta_bar]; + psi = atom->dvector[index_psi]; + psi_b = atom->dvector[index_psi_b]; + sigmaxx = atom->dvector[index_sigmaxx]; + sigmayy = atom->dvector[index_sigmayy]; + sigmazz = atom->dvector[index_sigmazz]; + history_setup_flag = atom->dvector[index_history_setup_flag]; + contacts = atom->dvector[index_contacts]; + adhesive_length = atom->dvector[index_adhesive_length]; + + pre_force(0); +} + +void FixMDRradiusUpdate::setup(int /*vflag*/) +{ + int tmp1, tmp2; + int index_Ro = atom->find_custom("Ro",tmp1,tmp2); + int index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); + int index_Velas = atom->find_custom("Velas",tmp1,tmp2); + int index_Vcaps = atom->find_custom("Vcaps",tmp1,tmp2); + int index_eps_bar = atom->find_custom("eps_bar",tmp1,tmp2); + int index_dRnumerator = atom->find_custom("dRnumerator",tmp1,tmp2); + int index_dRdenominator = atom->find_custom("dRdenominator",tmp1,tmp2); + int index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); + int index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); + int index_Atot = atom->find_custom("Atot",tmp1,tmp2); + int index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); + int index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); + int index_psi = atom->find_custom("psi",tmp1,tmp2); + int index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); + int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); + int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); + int index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); + int index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); + int index_contacts = atom->find_custom("contacts",tmp1,tmp2); + int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); + Ro = atom->dvector[index_Ro]; + Vgeo = atom->dvector[index_Vgeo]; + Velas = atom->dvector[index_Velas]; + Vcaps = atom->dvector[index_Vcaps]; + eps_bar = atom->dvector[index_eps_bar]; + dRnumerator = atom->dvector[index_dRnumerator]; + dRdenominator = atom->dvector[index_dRdenominator]; + Acon0 = atom->dvector[index_Acon0]; + Acon1 = atom->dvector[index_Acon1]; + Atot = atom->dvector[index_Atot]; + Atot_sum = atom->dvector[index_Atot_sum]; + ddelta_bar = atom->dvector[index_ddelta_bar]; + psi = atom->dvector[index_psi]; + psi_b = atom->dvector[index_psi_b]; + sigmaxx = atom->dvector[index_sigmaxx]; + sigmayy = atom->dvector[index_sigmayy]; + sigmazz = atom->dvector[index_sigmazz]; + history_setup_flag = atom->dvector[index_history_setup_flag]; + contacts = atom->dvector[index_contacts]; + adhesive_length = atom->dvector[index_adhesive_length]; + + end_of_step(); +} + +void FixMDRradiusUpdate::pre_force(int) +{ + + PairGranular * pair = dynamic_cast(force->pair_match("granular",1)); + class GranularModel* model; + class GranularModel** models_list = pair->models_list; + class GranSubModNormalMDR* norm_model = nullptr; + for (int i = 0; i < pair->nmodels; i++) { + model = models_list[i]; + if (model->normal_model->name == "mdr") norm_model = dynamic_cast(model->normal_model); + } + if (norm_model == nullptr) error->all(FLERR, "Did not find mdr model"); + //model = models_list[0]; + //class GranSubModNormalMDR* norm_model = dynamic_cast(model->normal_model); + + //std::cout << "Preforce was called radius update" << std::endl; + + // assign correct value to initially non-zero MDR particle history variables + //int tmp1, tmp2; + //int index_Ro = atom->find_custom("Ro",tmp1,tmp2); + //int index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); + //int index_Velas = atom->find_custom("Velas",tmp1,tmp2); + //int index_Atot = atom->find_custom("Atot",tmp1,tmp2); + //int index_psi = atom->find_custom("psi",tmp1,tmp2); + //int index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); + //int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); + //int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); + //int index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); + //int index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); + //int index_contacts = atom->find_custom("contacts",tmp1,tmp2); + //int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); + //double * Ro = atom->dvector[index_Ro]; + //double * Vgeo = atom->dvector[index_Vgeo]; + //double * Velas = atom->dvector[index_Velas]; + //double * Atot = atom->dvector[index_Atot]; + //double * psi = atom->dvector[index_psi]; + //double * psi_b = atom->dvector[index_psi_b]; + //double * sigmaxx = atom->dvector[index_sigmaxx]; + //double * sigmayy = atom->dvector[index_sigmayy]; + //double * sigmazz = atom->dvector[index_sigmazz]; + //double * history_setup_flag = atom->dvector[index_history_setup_flag]; + //double * contacts = atom->dvector[index_contacts]; + //double * adhesive_length = atom->dvector[index_adhesive_length]; + + double *radius = atom->radius; + int nlocal = atom->nlocal; + + //std::cout << "ntotal " << ntotal << ", nlocal " << atom->nlocal << ", nghost " << atom->nghost << std::endl; + + for (int i = 0; i < nlocal; i++) { + if (history_setup_flag[i] < 1e-16) { + Ro[i] = radius[i]; + Vgeo[i] = 4.0/3.0*M_PI*pow(Ro[i],3.0); + Velas[i] = 4.0/3.0*M_PI*pow(Ro[i],3.0); + Atot[i] = 4.0*M_PI*pow(Ro[i],2.0); + psi[i] = 1.0; + psi_b[i] = norm_model->psi_b; + history_setup_flag[i] = 1.0; + } + sigmaxx[i] = 0.0; + sigmayy[i] = 0.0; + sigmazz[i] = 0.0; + contacts[i] = 0.0; + adhesive_length[i] = 0.0; + } + + comm->forward_comm(this); + +} + +int FixMDRradiusUpdate::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/,int * /*pbc*/) +{ + int m = 0; + for (int i = 0; i < n; i++) { + int j = list[i]; + buf[m++] = Ro[j]; // 1 + buf[m++] = Vgeo[j]; // 2 + buf[m++] = Velas[j]; // 3 + buf[m++] = Vcaps[j]; // 4 + buf[m++] = eps_bar[j]; // 5 + buf[m++] = dRnumerator[j]; // 6 + buf[m++] = dRdenominator[j]; // 7 + buf[m++] = Acon0[j]; // 8 + buf[m++] = Acon1[j]; // 9 + buf[m++] = Atot[j]; // 10 + buf[m++] = Atot_sum[j]; // 11 + buf[m++] = ddelta_bar[j]; // 12 + buf[m++] = psi[j]; // 13 + buf[m++] = psi_b[j]; // 14 + buf[m++] = sigmaxx[j]; // 15 + buf[m++] = sigmayy[j]; // 16 + buf[m++] = sigmazz[j]; // 17 + buf[m++] = history_setup_flag[j]; // 18 + buf[m++] = contacts[j]; // 19 + buf[m++] = adhesive_length[j]; // 20 + } + return m; +} + +void FixMDRradiusUpdate::unpack_forward_comm(int n, int first, double *buf) +{ + int m = 0; + int last = first + n; + for (int i = first; i < last; i++) { + Ro[i] = buf[m++]; // 1 + Vgeo[i] = buf[m++]; // 2 + Velas[i] = buf[m++]; // 3 + Vcaps[i] = buf[m++]; // 4 + eps_bar[i] = buf[m++]; // 5 + dRnumerator[i] = buf[m++]; // 6 + dRdenominator[i] = buf[m++]; // 7 + Acon0[i] = buf[m++]; // 8 + Acon1[i] = buf[m++]; // 9 + Atot[i] = buf[m++]; // 10 + Atot_sum[i] = buf[m++]; // 11 + ddelta_bar[i] = buf[m++]; // 12 + psi[i] = buf[m++]; // 13 + psi_b[i] = buf[m++]; // 14 + sigmaxx[i] = buf[m++]; // 15 + sigmayy[i] = buf[m++]; // 16 + sigmazz[i] = buf[m++]; // 17 + history_setup_flag[i] = buf[m++]; // 18 + contacts[i] = buf[m++]; // 19 + adhesive_length[i] = buf[m++]; // 20 + } +} + +void FixMDRradiusUpdate::end_of_step() +{ + + //comm->forward_comm(this); + + //std::cout << "end_of_step() was called radius update" << std::endl; + + // update the apparent radius of every particle + + double *radius = atom->radius; + int nlocal = atom->nlocal; + double sigmaxx_sum = 0.0; + double sigmayy_sum = 0.0; + double sigmazz_sum = 0.0; + double Vparticles = 0.0; + + //std::cout << "New step" << std::endl; + + for (int i = 0; i < nlocal; i++) { + + const double R = radius[i]; + Atot[i] = 4.0*M_PI*pow(R,2.0) + Atot_sum[i]; + + const double Vo = 4.0/3.0*M_PI*pow(Ro[i],3.0); + const double Vgeoi = 4.0/3.0*M_PI*pow(R,3.0) - Vcaps[i]; + Vgeo[i] = std::min(Vgeoi,Vo); + //(Vgeoi < Vo) ? Vgeo[i] = Vgeoi : Vgeo[i] = Vo; + + const double Afree = Atot[i] - Acon1[i]; + psi[i] = Afree/Atot[i]; + + //if (psi[i] < 0.08) { + // std::cout << "psi is: " << psi[i] << std::endl; + //} + + const double dR = std::max(dRnumerator[i]/(dRdenominator[i] - 4.0*M_PI*pow(R,2.0)),0.0); + if (psi_b[i] < psi[i]) { + if ((radius[i] + dR) < (1.5*Ro[i])) radius[i] += dR; + //radius[i] += dR; + } + + //if (dR > 1e-7) { + // std::cout << "big dR change" << std::endl; + //} + //if (atom->tag[i] == 9){ + // std::cout << i << ", radius: " << radius[i] << ", dR: " << dR << ", dRnum: " << dRnumerator[i] << ", dRdenom " << dRdenominator[i] << ", dRdem_full " << dRdenominator[i] - 4.0*M_PI*pow(R,2.0) << std::endl; + //} + + + //std::cout << i << ", " << radius[i] << " | " << psi_b[i] << ", " << psi[i] << " | " << Acon1[i] << ", " << Atot[i] << std::endl; + + + Velas[i] = Vo*(1.0 + eps_bar[i]); + Vcaps[i] = 0.0; + eps_bar[i] = 0.0; + dRnumerator[i] = 0.0; + dRdenominator[i] = 0.0; + Acon0[i] = Acon1[i]; + Acon1[i] = 0.0; + //std::cout << "Acon reset: " << Acon0[i] << ", " << Acon1[i] << std::endl; + Atot_sum[i] = 0.0; + ddelta_bar[i] = 0.0; + //adhesive_length[i] = adhesive_length[i]/contacts[i]; // convert adhesive length to average aAdh for each particle + + + //if (lmp->update->ntimestep == 487500) { + // double **x = atom->x; + // CSVWriter csvWriter("/Users/willzunker/lammps_mdr_develop/sims/avicelTableting/atom_stresses_at_mid_compression.csv"); + // std::stringstream rowDataStream; + // rowDataStream << std::scientific << std::setprecision(4); // Set the format and precision + // rowDataStream << sigmaxx[i] << ", " << sigmayy[i] << ", " << sigmazz[i] << ", " << Velas[i] << ", " << x[i][2]; + // std::string rowData = rowDataStream.str(); + // csvWriter.writeRow(rowData); + //} +// + //if (lmp->update->ntimestep == 595750) { + // double **x = atom->x; + // CSVWriter csvWriter("/Users/willzunker/lammps_mdr_develop/sims/avicelTableting/atom_stresses_at_max_compression.csv"); + // std::stringstream rowDataStream; + // rowDataStream << std::scientific << std::setprecision(4); // Set the format and precision + // rowDataStream << sigmaxx[i] << ", " << sigmayy[i] << ", " << sigmazz[i] << ", " << Velas[i] << ", " << x[i][2]; + // std::string rowData = rowDataStream.str(); + // csvWriter.writeRow(rowData); + //} + + + //sigmaxx_sum += sigmaxx[i]; + //sigmayy_sum += sigmayy[i]; + //sigmazz_sum += sigmazz[i]; + //Vparticles += Velas[i]; + } + + //double sigmaxx_avg = sigmaxx_sum/nlocal; + //double sigmayy_avg = sigmayy_sum/nlocal; + //double sigmazz_avg = sigmazz_sum/nlocal; + + comm->forward_comm(this); +} + +//std::cout << radius[i] << ", " << dR << ", " << dRnumerator[i] << ", " << dRdenominator[i] << ", " << dRdenominator[i] - 4.0*M_PI*pow(R,2.0) << std::endl; +//std::cout << "Fix radius update setup has been entered !!!" << std::endl; +//std::cout << Ro[0] << ", " << Vgeo[0] << ", " << Velas[0] << std::endl; \ No newline at end of file diff --git a/src/fix_mdr_radius_update.h b/src/fix_mdr_radius_update.h new file mode 100644 index 0000000000..e53366c25e --- /dev/null +++ b/src/fix_mdr_radius_update.h @@ -0,0 +1,66 @@ +/* -*- c++ -*- ---------------------------------------------------------- + LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator + https://www.lammps.org/, Sandia National Laboratories + LAMMPS development team: developers@lammps.org + + Copyright (2003) Sandia Corporation. Under the terms of Contract + DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains + certain rights in this software. This software is distributed under + the GNU General Public License. + + See the README file in the top-level LAMMPS directory. +------------------------------------------------------------------------- */ + +#ifdef FIX_CLASS +// clang-format off +FixStyle(mdr/radius/update,FixMDRradiusUpdate); +// clang-format on +#else + +#ifndef LMP_FIX_MDR_RADIUS_UPDATE_H +#define LMP_FIX_MDR_RADIUS_UPDATE_H + +#include "fix.h" + +namespace LAMMPS_NS { + +class FixMDRradiusUpdate : public Fix { + public: + double * Ro; + double * Vgeo; + double * Velas; + double * Vcaps; + double * eps_bar; + double * dRnumerator; + double * dRdenominator; + double * Acon0; + double * Acon1; + double * Atot; + double * Atot_sum; + double * ddelta_bar; + double * psi; + double * psi_b; + double * sigmaxx; + double * sigmayy; + double * sigmazz; + double * history_setup_flag; + double * contacts; + double * adhesive_length; + + FixMDRradiusUpdate(class LAMMPS *, int, char **); + int setmask() override; + void setup(int) override; + void setup_pre_force(int) override; + void pre_force(int) override; + void end_of_step() override; // FOR MDR + int pack_forward_comm(int, int *, double *, int, int *) override; + void unpack_forward_comm(int, int, double *) override; + + private: + +}; + +} // namespace LAMMPS_NS + +#endif +#endif diff --git a/src/variable.cpp b/src/variable.cpp index b0667b9941..350d6a7141 100644 --- a/src/variable.cpp +++ b/src/variable.cpp @@ -77,7 +77,7 @@ enum{DONE,ADD,SUBTRACT,MULTIPLY,DIVIDE,CARAT,MODULO,UNARY, SQRT,EXP,LN,LOG,ABS,SIN,COS,TAN,ASIN,ACOS,ATAN,ATAN2, RANDOM,NORMAL,CEIL,FLOOR,ROUND,TERNARY, RAMP,STAGGER,LOGFREQ,LOGFREQ2,LOGFREQ3,STRIDE,STRIDE2, - VDISPLACE,SWIGGLE,CWIGGLE,GMASK,RMASK, + VDISPLACE,SWIGGLE,CWIGGLE,SIGN,GMASK,RMASK, GRMASK,IS_ACTIVE,IS_DEFINED,IS_AVAILABLE,IS_FILE,EXTRACT_SETTING, VALUE,ATOMARRAY,TYPEARRAY,INTARRAY,BIGINTARRAY,VECTORARRAY}; @@ -2575,7 +2575,7 @@ double Variable::evaluate(char *str, Tree **tree, int ivar) atan2(y,x),random(x,y,z),normal(x,y,z),ceil(),floor(),round(),ternary(x,y,z), ramp(x,y),stagger(x,y),logfreq(x,y,z),logfreq2(x,y,z), logfreq3(x,y,z),stride(x,y,z),stride2(x,y,z,a,b,c),vdisplace(x,y),swiggle(x,y,z), - cwiggle(x,y,z),gmask(x),rmask(x),grmask(x,y) + cwiggle(x,y,z),sign(x),gmask(x),rmask(x),grmask(x,y) ---------------------------------------------------------------------- */ double Variable::collapse_tree(Tree *tree) @@ -3125,6 +3125,14 @@ double Variable::collapse_tree(Tree *tree) return tree->value; } + if (tree->type == SIGN) { + arg1 = collapse_tree(tree->first); + if (tree->first->type != VALUE) return 0.0; + tree->type = VALUE; + tree->value = (arg1 >= 0.0) ? 1.0 : -1.0; // sign(arg1); + return tree->value; + } + // mask functions do not become a single collapsed value if (tree->type == GMASK) return 0.0; @@ -3143,7 +3151,7 @@ double Variable::collapse_tree(Tree *tree) atan2(y,x),random(x,y,z),normal(x,y,z),ceil(),floor(),round(),ternary(x,y,z), ramp(x,y),stagger(x,y),logfreq(x,y,z),logfreq2(x,y,z), logfreq3(x,y,z),stride(x,y,z),stride2(x,y,z,a,b,c),vdisplace(x,y), - swiggle(x,y,z),cwiggle(x,y,z),gmask(x),rmask(x),grmask(x,y) + swiggle(x,y,z),cwiggle(x,y,z),sign(x),gmask(x),rmask(x),grmask(x,y) ---------------------------------------------------------------------- */ double Variable::eval_tree(Tree *tree, int i) @@ -3459,6 +3467,9 @@ double Variable::eval_tree(Tree *tree, int i) return arg; } + if (tree->type == SIGN) + return (eval_tree(tree->first,i) >= 0.0) ? 1.0 : -1.0; // sign(eval_tree(tree->first,i)); + if (tree->type == GMASK) { if (atom->mask[i] & tree->ivalue) return 1.0; else return 0.0; @@ -3650,7 +3661,7 @@ int Variable::math_function(char *word, char *contents, Tree **tree, Tree **tree strcmp(word,"logfreq") != 0 && strcmp(word,"logfreq2") != 0 && strcmp(word,"logfreq3") != 0 && strcmp(word,"stride") != 0 && strcmp(word,"stride2") != 0 && strcmp(word,"vdisplace") != 0 && - strcmp(word,"swiggle") != 0 && strcmp(word,"cwiggle") != 0) + strcmp(word,"swiggle") != 0 && strcmp(word,"cwiggle") != 0 && strcmp(word,"sign") != 0) return 0; // parse contents for comma-separated args @@ -4045,6 +4056,11 @@ int Variable::math_function(char *word, char *contents, Tree **tree, Tree **tree double value = value1 + value2*(1.0-cos(omega*delta*update->dt)); argstack[nargstack++] = value; } + } else if (strcmp(word,"sign") == 0) { + if (narg != 1) + print_var_error(FLERR,"Invalid math function in variable formula",ivar); + if (tree) newtree->type = SIGN; + else argstack[nargstack++] = (value1 >= 0.0) ? 1.0 : -1.0; // sign(value1); } // delete stored args diff --git a/src/verlet.cpp b/src/verlet.cpp index 0222a0d2a0..d72383bf4a 100644 --- a/src/verlet.cpp +++ b/src/verlet.cpp @@ -282,7 +282,7 @@ void Verlet::run(int n) } timer->stamp(); comm->exchange(); - if (sortflag && ntimestep >= atom->nextsort) atom->sort(); + //if (sortflag && ntimestep >= atom->nextsort) atom->sort(); comm->borders(); if (triclinic) domain->lamda2x(atom->nlocal+atom->nghost); timer->stamp(Timer::COMM); From e48f288e2b7a66046f1c3147c49d435c9bd60a94 Mon Sep 17 00:00:00 2001 From: Sachith Dunatunga Date: Sat, 14 Dec 2024 13:20:16 -0800 Subject: [PATCH 02/74] result of "make fix-whitespace" --- src/GRANULAR/fix_wall_gran.h | 2 +- src/GRANULAR/fix_wall_gran_region.cpp | 2 +- src/GRANULAR/fix_wall_gran_region.h | 10 +- src/GRANULAR/gran_sub_mod_normal.cpp | 204 +++++++++++++------------- src/GRANULAR/pair_granular.cpp | 18 +-- src/GRANULAR/pair_granular.h | 2 +- src/csv_writer.h | 2 +- src/fix_mdr_mean_surf_disp.cpp | 46 +++--- src/fix_mdr_mean_surf_disp.h | 6 +- src/fix_mdr_radius_update.cpp | 96 ++++++------ src/fix_mdr_radius_update.h | 6 +- src/variable.cpp | 2 +- 12 files changed, 198 insertions(+), 198 deletions(-) diff --git a/src/GRANULAR/fix_wall_gran.h b/src/GRANULAR/fix_wall_gran.h index f8d351051c..16b1b228ab 100644 --- a/src/GRANULAR/fix_wall_gran.h +++ b/src/GRANULAR/fix_wall_gran.h @@ -87,7 +87,7 @@ class FixWallGran : public Fix { int store; - + }; } // namespace LAMMPS_NS diff --git a/src/GRANULAR/fix_wall_gran_region.cpp b/src/GRANULAR/fix_wall_gran_region.cpp index 7eba3bdfb3..ba8cd467ec 100644 --- a/src/GRANULAR/fix_wall_gran_region.cpp +++ b/src/GRANULAR/fix_wall_gran_region.cpp @@ -231,7 +231,7 @@ void FixWallGranRegion::post_force(int /*vflag*/) model->radi = radius[i]; model->radj = region->contact[ic].radius; model->r = region->contact[ic].r; - model->i = i; // Added for MDR + model->i = i; // Added for MDR model->j = ic; // Added for MDR if (model->beyond_contact) model->touch = history_many[i][c2r[ic]][0]; diff --git a/src/GRANULAR/fix_wall_gran_region.h b/src/GRANULAR/fix_wall_gran_region.h index e9e24415bc..6f9866d8ae 100644 --- a/src/GRANULAR/fix_wall_gran_region.h +++ b/src/GRANULAR/fix_wall_gran_region.h @@ -53,20 +53,20 @@ class FixWallGranRegion : public FixWallGran { int tmax; // MOVED FROM PRIVATE TO PUBLIC FOR MDR MODEL private: - + int nregion; // shear history for multiple contacts per particle - - - + + + // c2r[i] = index of Ith contact in // region-contact[] list of contacts int motion_resetflag; // used by restart to indicate that region // vel info is to be reset - + }; } // namespace LAMMPS_NS diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index bf3d045c2f..3521f0be72 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -22,7 +22,7 @@ #include #include -#include +#include #include using namespace LAMMPS_NS; @@ -401,12 +401,12 @@ GranSubModNormalMDR::GranSubModNormalMDR(GranularModel *gm, LAMMPS *lmp) : { num_coeffs = 6; // Young's Modulus, Poisson's ratio, yield stress, effective surface energy, psi_b, coefficent of restitution contact_radius_flag = 1; - size_history = 26; + size_history = 26; nondefault_history_transfer = 1; transfer_history_factor = new double[size_history]; //transfer_history_factor[0] = +1; - for (int i = 0; i < size_history; i++) { + for (int i = 0; i < size_history; i++) { transfer_history_factor[i] = +1; } } @@ -435,18 +435,18 @@ void GranSubModNormalMDR::coeffs_to_local() double GranSubModNormalMDR::calculate_forces() { - // To understand the structure of the overall code it is important to consider + // To understand the structure of the overall code it is important to consider // the following: // - // The MDR contact model was developed by imagining individual particles being - // squished between a number of rigid flats (references below). To allow - // for many interacting particles, we extend the idea of isolated particles surrounded - // by rigid flats. In particular, we imagine placing rigid flats at the overlap + // The MDR contact model was developed by imagining individual particles being + // squished between a number of rigid flats (references below). To allow + // for many interacting particles, we extend the idea of isolated particles surrounded + // by rigid flats. In particular, we imagine placing rigid flats at the overlap // midpoints between particles. The force is calculated seperately on both sides - // of the contact assuming interaction with a rigid flat. The two forces are then - // averaged on either side of the contact to determine the final force. If the + // of the contact assuming interaction with a rigid flat. The two forces are then + // averaged on either side of the contact to determine the final force. If the // contact is between a particle and wall then only one force evaluation is required. - // + // // Zunker and Kamrin, 2024, Part I: https://doi.org/10.1016/j.jmps.2023.105492 // Zunker and Kamrin, 2024, Part II: https://doi.org/10.1016/j.jmps.2023.105493 @@ -456,8 +456,8 @@ double GranSubModNormalMDR::calculate_forces() const int j_true = gm->j; // true j particle index const double radi_true = gm->radi; // true i particle initial radius const double radj_true = gm->radj; // true j particle initial radius - - F = 0.0; // average force + + F = 0.0; // average force double F0 = 0.0; // force on contact side 0 double F1 = 0.0; // force on contact side 1 double R0 = 0.0; @@ -465,21 +465,21 @@ double GranSubModNormalMDR::calculate_forces() int i0 = 0; int i1 = 0; double delta = gm->delta; // apparent overlap - - //if (gm->contact_type == PAIR) delta = gm->delta/2.0; // half displacement to imagine interaction with rigid flat - //std::cout << "Normal force is called for: " << i_true << ", " << j_true << std::endl; - //std::cout << "Contact model has been entered " << gm->contact_type << ", " << PAIR << ", " << WALL << ", " << WALLREGION << ", " << gm->itype << ", " << gm->jtype << ", " << gm->delta << std::endl; - // initialize indexing in history array of different constact history variables - const int delta_offset_0 = 0; // apparent overlap - const int delta_offset_1 = 1; - const int deltao_offset_0 = 2; // displacement - const int deltao_offset_1 = 3; + //if (gm->contact_type == PAIR) delta = gm->delta/2.0; // half displacement to imagine interaction with rigid flat + //std::cout << "Normal force is called for: " << i_true << ", " << j_true << std::endl; + //std::cout << "Contact model has been entered " << gm->contact_type << ", " << PAIR << ", " << WALL << ", " << WALLREGION << ", " << gm->itype << ", " << gm->jtype << ", " << gm->delta << std::endl; + + // initialize indexing in history array of different constact history variables + const int delta_offset_0 = 0; // apparent overlap + const int delta_offset_1 = 1; + const int deltao_offset_0 = 2; // displacement + const int deltao_offset_1 = 3; const int delta_MDR_offset_0 = 4; // MDR apparent overlap const int delta_MDR_offset_1 = 5; const int delta_BULK_offset_0 = 6; // bulk displacement const int delta_BULK_offset_1 = 7; - const int deltamax_MDR_offset_0 = 8; // maximum MDR apparent overlap + const int deltamax_MDR_offset_0 = 8; // maximum MDR apparent overlap const int deltamax_MDR_offset_1 = 9; const int Yflag_offset_0 = 10; // yield flag const int Yflag_offset_1 = 11; @@ -493,32 +493,32 @@ double GranSubModNormalMDR::calculate_forces() const int Ac_offset_1 = 19; const int eps_bar_offset_0 = 20; // volume-averaged infinitesimal strain tensor const int eps_bar_offset_1 = 21; - const int penalty_offset_ = 22; // contact penalty + const int penalty_offset_ = 22; // contact penalty const int deltamax_offset_ = 23; const int deltap_offset_0 = 24; const int deltap_offset_1 = 25; - // initialize particle history variables + // initialize particle history variables int tmp1, tmp2; int index_Ro = atom->find_custom("Ro",tmp1,tmp2); // initial radius int index_Vcaps = atom->find_custom("Vcaps",tmp1,tmp2); // spherical cap volume from intersection of apparent radius particle and contact planes int index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); // geometric particle volume of apparent particle after removing spherical cap volume - int index_Velas = atom->find_custom("Velas",tmp1,tmp2); // particle volume from linear elasticity + int index_Velas = atom->find_custom("Velas",tmp1,tmp2); // particle volume from linear elasticity int index_eps_bar = atom->find_custom("eps_bar",tmp1,tmp2); // volume-averaged infinitesimal strain tensor int index_dRnumerator = atom->find_custom("dRnumerator",tmp1,tmp2); // summation of numerator terms in calculation of dR int index_dRdenominator = atom->find_custom("dRdenominator",tmp1,tmp2); // summation of denominator terms in calculation of dR - int index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); // total area involved in contacts: Acon^{n} + int index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); // total area involved in contacts: Acon^{n} int index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); // total area involved in contacts: Acon^{n+1} - int index_Atot = atom->find_custom("Atot",tmp1,tmp2); // total particle area + int index_Atot = atom->find_custom("Atot",tmp1,tmp2); // total particle area int index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); // running sum of contact area minus cap area int index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); // change in mean surface displacement int index_psi = atom->find_custom("psi",tmp1,tmp2); // ratio of free surface area to total surface area int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); // xx-component of the stress tensor, not necessary for force calculation - int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); // yy-component of the stress tensor, not necessary for force calculation - int index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); // zz-component of the stress tensor, not necessary for force calculation - int index_contacts = atom->find_custom("contacts",tmp1,tmp2); // total contacts on particle - int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); // total contacts on particle + int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); // yy-component of the stress tensor, not necessary for force calculation + int index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); // zz-component of the stress tensor, not necessary for force calculation + int index_contacts = atom->find_custom("contacts",tmp1,tmp2); // total contacts on particle + int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); // total contacts on particle double * Rinitial = atom->dvector[index_Ro]; double * Vgeo = atom->dvector[index_Vgeo]; double * Velas = atom->dvector[index_Velas]; @@ -527,7 +527,7 @@ double GranSubModNormalMDR::calculate_forces() double * dRnumerator = atom->dvector[index_dRnumerator]; double * dRdenominator = atom->dvector[index_dRdenominator]; double * Acon0 = atom->dvector[index_Acon0]; - double * Acon1 = atom->dvector[index_Acon1]; + double * Acon1 = atom->dvector[index_Acon1]; double * Atot = atom->dvector[index_Atot]; double * Atot_sum = atom->dvector[index_Atot_sum]; double * ddelta_bar = atom->dvector[index_ddelta_bar]; @@ -537,9 +537,9 @@ double GranSubModNormalMDR::calculate_forces() double * sigmazz = atom->dvector[index_sigmazz]; double * contacts = atom->dvector[index_contacts]; double * adhesive_length = atom->dvector[index_adhesive_length]; - - double * history = & gm->history[history_index]; // load in all history variables + + double * history = & gm->history[history_index]; // load in all history variables // Rigid flat placement scheme double * deltamax_offset = & history[deltamax_offset_]; @@ -552,19 +552,19 @@ double GranSubModNormalMDR::calculate_forces() if (gm->delta >= *deltamax_offset) *deltamax_offset = gm->delta; deltamax = *deltamax_offset; - for (int contactSide = 0; contactSide < 2; contactSide++) { + for (int contactSide = 0; contactSide < 2; contactSide++) { - double * delta_offset; + double * delta_offset; double * deltao_offset; - double * delta_MDR_offset; - double * delta_BULK_offset; - double * deltamax_MDR_offset; - double * Yflag_offset; - double * deltaY_offset; + double * delta_MDR_offset; + double * delta_BULK_offset; + double * deltamax_MDR_offset; + double * Yflag_offset; + double * deltaY_offset; double * cA_offset; - double * aAdh_offset; - double * Ac_offset; - double * eps_bar_offset; + double * aAdh_offset; + double * Ac_offset; + double * eps_bar_offset; double * penalty_offset; double * deltap_offset; @@ -631,7 +631,7 @@ double GranSubModNormalMDR::calculate_forces() gm->radi = radj_true; gm->radj = radi_true; } - + double delta_geo; double delta_geo_alt; double delta_geoOpt1 = deltamax*(deltamax - 2.0*R1)/(2.0*(deltamax - R0 - R1)); @@ -649,7 +649,7 @@ double GranSubModNormalMDR::calculate_forces() delta = delta_geo + (deltap1 - delta_geo)/(deltap - deltamax)*(gm->delta-deltamax); //std::cout << "CS 1: " << gm->radi << ", " << gm->radj << ", gm->delta " << gm->delta << ", delta " << delta << ", deltamax " << deltamax << ", delta_geo " << delta_geo << ", delta_geo_alt " << delta_geo_alt << ", delta_geo/Ri " << delta_geo/gm->radi << ", delta_geo_alt/Rj " << delta_geo_alt/gm->radj << ", delta_geoOpt1 " << delta_geoOpt1 << ", delta_geoOpt2 " << delta_geoOpt2 << ", deltamax-delta " << (deltamax-gm->delta) << std::endl; - + delta_offset = & history[delta_offset_1]; deltao_offset = & history[deltao_offset_1]; delta_MDR_offset = & history[delta_MDR_offset_1]; @@ -678,8 +678,8 @@ double GranSubModNormalMDR::calculate_forces() const double Ro = Rinitial[i]; // initial radius const double R = gm->radi; // apparent radius - - // kinematics + + // kinematics const double ddelta = delta - *delta_offset; *delta_offset = delta; @@ -689,7 +689,7 @@ double GranSubModNormalMDR::calculate_forces() double ddelta_MDR; double ddelta_BULK; - if ( psi[i] < psi_b ) { // if true, bulk response has triggered, split displacement increment between the MDR and BULK components + if ( psi[i] < psi_b ) { // if true, bulk response has triggered, split displacement increment between the MDR and BULK components ddelta_MDR = std::min(ddelta-ddelta_bar[i], delta-*delta_MDR_offset); ddelta_BULK = ddelta_bar[i]; } else { // if false, no bulk response, full displacement increment goes to the MDR component @@ -712,7 +712,7 @@ double GranSubModNormalMDR::calculate_forces() *deltaY_offset = delta_MDR; *cA_offset = M_PI*(pow(*deltaY_offset,2.0) - *deltaY_offset*R); } - } + } //if (i_true == 167 && j_true == 204) { //std::cout << "i " << i << " | j " << j << " | delta_BULK: " << delta_BULK << " | delta_MDR " << delta_MDR << " | ddelta_BULK " << ddelta_BULK << " | ddelta_MDR " << ddelta_MDR << std::endl; @@ -725,25 +725,25 @@ double GranSubModNormalMDR::calculate_forces() double A; // height of elliptical indenter double B; // width of elliptical indenter double deltae1D; // transformed elastic displacement - double deltaR; // displacement correction + double deltaR; // displacement correction double amax; // maximum experienced contact radius const double cA = *cA_offset; // contact area intercept if ( *Yflag_offset == 0.0 ) { // elastic contact - A = 4.0*R; - B = 2.0*R; - deltae1D = delta_MDR; - (deltae1D > 0) ? amax = sqrt(deltae1D*R) : amax = 0.0; + A = 4.0*R; + B = 2.0*R; + deltae1D = delta_MDR; + (deltae1D > 0) ? amax = sqrt(deltae1D*R) : amax = 0.0; } else { // plastic contact - amax = sqrt((2.0*deltamax_MDR*R - pow(deltamax_MDR,2.0)) + cA/M_PI); - A = 4.0*pY/Eeff*amax; - B = 2.0*amax; - const double deltae1Dmax = A/2.0; // maximum transformed elastic displacement + amax = sqrt((2.0*deltamax_MDR*R - pow(deltamax_MDR,2.0)) + cA/M_PI); + A = 4.0*pY/Eeff*amax; + B = 2.0*amax; + const double deltae1Dmax = A/2.0; // maximum transformed elastic displacement const double Fmax = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltae1Dmax/A) - (1.0 - 2.0*deltae1Dmax/A)*sqrt(4.0*deltae1Dmax/A - 4.0*pow(deltae1Dmax,2.0)/pow(A,2.0))); // force caused by full submersion of elliptical indenter to depth of A/2 const double zR = R - (deltamax_MDR - deltae1Dmax); // depth of particle center - deltaR = (Fmax*(2*pow(amax,2.0)*(-1 + nu) - (-1 + 2*nu)*zR*(-zR + sqrt(pow(amax,2.0) + pow(zR,2.0)))))/((M_PI*pow(amax,2.0))*2*G*sqrt(pow(amax,2.0) + pow(zR,2.0))); - deltae1D = (delta_MDR - deltamax_MDR + deltae1Dmax + deltaR)/(1 + deltaR/deltae1Dmax); // transformed elastic displacement - + deltaR = (Fmax*(2*pow(amax,2.0)*(-1 + nu) - (-1 + 2*nu)*zR*(-zR + sqrt(pow(amax,2.0) + pow(zR,2.0)))))/((M_PI*pow(amax,2.0))*2*G*sqrt(pow(amax,2.0) + pow(zR,2.0))); + deltae1D = (delta_MDR - deltamax_MDR + deltae1Dmax + deltaR)/(1 + deltaR/deltae1Dmax); // transformed elastic displacement + // added for rigid flat placement *deltap_offset = deltamax_MDR - (deltae1Dmax + deltaR); //std::cout << *deltap_offset << std::endl; @@ -755,7 +755,7 @@ double GranSubModNormalMDR::calculate_forces() double a_na; double a_fac = 0.99; (deltae1D >= 0.0) ? a_na = B*sqrt(A - deltae1D)*sqrt(deltae1D)/A : a_na = 0.0; - double aAdh = *aAdh_offset; + double aAdh = *aAdh_offset; if (aAdh > a_fac*amax) aAdh = a_fac*amax; //if (i_true == 4 && j_true == 52){ @@ -764,9 +764,9 @@ double GranSubModNormalMDR::calculate_forces() if ( gamma > 0.0 ) { // adhesive contact double g_aAdh; - + if (delta_MDR == deltamax_MDR || a_na >= aAdh ) { // case 1: no tensile springs, purely compressive contact - (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltae1D/A) - (1.0 - 2.0*deltae1D/A)*sqrt(4.0*deltae1D/A - 4.0*pow(deltae1D,2.0)/pow(A,2.0))); + (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltae1D/A) - (1.0 - 2.0*deltae1D/A)*sqrt(4.0*deltae1D/A - 4.0*pow(deltae1D,2.0)/pow(A,2.0))); if ( std::isnan(F_MDR) ) { std::cout << "F_MDR is NaN, case 1: no tensile springs" << std::endl; //std::cout << "Normal model: " << gm->delta << ", " << ddelta << ", " << gm->radi << ", " << gm->radj << " | delta: " << delta0 << ", " << delta1 << " | delta2_offset: " << *delta2_offset0 << ", " << *delta2_offset1 << "| dde: " << dde0 << ", " << dde1 << "| Fold: " << F0old << ", " << F1old << " | a: " << a0 << ", " << a1 << " | k_BULK: " << k_BULK0 << ", " << k_BULK1 << " | h_BULK: " << h_BULK0 << ", " << h_BULK1 << std::endl; @@ -775,7 +775,7 @@ double GranSubModNormalMDR::calculate_forces() } *aAdh_offset = a_fac*a_na; } else { - const double lmax = sqrt(2.0*M_PI*aAdh*gamma/Eeff); + const double lmax = sqrt(2.0*M_PI*aAdh*gamma/Eeff); g_aAdh = A/2 - A/B*sqrt(pow(B,2.0)/4 - pow(aAdh,2.0)); const double acrit = (-((pow(B,2)*gamma*M_PI)/(pow(A,2)*Eeff)) + (pow(2,0.3333333333333333)*pow(B,4)*pow(gamma,2)*pow(M_PI,1.6666666666666667))/ (pow(A,2)*pow(Eeff,2)*pow((27*pow(A,4)*pow(B,4)*gamma)/Eeff - (2*pow(B,6)*pow(gamma,3)*pow(M_PI,2))/pow(Eeff,3) + (3*sqrt(3)*sqrt(27*pow(A,8)*pow(B,8)*pow(Eeff,2)*pow(gamma,2) - @@ -785,19 +785,19 @@ double GranSubModNormalMDR::calculate_forces() if ( (deltae1D + lmax - g_aAdh) >= 0.0) { // case 2: tensile springs, but not exceeding critical length --> deltae + lmax - g(aAdhes) >= 0 //if (contactSide == 0) { - //std::cout << "Case 2 tensile springs not exceeding critical length, R " << R << "deltae1D " << deltae1D << " , lmax " << lmax << " , g_adh" << g_aAdh << " sum " << (deltae1D + lmax - g_aAdh) << std::endl; + //std::cout << "Case 2 tensile springs not exceeding critical length, R " << R << "deltae1D " << deltae1D << " , lmax " << lmax << " , g_adh" << g_aAdh << " sum " << (deltae1D + lmax - g_aAdh) << std::endl; //} - const double deltaeAdh = g_aAdh; + const double deltaeAdh = g_aAdh; const double F_na = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltaeAdh/A) - (1.0 - 2.0*deltaeAdh/A)*sqrt(4.0*deltaeAdh/A - 4.0*pow(deltaeAdh,2.0)/pow(A,2.0))); const double F_Adhes = 2.0*Eeff*(deltae1D - deltaeAdh)*aAdh; - F_MDR = F_na + F_Adhes; + F_MDR = F_na + F_Adhes; if ( std::isnan(F_MDR) ) std::cout << "F_MDR is NaN, case 2: tensile springs, but not exceeding critical length" << std::endl; } else { // case 3: tensile springs exceed critical length --> deltae + lmax - g(aAdhes) = 0 //if (contactSide == 0) { - //std::cout << "Case 3 tensile springs exceed critical length, R " << R << " deltae1D " << deltae1D << " , lmax " << lmax << " , g_adh " << g_aAdh << " sum " << (deltae1D + lmax - g_aAdh) << std::endl; + //std::cout << "Case 3 tensile springs exceed critical length, R " << R << " deltae1D " << deltae1D << " , lmax " << lmax << " , g_adh " << g_aAdh << " sum " << (deltae1D + lmax - g_aAdh) << std::endl; //} - + if ( aAdh < acrit ) { aAdh = 0.0; F_MDR = 0.0; @@ -807,31 +807,31 @@ double GranSubModNormalMDR::calculate_forces() const double error = 1e-10; const double error2 = 1e-16; double aAdh_tmp = aAdh; - double fa; + double fa; double fa2; double dfda; for (int lv1 = 0; lv1 < maxIterations; ++lv1) { fa = deltae1D + sqrt(2.0*M_PI*aAdh_tmp*gamma/Eeff) - ( A/2 - A/B*sqrt(pow(B,2.0)/4 - pow(aAdh_tmp,2.0)) ); if (abs(fa) < error) { break; - } + } dfda = -((aAdh_tmp*A)/(B*sqrt(-pow(aAdh_tmp,2.0) + pow(B,2.0)/4.0))) + (gamma*sqrt(M_PI/2.0))/(Eeff*sqrt((aAdh_tmp*gamma)/Eeff)); aAdh_tmp = aAdh_tmp - fa/dfda; fa2 = deltae1D + sqrt(2.0*M_PI*aAdh_tmp*gamma/Eeff) - ( A/2 - A/B*sqrt(pow(B,2.0)/4 - pow(aAdh_tmp,2.0)) ); if (abs(fa-fa2) < error2) { break; - } + } if (lv1 == maxIterations-1){ aAdh_tmp = 0.0; } } aAdh = aAdh_tmp; - - g_aAdh = A/2.0 - A/B*sqrt(pow(B,2.0)/4.0 - pow(aAdh,2.0)); - const double deltaeAdh = g_aAdh; + + g_aAdh = A/2.0 - A/B*sqrt(pow(B,2.0)/4.0 - pow(aAdh,2.0)); + const double deltaeAdh = g_aAdh; const double F_na = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltaeAdh/A) - (1.0 - 2.0*deltaeAdh/A)*sqrt(4.0*deltaeAdh/A - 4.0*pow(deltaeAdh,2.0)/pow(A,2.0))); const double F_Adhes = 2.0*Eeff*(deltae1D - deltaeAdh)*aAdh; - F_MDR = F_na + F_Adhes; + F_MDR = F_na + F_Adhes; if ( std::isnan(F_MDR) ) std::cout << "F_MDR is NaN, case 3: tensile springs exceed critical length" << std::endl; } *aAdh_offset = aAdh; @@ -839,13 +839,13 @@ double GranSubModNormalMDR::calculate_forces() } } else { // non-adhesive contact *aAdh_offset = a_na; - (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltae1D/A) - (1.0 - 2.0*deltae1D/A)*sqrt(4.0*deltae1D/A - 4.0*pow(deltae1D,2.0)/pow(A,2.0))); + (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltae1D/A) - (1.0 - 2.0*deltae1D/A)*sqrt(4.0*deltae1D/A - 4.0*pow(deltae1D,2.0)/pow(A,2.0))); if ( std::isnan(F_MDR) ) { std::cout << "F_MDR is NaN, non-adhesive case" << std::endl; //std::cout << "Normal model: " << gm->delta << ", " << ddelta << ", " << gm->radi << ", " << gm->radj << " | delta: " << delta0 << ", " << delta1 << " | delta2_offset: " << *delta2_offset0 << ", " << *delta2_offset1 << "| dde: " << dde0 << ", " << dde1 << "| Fold: " << F0old << ", " << F1old << " | a: " << a0 << ", " << a1 << " | k_BULK: " << k_BULK0 << ", " << k_BULK1 << " | h_BULK: " << h_BULK0 << ", " << h_BULK1 << std::endl; std::cout << "i_true: " << i_true << ", j_true: " << j_true << ", i_tag: " << atom->tag[i_true] << ", j_tag: " << atom->tag[j_true] << ", deltae1D: " << deltae1D << ", A: " << A << ", B: " << B << ", amax: " << amax << ", deltamax_MDR: " << deltamax_MDR << ", R: " << R << std::endl; std::exit(1); - } + } } //std::cout << gm->i << ", " << gm->j << ", aAdh_offset: " << *aAdh_offset << ", aAdh: " << aAdh << ", a_na: " << a_na << std::endl; @@ -860,8 +860,8 @@ double GranSubModNormalMDR::calculate_forces() //std::cout << gm->i << ", " << gm->j << ", " << gm->contact_type << ", " << *gm->xi[1] << ", " << *gm->xj[1] << std::endl; - // area related calculations - double Ac; + // area related calculations + double Ac; (*Yflag_offset == 0.0) ? Ac = M_PI*delta*R : Ac = M_PI*((2.0*delta*R - pow(delta,2.0)) + cA/M_PI); if (Ac < 0.0 ) Ac = 0.0; Atot_sum[i] += wij*(Ac - 2.0*M_PI*R*(deltamax_MDR + delta_BULK)); @@ -932,7 +932,7 @@ double GranSubModNormalMDR::calculate_forces() //int rank = 0; //MPI_Comm_rank(MPI_COMM_WORLD, &rank); - //std::cout << "Step: " << lmp->update->ntimestep << ", CS: " << contactSide << ", itag: " << atom->tag[i] << ", jtag: " << atom->tag[j] << ", rank: " << rank << ", gm->delta: " << gm->delta << ", delta: " << delta << ", ddelta: " << ddelta << ", delta_bar: " << ddelta_bar[i] << ", R: " << R << ", F_MDR: " << F_MDR << ", F_BULK: " << F_BULK << std::endl; + //std::cout << "Step: " << lmp->update->ntimestep << ", CS: " << contactSide << ", itag: " << atom->tag[i] << ", jtag: " << atom->tag[j] << ", rank: " << rank << ", gm->delta: " << gm->delta << ", delta: " << delta << ", ddelta: " << ddelta << ", delta_bar: " << ddelta_bar[i] << ", R: " << R << ", F_MDR: " << F_MDR << ", F_BULK: " << F_BULK << std::endl; //std::cout << gm->i << ", " << gm->j << ", " << Vgeo[i] << ", " << Acon0[i] << ", " << Acon1[i] << ", " << Ac << ", " << kappa << " || " << psi[i] << ", " << ddelta_bar[i] << ", " << ddelta << ", " << ddelta_MDR << ", " << ddelta_BULK << ", " << delta << ", " << delta_MDR << ", " << delta_BULK << ", " << F_MDR << ", " << F_BULK << ", " << R << " || " << deltae1D << ", " << A << ", " << B << std::endl; @@ -950,7 +950,7 @@ double GranSubModNormalMDR::calculate_forces() // radius update scheme quantity calculation Vcaps[i] += (M_PI/3.0)*pow(delta,2.0)*(3.0*R - delta); - + const double Fntmp = wij*(F_MDR + F_BULK); const double fx = Fntmp*gm->nx[0]; const double fy = Fntmp*gm->nx[1]; @@ -960,7 +960,7 @@ double GranSubModNormalMDR::calculate_forces() const double bz = -(Ro - deltao)*gm->nx[2]; const double eps_bar_contact = (1.0/(3*kappa*Velas[i]))*(fx*bx + fy*by + fz*bz); eps_bar[i] += eps_bar_contact; - + //double **x = atom->x; //const double xi = x[i_true][0]; //const double xj = x[j_true][0]; @@ -977,7 +977,7 @@ double GranSubModNormalMDR::calculate_forces() //std::cout << i << ", " << j << ", " << gm->contact_type << " || " << eps_bar_contact << ", " << *eps_bar_offset << ", " << (uintptr_t)(eps_bar_offset) << " || " << wij << ", " << ddeltao << ", " << deltao << " || " << Ro << ", " << R << std::endl; //} - + double desp_bar_contact = eps_bar_contact - *eps_bar_offset; // && desp_bar_contact < 0.0 if(delta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0){ const double Vo = (4.0/3.0)*M_PI*pow(Ro,3.0); @@ -1020,7 +1020,7 @@ double GranSubModNormalMDR::calculate_forces() //} } - + gm->i = i_true; gm->j = j_true; gm->radi = radi_true; @@ -1044,7 +1044,7 @@ double GranSubModNormalMDR::calculate_forces() if (gm->contact_type != PAIR) { F = wij*F0*wallForceMagnifer; } else { - F = wij*(F0 + F1)/2.0; + F = wij*(F0 + F1)/2.0; } //std::cout << F << ", " << F0 << ", " << F1 << " | " << R0 << ", " << R1 << std::endl; @@ -1073,7 +1073,7 @@ double GranSubModNormalMDR::calculate_forces() //const double xi = x[gm->i][0]; //const double xj = x[gm->j][0]; //const double del = 20.0 - abs(xi-xj); - + //if (i_true == 146 && j_true == 152) { // CSVWriter csvWriter("/Users/willzunker/lammps_mdr_develop/sims/avicelTableting/rigid_flat_output.csv"); // std::stringstream rowDataStream; @@ -1133,21 +1133,21 @@ void GranSubModNormalMDR::set_fncrit() //std::cout << "F_MDR should be > 0: " << F_MDR << ", " << gm->i << ", " << gm->j << std::endl; //std::cout << gm->i << ", " << gm->j << " || " << delta << ", " << delta_MDR << ", " << deltamax_MDR << ", " << deltae1D << " || " << A << ", " << B << std::endl; -//std::cout << i_true << ", " << j_true << std::endl; +//std::cout << i_true << ", " << j_true << std::endl; //std::cout << history_index << ", " << history[0] << ", " << history[1] << ", " << history[2] << std::endl; // initialize all history variables - //double delta_offset; + //double delta_offset; //double deltao_offset; - //double delta_MDR_offset; - //double delta_BULK_offset; - //double deltamax_MDR_offset; - //double Yflag; - //double deltaY_offset; - //double Ac_offset; - //double aAdh_offset; - //double deltap_offset; - //double cA_offset; + //double delta_MDR_offset; + //double delta_BULK_offset; + //double deltamax_MDR_offset; + //double Yflag; + //double deltaY_offset; + //double Ac_offset; + //double aAdh_offset; + //double deltap_offset; + //double cA_offset; //double eps_bar_offset; - //double wall_contact_flag_offset; \ No newline at end of file + //double wall_contact_flag_offset; diff --git a/src/GRANULAR/pair_granular.cpp b/src/GRANULAR/pair_granular.cpp index 04d06c296f..230cba446b 100644 --- a/src/GRANULAR/pair_granular.cpp +++ b/src/GRANULAR/pair_granular.cpp @@ -504,7 +504,7 @@ void PairGranular::init_style() index_vq = atom->find_custom("viscous_heat",tmp1,tmp2); index_vt = atom->find_custom("viscous_temp",tmp1,tmp2); fix_flag = 1; - } + } */ if (model->normal_model->name == "mdr") { @@ -521,22 +521,22 @@ void PairGranular::init_style() index_Ro = atom->find_custom("Ro",tmp1,tmp2); // initial radius index_Vcaps = atom->find_custom("Vcaps",tmp1,tmp2); // spherical cap volume from intersection of apparent radius particle and contact planes index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); // geometric particle volume of apparent particle after removing spherical cap volume - index_Velas = atom->find_custom("Velas",tmp1,tmp2); // particle volume from linear elasticity + index_Velas = atom->find_custom("Velas",tmp1,tmp2); // particle volume from linear elasticity index_eps_bar = atom->find_custom("eps_bar",tmp1,tmp2); // volume-averaged infinitesimal strain tensor index_dRnumerator = atom->find_custom("dRnumerator",tmp1,tmp2); // summation of numerator terms in calculation of dR index_dRdenominator = atom->find_custom("dRdenominator",tmp1,tmp2); // summation of denominator terms in calculation of dR - index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); // total area involved in contacts: Acon^{n} + index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); // total area involved in contacts: Acon^{n} index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); // total area involved in contacts: Acon^{n+1} - index_Atot = atom->find_custom("Atot",tmp1,tmp2); // total particle area + index_Atot = atom->find_custom("Atot",tmp1,tmp2); // total particle area index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); // running sum of contact area minus cap area index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); // change in mean surface displacement index_psi = atom->find_custom("psi",tmp1,tmp2); // ratio of free surface area to total surface area index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); // TEMPORARY, SINCE PSI_B IS ALREADY DEFINED IN THE INPUT SCRIPT - index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); // flag to check if history variables have been initialized + index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); // flag to check if history variables have been initialized index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); // xx-component of the stress tensor, not necessary for force calculation - index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); // yy-component of the stress tensor, not necessary for force calculation - index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); // zz-component of the stress tensor, not necessary for force calculation - index_contacts = atom->find_custom("contacts",tmp1,tmp2); // total contacts on particle + index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); // yy-component of the stress tensor, not necessary for force calculation + index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); // zz-component of the stress tensor, not necessary for force calculation + index_contacts = atom->find_custom("contacts",tmp1,tmp2); // total contacts on particle index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); // total contacts on particle std::cout << "MDR history variables have been initialized 2" << ", " << index_Ro << std::endl; @@ -548,7 +548,7 @@ void PairGranular::init_style() modify->add_fix("fix_mdr_mean_surf_disp all mdr/mean/surf/disp"); fix_flag = 1; - } + } } // check for FixFreeze and set freeze_group_bit diff --git a/src/GRANULAR/pair_granular.h b/src/GRANULAR/pair_granular.h index 16a97250b8..10b581968a 100644 --- a/src/GRANULAR/pair_granular.h +++ b/src/GRANULAR/pair_granular.h @@ -74,7 +74,7 @@ class PairGranular : public Pair { int index_Ro; int index_Vcaps; int index_Vgeo; - int index_Velas; + int index_Velas; int index_eps_bar; int index_dRnumerator; int index_dRdenominator; diff --git a/src/csv_writer.h b/src/csv_writer.h index 0a01604393..29bb44e419 100644 --- a/src/csv_writer.h +++ b/src/csv_writer.h @@ -22,4 +22,4 @@ public: private: std::string filename_; -}; \ No newline at end of file +}; diff --git a/src/fix_mdr_mean_surf_disp.cpp b/src/fix_mdr_mean_surf_disp.cpp index 4165299b05..cdc170f968 100644 --- a/src/fix_mdr_mean_surf_disp.cpp +++ b/src/fix_mdr_mean_surf_disp.cpp @@ -63,9 +63,9 @@ int FixMDRmeanSurfDisp::setmask() void FixMDRmeanSurfDisp::setup_pre_force(int /*vflag*/) { int tmp1, tmp2; - int index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); - int index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); - Acon0 = atom->dvector[index_Acon0]; + int index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); + int index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); + Acon0 = atom->dvector[index_Acon0]; ddelta_bar = atom->dvector[index_ddelta_bar]; pre_force(0); @@ -97,9 +97,9 @@ void FixMDRmeanSurfDisp::pre_force(int) FixNeighHistory * fix_history = dynamic_cast(modify->get_fix_by_id("NEIGH_HISTORY_GRANULAR")); PairGranular * pair = dynamic_cast(force->pair_match("granular",1)); NeighList * list = pair->list; - + const int size_history = pair->get_size_history(); - + //std::cout << " " << std::endl; //std::cout << "New Step" << std::endl; @@ -135,14 +135,14 @@ void FixMDRmeanSurfDisp::pre_force(int) const double ytmp = x[i][1]; const double ztmp = x[i][2]; allhistory = firsthistory[i]; - double radi = radius[i]; + double radi = radius[i]; jlist = firstneigh[i]; jnum = numneigh[i]; for (int jj = 0; jj < jnum; jj++) { j = jlist[jj]; j &= NEIGHMASK; jtype = type[j]; - double radj = radius[j]; + double radj = radius[j]; const double delx_ij = x[j][0] - xtmp; const double dely_ij = x[j][1] - ytmp; const double delz_ij = x[j][2] - ztmp; @@ -153,7 +153,7 @@ void FixMDRmeanSurfDisp::pre_force(int) const double deltan_ij = radsum_ij - r_ij; if (deltan_ij >= 0.0) { for (int kk = jj; kk < jnum; kk++) { - k = jlist[kk]; + k = jlist[kk]; k &= NEIGHMASK; ktype = type[k]; if (kk != jj) { @@ -175,7 +175,7 @@ void FixMDRmeanSurfDisp::pre_force(int) const double radsum_jk = radj + radk; const double deltan_jk = radsum_jk - r_jk; if (deltan_ik >= 0.0 && deltan_jk >= 0.0) { - + // pull ij history history_ij = &allhistory[size_history * jj]; double * pij = &history_ij[22]; // penalty for contact i and j @@ -186,7 +186,7 @@ void FixMDRmeanSurfDisp::pre_force(int) // we don't know if who owns the contact ahead of time, k might be in j's neigbor list or vice versa, so we need to manually search to figure out the owner // check if k is in the neighbor list of j - double * pjk = NULL; + double * pjk = NULL; int * const jklist = firstneigh[j]; const int jknum = numneigh[j]; for (int jk = 0; jk < jknum; jk++) { @@ -219,7 +219,7 @@ void FixMDRmeanSurfDisp::pre_force(int) //std::cout << "Print 198 pjk[0]: " << rank << ", " << pjk[0] << std::endl; break; } - } + } } //std::cout << "Print: " << __LINE__ << std::endl; @@ -234,8 +234,8 @@ void FixMDRmeanSurfDisp::pre_force(int) const double enx_kj = -delx_jk * rinv_jk; const double eny_kj = -dely_jk * rinv_jk; const double enz_kj = -delz_jk * rinv_jk; - const double alpha = std::acos(enx_ki*enx_kj + eny_ki*eny_kj + enz_ki*enz_kj); - pij[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/M_PI - 1.0/2.0)) ); + const double alpha = std::acos(enx_ki*enx_kj + eny_ki*eny_kj + enz_ki*enz_kj); + pij[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/M_PI - 1.0/2.0)) ); } else if (maxIndex == 1) { // the central particle is j const double enx_ji = -delx_ij * rinv_ij; const double eny_ji = -dely_ij * rinv_ij; @@ -243,7 +243,7 @@ void FixMDRmeanSurfDisp::pre_force(int) const double enx_jk = delx_jk * rinv_jk; const double eny_jk = dely_jk * rinv_jk; const double enz_jk = delz_jk * rinv_jk; - const double alpha = std::acos(enx_ji*enx_jk + eny_ji*eny_jk + enz_ji*enz_jk); + const double alpha = std::acos(enx_ji*enx_jk + eny_ji*eny_jk + enz_ji*enz_jk); pik[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/M_PI - 1.0/2.0)) ); } else { // the central particle is i if (j < atom->nlocal || k < atom->nlocal) { @@ -253,7 +253,7 @@ void FixMDRmeanSurfDisp::pre_force(int) const double enx_ik = delx_ik * rinv_ik; const double eny_ik = dely_ik * rinv_ik; const double enz_ik = delz_ik * rinv_ik; - const double alpha = std::acos(enx_ij*enx_ik + eny_ij*eny_ik + enz_ij*enz_ik); + const double alpha = std::acos(enx_ij*enx_ik + eny_ij*eny_ik + enz_ij*enz_ik); //std::cout << "Print: " << __LINE__ << std::endl; pjk[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/M_PI - 1.0/2.0)) ); //std::cout << "Print: " << __LINE__ << std::endl; @@ -264,7 +264,7 @@ void FixMDRmeanSurfDisp::pre_force(int) } } } - } + } } @@ -286,7 +286,7 @@ void FixMDRmeanSurfDisp::pre_force(int) double *radius = atom->radius; int nlocal = atom->nlocal; - + inum = list->inum; ilist = list->ilist; numneigh = list->numneigh; @@ -336,8 +336,8 @@ void FixMDRmeanSurfDisp::pre_force(int) //const double wij = std::max(1.0-pij,0.0); const double delta = model->radsum - sqrt(model->rsq); - const int delta_offset_0 = 0; // apparent overlap - const int delta_offset_1 = 1; + const int delta_offset_0 = 0; // apparent overlap + const int delta_offset_1 = 1; const int Ac_offset_0 = 18; // contact area const int Ac_offset_1 = 19; const int deltamax_offset_ = 23; @@ -347,7 +347,7 @@ void FixMDRmeanSurfDisp::pre_force(int) double deltamax = history[deltamax_offset_]; double deltap0 = history[deltap_offset_0]; double deltap1 = history[deltap_offset_1]; - + if (delta > deltamax) deltamax = delta; double delta0old = history[delta_offset_0]; @@ -511,13 +511,13 @@ void FixMDRmeanSurfDisp::pre_force(int) if (Acon0[i] != 0.0) { const double delta = model->radsum - model->r; const double delta_offset0 = fix->history_many[i][fix->c2r[ic]][0]; - const double ddelta = delta - delta_offset0; + const double ddelta = delta - delta_offset0; const double Ac_offset0 = fix->history_many[i][fix->c2r[ic]][18]; ddelta_bar[i] += wij*Ac_offset0/Acon0[i]*ddelta; // Multiply by 0.5 since displacement is shared equally between deformable particles. //std::cout << delta << ", " << delta_offset0 << " || " << Ac_offset0 << ", " << Acon0[i] << ", " << ddelta << ", " << ddelta_bar[i] << std::endl; } } - } + } } } @@ -536,4 +536,4 @@ void FixMDRmeanSurfDisp::pre_force(int) //std::cout << radius[i] << ", " << dR << ", " << dRnumerator[i] << ", " << dRdenominator[i] << ", " << dRdenominator[i] - 4.0*M_PI*pow(R,2.0) << std::endl; //std::cout << "Fix radius update setup has been entered !!!" << std::endl; -//std::cout << Ro[0] << ", " << Vgeo[0] << ", " << Velas[0] << std::endl; \ No newline at end of file +//std::cout << Ro[0] << ", " << Vgeo[0] << ", " << Velas[0] << std::endl; diff --git a/src/fix_mdr_mean_surf_disp.h b/src/fix_mdr_mean_surf_disp.h index be5be15907..daacb660e0 100644 --- a/src/fix_mdr_mean_surf_disp.h +++ b/src/fix_mdr_mean_surf_disp.h @@ -25,10 +25,10 @@ FixStyle(mdr/mean/surf/disp,FixMDRmeanSurfDisp); namespace LAMMPS_NS { class FixMDRmeanSurfDisp : public Fix { - public: - double * Acon0; + public: + double * Acon0; double * ddelta_bar; - + FixMDRmeanSurfDisp(class LAMMPS *, int, char **); int setmask() override; void setup_pre_force(int) override; diff --git a/src/fix_mdr_radius_update.cpp b/src/fix_mdr_radius_update.cpp index 010fad64d5..3f226fb87a 100644 --- a/src/fix_mdr_radius_update.cpp +++ b/src/fix_mdr_radius_update.cpp @@ -35,7 +35,7 @@ #include "gran_sub_mod_normal.h" #include "update.h" #include "comm.h" -#include +#include #include using namespace LAMMPS_NS; @@ -69,19 +69,19 @@ void FixMDRradiusUpdate::setup_pre_force(int /*vflag*/) int index_eps_bar = atom->find_custom("eps_bar",tmp1,tmp2); int index_dRnumerator = atom->find_custom("dRnumerator",tmp1,tmp2); int index_dRdenominator = atom->find_custom("dRdenominator",tmp1,tmp2); - int index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); - int index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); - int index_Atot = atom->find_custom("Atot",tmp1,tmp2); - int index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); - int index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); + int index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); + int index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); + int index_Atot = atom->find_custom("Atot",tmp1,tmp2); + int index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); + int index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); int index_psi = atom->find_custom("psi",tmp1,tmp2); - int index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); - int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); - int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); + int index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); + int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); + int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); int index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); - int index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); - int index_contacts = atom->find_custom("contacts",tmp1,tmp2); - int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); + int index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); + int index_contacts = atom->find_custom("contacts",tmp1,tmp2); + int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); Ro = atom->dvector[index_Ro]; Vgeo = atom->dvector[index_Vgeo]; Velas = atom->dvector[index_Velas]; @@ -89,9 +89,9 @@ void FixMDRradiusUpdate::setup_pre_force(int /*vflag*/) eps_bar = atom->dvector[index_eps_bar]; dRnumerator = atom->dvector[index_dRnumerator]; dRdenominator = atom->dvector[index_dRdenominator]; - Acon0 = atom->dvector[index_Acon0]; + Acon0 = atom->dvector[index_Acon0]; Acon1 = atom->dvector[index_Acon1]; - Atot = atom->dvector[index_Atot]; + Atot = atom->dvector[index_Atot]; Atot_sum = atom->dvector[index_Atot_sum]; ddelta_bar = atom->dvector[index_ddelta_bar]; psi = atom->dvector[index_psi]; @@ -116,19 +116,19 @@ void FixMDRradiusUpdate::setup(int /*vflag*/) int index_eps_bar = atom->find_custom("eps_bar",tmp1,tmp2); int index_dRnumerator = atom->find_custom("dRnumerator",tmp1,tmp2); int index_dRdenominator = atom->find_custom("dRdenominator",tmp1,tmp2); - int index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); - int index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); - int index_Atot = atom->find_custom("Atot",tmp1,tmp2); - int index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); - int index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); + int index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); + int index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); + int index_Atot = atom->find_custom("Atot",tmp1,tmp2); + int index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); + int index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); int index_psi = atom->find_custom("psi",tmp1,tmp2); - int index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); - int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); - int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); + int index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); + int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); + int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); int index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); - int index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); - int index_contacts = atom->find_custom("contacts",tmp1,tmp2); - int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); + int index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); + int index_contacts = atom->find_custom("contacts",tmp1,tmp2); + int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); Ro = atom->dvector[index_Ro]; Vgeo = atom->dvector[index_Vgeo]; Velas = atom->dvector[index_Velas]; @@ -136,9 +136,9 @@ void FixMDRradiusUpdate::setup(int /*vflag*/) eps_bar = atom->dvector[index_eps_bar]; dRnumerator = atom->dvector[index_dRnumerator]; dRdenominator = atom->dvector[index_dRdenominator]; - Acon0 = atom->dvector[index_Acon0]; + Acon0 = atom->dvector[index_Acon0]; Acon1 = atom->dvector[index_Acon1]; - Atot = atom->dvector[index_Atot]; + Atot = atom->dvector[index_Atot]; Atot_sum = atom->dvector[index_Atot_sum]; ddelta_bar = atom->dvector[index_ddelta_bar]; psi = atom->dvector[index_psi]; @@ -170,20 +170,20 @@ void FixMDRradiusUpdate::pre_force(int) //std::cout << "Preforce was called radius update" << std::endl; - // assign correct value to initially non-zero MDR particle history variables + // assign correct value to initially non-zero MDR particle history variables //int tmp1, tmp2; //int index_Ro = atom->find_custom("Ro",tmp1,tmp2); //int index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); //int index_Velas = atom->find_custom("Velas",tmp1,tmp2); - //int index_Atot = atom->find_custom("Atot",tmp1,tmp2); + //int index_Atot = atom->find_custom("Atot",tmp1,tmp2); //int index_psi = atom->find_custom("psi",tmp1,tmp2); //int index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); - //int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); - //int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); - //int index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); - //int index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); - //int index_contacts = atom->find_custom("contacts",tmp1,tmp2); - //int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); + //int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); + //int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); + //int index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); + //int index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); + //int index_contacts = atom->find_custom("contacts",tmp1,tmp2); + //int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); //double * Ro = atom->dvector[index_Ro]; //double * Vgeo = atom->dvector[index_Vgeo]; //double * Velas = atom->dvector[index_Velas]; @@ -196,13 +196,13 @@ void FixMDRradiusUpdate::pre_force(int) //double * history_setup_flag = atom->dvector[index_history_setup_flag]; //double * contacts = atom->dvector[index_contacts]; //double * adhesive_length = atom->dvector[index_adhesive_length]; - + double *radius = atom->radius; int nlocal = atom->nlocal; //std::cout << "ntotal " << ntotal << ", nlocal " << atom->nlocal << ", nghost " << atom->nghost << std::endl; - for (int i = 0; i < nlocal; i++) { + for (int i = 0; i < nlocal; i++) { if (history_setup_flag[i] < 1e-16) { Ro[i] = radius[i]; Vgeo[i] = 4.0/3.0*M_PI*pow(Ro[i],3.0); @@ -232,7 +232,7 @@ int FixMDRradiusUpdate::pack_forward_comm(int n, int *list, double *buf, int /*p buf[m++] = Vgeo[j]; // 2 buf[m++] = Velas[j]; // 3 buf[m++] = Vcaps[j]; // 4 - buf[m++] = eps_bar[j]; // 5 + buf[m++] = eps_bar[j]; // 5 buf[m++] = dRnumerator[j]; // 6 buf[m++] = dRdenominator[j]; // 7 buf[m++] = Acon0[j]; // 8 @@ -261,7 +261,7 @@ void FixMDRradiusUpdate::unpack_forward_comm(int n, int first, double *buf) Vgeo[i] = buf[m++]; // 2 Velas[i] = buf[m++]; // 3 Vcaps[i] = buf[m++]; // 4 - eps_bar[i] = buf[m++]; // 5 + eps_bar[i] = buf[m++]; // 5 dRnumerator[i] = buf[m++]; // 6 dRdenominator[i] = buf[m++]; // 7 Acon0[i] = buf[m++]; // 8 @@ -282,7 +282,7 @@ void FixMDRradiusUpdate::unpack_forward_comm(int n, int first, double *buf) void FixMDRradiusUpdate::end_of_step() { - + //comm->forward_comm(this); //std::cout << "end_of_step() was called radius update" << std::endl; @@ -293,13 +293,13 @@ void FixMDRradiusUpdate::end_of_step() int nlocal = atom->nlocal; double sigmaxx_sum = 0.0; double sigmayy_sum = 0.0; - double sigmazz_sum = 0.0; + double sigmazz_sum = 0.0; double Vparticles = 0.0; //std::cout << "New step" << std::endl; for (int i = 0; i < nlocal; i++) { - + const double R = radius[i]; Atot[i] = 4.0*M_PI*pow(R,2.0) + Atot_sum[i]; @@ -316,7 +316,7 @@ void FixMDRradiusUpdate::end_of_step() //} const double dR = std::max(dRnumerator[i]/(dRdenominator[i] - 4.0*M_PI*pow(R,2.0)),0.0); - if (psi_b[i] < psi[i]) { + if (psi_b[i] < psi[i]) { if ((radius[i] + dR) < (1.5*Ro[i])) radius[i] += dR; //radius[i] += dR; } @@ -327,10 +327,10 @@ void FixMDRradiusUpdate::end_of_step() //if (atom->tag[i] == 9){ // std::cout << i << ", radius: " << radius[i] << ", dR: " << dR << ", dRnum: " << dRnumerator[i] << ", dRdenom " << dRdenominator[i] << ", dRdem_full " << dRdenominator[i] - 4.0*M_PI*pow(R,2.0) << std::endl; //} - - + + //std::cout << i << ", " << radius[i] << " | " << psi_b[i] << ", " << psi[i] << " | " << Acon1[i] << ", " << Atot[i] << std::endl; - + Velas[i] = Vo*(1.0 + eps_bar[i]); Vcaps[i] = 0.0; @@ -339,7 +339,7 @@ void FixMDRradiusUpdate::end_of_step() dRdenominator[i] = 0.0; Acon0[i] = Acon1[i]; Acon1[i] = 0.0; - //std::cout << "Acon reset: " << Acon0[i] << ", " << Acon1[i] << std::endl; + //std::cout << "Acon reset: " << Acon0[i] << ", " << Acon1[i] << std::endl; Atot_sum[i] = 0.0; ddelta_bar[i] = 0.0; //adhesive_length[i] = adhesive_length[i]/contacts[i]; // convert adhesive length to average aAdh for each particle @@ -381,4 +381,4 @@ void FixMDRradiusUpdate::end_of_step() //std::cout << radius[i] << ", " << dR << ", " << dRnumerator[i] << ", " << dRdenominator[i] << ", " << dRdenominator[i] - 4.0*M_PI*pow(R,2.0) << std::endl; //std::cout << "Fix radius update setup has been entered !!!" << std::endl; -//std::cout << Ro[0] << ", " << Vgeo[0] << ", " << Velas[0] << std::endl; \ No newline at end of file +//std::cout << Ro[0] << ", " << Vgeo[0] << ", " << Velas[0] << std::endl; diff --git a/src/fix_mdr_radius_update.h b/src/fix_mdr_radius_update.h index e53366c25e..f431c0d13d 100644 --- a/src/fix_mdr_radius_update.h +++ b/src/fix_mdr_radius_update.h @@ -31,7 +31,7 @@ class FixMDRradiusUpdate : public Fix { double * Velas; double * Vcaps; double * eps_bar; - double * dRnumerator; + double * dRnumerator; double * dRdenominator; double * Acon0; double * Acon1; @@ -43,10 +43,10 @@ class FixMDRradiusUpdate : public Fix { double * sigmaxx; double * sigmayy; double * sigmazz; - double * history_setup_flag; + double * history_setup_flag; double * contacts; double * adhesive_length; - + FixMDRradiusUpdate(class LAMMPS *, int, char **); int setmask() override; void setup(int) override; diff --git a/src/variable.cpp b/src/variable.cpp index 350d6a7141..b581e4ce0d 100644 --- a/src/variable.cpp +++ b/src/variable.cpp @@ -3661,7 +3661,7 @@ int Variable::math_function(char *word, char *contents, Tree **tree, Tree **tree strcmp(word,"logfreq") != 0 && strcmp(word,"logfreq2") != 0 && strcmp(word,"logfreq3") != 0 && strcmp(word,"stride") != 0 && strcmp(word,"stride2") != 0 && strcmp(word,"vdisplace") != 0 && - strcmp(word,"swiggle") != 0 && strcmp(word,"cwiggle") != 0 && strcmp(word,"sign") != 0) + strcmp(word,"swiggle") != 0 && strcmp(word,"cwiggle") != 0 && strcmp(word,"sign") != 0) return 0; // parse contents for comma-separated args From 64c06e9673b60a349aa0e146dd31e081089b698a Mon Sep 17 00:00:00 2001 From: Sachith Dunatunga Date: Sun, 15 Dec 2024 11:53:48 -0800 Subject: [PATCH 03/74] revert verlet.cpp change --- src/variable.cpp | 2 +- src/verlet.cpp | 2 +- 2 files changed, 2 insertions(+), 2 deletions(-) diff --git a/src/variable.cpp b/src/variable.cpp index b581e4ce0d..f20c78adc2 100644 --- a/src/variable.cpp +++ b/src/variable.cpp @@ -3643,7 +3643,7 @@ tagint Variable::int_between_brackets(char *&ptr, int varallow) atan2(y,x),random(x,y,z),normal(x,y,z),ceil(),floor(),round(),ternary(), ramp(x,y),stagger(x,y),logfreq(x,y,z),logfreq2(x,y,z), logfreq3(x,y,z),stride(x,y,z),stride2(x,y,z,a,b,c),vdisplace(x,y), - swiggle(x,y,z),cwiggle(x,y,z) + swiggle(x,y,z),cwiggle(x,y,z),sign(x) ------------------------------------------------------------------------- */ int Variable::math_function(char *word, char *contents, Tree **tree, Tree **treestack, diff --git a/src/verlet.cpp b/src/verlet.cpp index d72383bf4a..0222a0d2a0 100644 --- a/src/verlet.cpp +++ b/src/verlet.cpp @@ -282,7 +282,7 @@ void Verlet::run(int n) } timer->stamp(); comm->exchange(); - //if (sortflag && ntimestep >= atom->nextsort) atom->sort(); + if (sortflag && ntimestep >= atom->nextsort) atom->sort(); comm->borders(); if (triclinic) domain->lamda2x(atom->nlocal+atom->nghost); timer->stamp(Timer::COMM); From 5d865598ede9d648db9646315bd927e438110992 Mon Sep 17 00:00:00 2001 From: Sachith Dunatunga Date: Sun, 15 Dec 2024 11:56:58 -0800 Subject: [PATCH 04/74] Fix data file path for large avicel sim --- examples/granular/in.avicelTableting20000 | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/examples/granular/in.avicelTableting20000 b/examples/granular/in.avicelTableting20000 index 51e6dd5699..68b58024a0 100644 --- a/examples/granular/in.avicelTableting20000 +++ b/examples/granular/in.avicelTableting20000 @@ -13,7 +13,7 @@ processors 2 2 1 ######################### SIMULATION BOUNDING BOX, INTEGRATION, AND, GRAVITY ########################### boundary f f f -read_data spheres.data +read_data spheres20000.data ######################################### ADD DIE AND ATOM PARAMETERIZATION ############################################## From 7922c923e285928273c54c4469fa7377253baf96 Mon Sep 17 00:00:00 2001 From: Sachith Dunatunga Date: Sun, 15 Dec 2024 12:25:53 -0800 Subject: [PATCH 05/74] Use MY_PI from math_const.h (for Windows) --- src/GRANULAR/gran_sub_mod_normal.cpp | 42 ++++++++++++++-------------- src/fix_mdr_mean_surf_disp.cpp | 10 ++++--- src/fix_mdr_radius_update.cpp | 22 ++++++++------- 3 files changed, 39 insertions(+), 35 deletions(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 3521f0be72..169756b41f 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -706,11 +706,11 @@ double GranSubModNormalMDR::calculate_forces() const double pY = Y*(1.75*exp(-4.4*deltamax_MDR/R) + 1.0); // Set value of average pressure along yield surface if ( *Yflag_offset == 0.0 && delta_MDR >= deltamax_MDR ) { - const double phertz = 4*Eeff*sqrt(delta_MDR)/(3*M_PI*sqrt(R)); + const double phertz = 4*Eeff*sqrt(delta_MDR)/(3*MY_PI*sqrt(R)); if ( phertz > pY ) { *Yflag_offset = 1.0; *deltaY_offset = delta_MDR; - *cA_offset = M_PI*(pow(*deltaY_offset,2.0) - *deltaY_offset*R); + *cA_offset = MY_PI*(pow(*deltaY_offset,2.0) - *deltaY_offset*R); } } @@ -735,13 +735,13 @@ double GranSubModNormalMDR::calculate_forces() deltae1D = delta_MDR; (deltae1D > 0) ? amax = sqrt(deltae1D*R) : amax = 0.0; } else { // plastic contact - amax = sqrt((2.0*deltamax_MDR*R - pow(deltamax_MDR,2.0)) + cA/M_PI); + amax = sqrt((2.0*deltamax_MDR*R - pow(deltamax_MDR,2.0)) + cA/MY_PI); A = 4.0*pY/Eeff*amax; B = 2.0*amax; const double deltae1Dmax = A/2.0; // maximum transformed elastic displacement const double Fmax = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltae1Dmax/A) - (1.0 - 2.0*deltae1Dmax/A)*sqrt(4.0*deltae1Dmax/A - 4.0*pow(deltae1Dmax,2.0)/pow(A,2.0))); // force caused by full submersion of elliptical indenter to depth of A/2 const double zR = R - (deltamax_MDR - deltae1Dmax); // depth of particle center - deltaR = (Fmax*(2*pow(amax,2.0)*(-1 + nu) - (-1 + 2*nu)*zR*(-zR + sqrt(pow(amax,2.0) + pow(zR,2.0)))))/((M_PI*pow(amax,2.0))*2*G*sqrt(pow(amax,2.0) + pow(zR,2.0))); + deltaR = (Fmax*(2*pow(amax,2.0)*(-1 + nu) - (-1 + 2*nu)*zR*(-zR + sqrt(pow(amax,2.0) + pow(zR,2.0)))))/((MY_PI*pow(amax,2.0))*2*G*sqrt(pow(amax,2.0) + pow(zR,2.0))); deltae1D = (delta_MDR - deltamax_MDR + deltae1Dmax + deltaR)/(1 + deltaR/deltae1Dmax); // transformed elastic displacement // added for rigid flat placement @@ -750,7 +750,7 @@ double GranSubModNormalMDR::calculate_forces() } //std::cout << psi_b << ", " << psi[i] << ", " << A << ", " << B << ", " << pY << ", " << amax << " || " << deltao << ", " << delta << ", " << ddelta << ", " << *delta_offset << ", " << ddelta_bar[i] << " || " << delta_MDR << ", " << ddelta_MDR << ", " << *delta_MDR_offset << ", " << deltamax_MDR << " || " << delta_BULK << ", " << ddelta_BULK << ", " << *delta_BULK_offset << " || " << R << std::endl; - //std::cout << i << ", " << j << ", " << A << ", " << B << " || " << deltao << ", " << delta << ", " << ddelta << ", " << R << ", " << M_PI*pow(amax,2.0) << std::endl; + //std::cout << i << ", " << j << ", " << A << ", " << B << " || " << deltao << ", " << delta << ", " << ddelta << ", " << R << ", " << MY_PI*pow(amax,2.0) << std::endl; double a_na; double a_fac = 0.99; @@ -775,12 +775,12 @@ double GranSubModNormalMDR::calculate_forces() } *aAdh_offset = a_fac*a_na; } else { - const double lmax = sqrt(2.0*M_PI*aAdh*gamma/Eeff); + const double lmax = sqrt(2.0*MY_PI*aAdh*gamma/Eeff); g_aAdh = A/2 - A/B*sqrt(pow(B,2.0)/4 - pow(aAdh,2.0)); - const double acrit = (-((pow(B,2)*gamma*M_PI)/(pow(A,2)*Eeff)) + (pow(2,0.3333333333333333)*pow(B,4)*pow(gamma,2)*pow(M_PI,1.6666666666666667))/ - (pow(A,2)*pow(Eeff,2)*pow((27*pow(A,4)*pow(B,4)*gamma)/Eeff - (2*pow(B,6)*pow(gamma,3)*pow(M_PI,2))/pow(Eeff,3) + (3*sqrt(3)*sqrt(27*pow(A,8)*pow(B,8)*pow(Eeff,2)*pow(gamma,2) - - 4*pow(A,4)*pow(B,10)*pow(gamma,4)*pow(M_PI,2)))/pow(Eeff,2),0.3333333333333333)) + (pow(M_PI/2.,0.3333333333333333)*pow((27*pow(A,4)*pow(B,4)*gamma)/Eeff - - (2*pow(B,6)*pow(gamma,3)*pow(M_PI,2))/pow(Eeff,3) + (3*sqrt(3)*sqrt(27*pow(A,8)*pow(B,8)*pow(Eeff,2)*pow(gamma,2) - 4*pow(A,4)*pow(B,10)*pow(gamma,4)*pow(M_PI,2)))/ + const double acrit = (-((pow(B,2)*gamma*MY_PI)/(pow(A,2)*Eeff)) + (pow(2,0.3333333333333333)*pow(B,4)*pow(gamma,2)*pow(MY_PI,1.6666666666666667))/ + (pow(A,2)*pow(Eeff,2)*pow((27*pow(A,4)*pow(B,4)*gamma)/Eeff - (2*pow(B,6)*pow(gamma,3)*pow(MY_PI,2))/pow(Eeff,3) + (3*sqrt(3)*sqrt(27*pow(A,8)*pow(B,8)*pow(Eeff,2)*pow(gamma,2) - + 4*pow(A,4)*pow(B,10)*pow(gamma,4)*pow(MY_PI,2)))/pow(Eeff,2),0.3333333333333333)) + (pow(MY_PI/2.,0.3333333333333333)*pow((27*pow(A,4)*pow(B,4)*gamma)/Eeff - + (2*pow(B,6)*pow(gamma,3)*pow(MY_PI,2))/pow(Eeff,3) + (3*sqrt(3)*sqrt(27*pow(A,8)*pow(B,8)*pow(Eeff,2)*pow(gamma,2) - 4*pow(A,4)*pow(B,10)*pow(gamma,4)*pow(MY_PI,2)))/ pow(Eeff,2),0.3333333333333333))/pow(A,2))/6; if ( (deltae1D + lmax - g_aAdh) >= 0.0) { // case 2: tensile springs, but not exceeding critical length --> deltae + lmax - g(aAdhes) >= 0 @@ -811,13 +811,13 @@ double GranSubModNormalMDR::calculate_forces() double fa2; double dfda; for (int lv1 = 0; lv1 < maxIterations; ++lv1) { - fa = deltae1D + sqrt(2.0*M_PI*aAdh_tmp*gamma/Eeff) - ( A/2 - A/B*sqrt(pow(B,2.0)/4 - pow(aAdh_tmp,2.0)) ); + fa = deltae1D + sqrt(2.0*MY_PI*aAdh_tmp*gamma/Eeff) - ( A/2 - A/B*sqrt(pow(B,2.0)/4 - pow(aAdh_tmp,2.0)) ); if (abs(fa) < error) { break; } - dfda = -((aAdh_tmp*A)/(B*sqrt(-pow(aAdh_tmp,2.0) + pow(B,2.0)/4.0))) + (gamma*sqrt(M_PI/2.0))/(Eeff*sqrt((aAdh_tmp*gamma)/Eeff)); + dfda = -((aAdh_tmp*A)/(B*sqrt(-pow(aAdh_tmp,2.0) + pow(B,2.0)/4.0))) + (gamma*sqrt(MY_PI/2.0))/(Eeff*sqrt((aAdh_tmp*gamma)/Eeff)); aAdh_tmp = aAdh_tmp - fa/dfda; - fa2 = deltae1D + sqrt(2.0*M_PI*aAdh_tmp*gamma/Eeff) - ( A/2 - A/B*sqrt(pow(B,2.0)/4 - pow(aAdh_tmp,2.0)) ); + fa2 = deltae1D + sqrt(2.0*MY_PI*aAdh_tmp*gamma/Eeff) - ( A/2 - A/B*sqrt(pow(B,2.0)/4 - pow(aAdh_tmp,2.0)) ); if (abs(fa-fa2) < error2) { break; } @@ -862,9 +862,9 @@ double GranSubModNormalMDR::calculate_forces() // area related calculations double Ac; - (*Yflag_offset == 0.0) ? Ac = M_PI*delta*R : Ac = M_PI*((2.0*delta*R - pow(delta,2.0)) + cA/M_PI); + (*Yflag_offset == 0.0) ? Ac = MY_PI*delta*R : Ac = MY_PI*((2.0*delta*R - pow(delta,2.0)) + cA/MY_PI); if (Ac < 0.0 ) Ac = 0.0; - Atot_sum[i] += wij*(Ac - 2.0*M_PI*R*(deltamax_MDR + delta_BULK)); + Atot_sum[i] += wij*(Ac - 2.0*MY_PI*R*(deltamax_MDR + delta_BULK)); Acon1[i] += wij*Ac; // bulk force calculation @@ -949,7 +949,7 @@ double GranSubModNormalMDR::calculate_forces() *Ac_offset = wij*Ac; // radius update scheme quantity calculation - Vcaps[i] += (M_PI/3.0)*pow(delta,2.0)*(3.0*R - delta); + Vcaps[i] += (MY_PI/3.0)*pow(delta,2.0)*(3.0*R - delta); const double Fntmp = wij*(F_MDR + F_BULK); const double fx = Fntmp*gm->nx[0]; @@ -973,16 +973,16 @@ double GranSubModNormalMDR::calculate_forces() //} //if () { - // std::cout << j << ", " << -Vo*(eps_bar_contact - *eps_bar_offset) - wij*M_PI*ddeltao*( 2.0*deltao*Ro - pow(deltao,2.0) + pow(R,2.0) - pow(Ro,2.0) ) << ", " << -Vo*(eps_bar_contact - *eps_bar_offset) << ", " << wij*M_PI*ddeltao*( 2.0*deltao*Ro - pow(deltao,2.0) + pow(R,2.0) - pow(Ro,2.0) ) << std::endl; + // std::cout << j << ", " << -Vo*(eps_bar_contact - *eps_bar_offset) - wij*MY_PI*ddeltao*( 2.0*deltao*Ro - pow(deltao,2.0) + pow(R,2.0) - pow(Ro,2.0) ) << ", " << -Vo*(eps_bar_contact - *eps_bar_offset) << ", " << wij*MY_PI*ddeltao*( 2.0*deltao*Ro - pow(deltao,2.0) + pow(R,2.0) - pow(Ro,2.0) ) << std::endl; //std::cout << i << ", " << j << ", " << gm->contact_type << " || " << eps_bar_contact << ", " << *eps_bar_offset << ", " << (uintptr_t)(eps_bar_offset) << " || " << wij << ", " << ddeltao << ", " << deltao << " || " << Ro << ", " << R << std::endl; //} double desp_bar_contact = eps_bar_contact - *eps_bar_offset; // && desp_bar_contact < 0.0 if(delta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0){ - const double Vo = (4.0/3.0)*M_PI*pow(Ro,3.0); - dRnumerator[i] += -Vo*(eps_bar_contact - *eps_bar_offset) - wij*M_PI*ddeltao*( 2.0*deltao*Ro - pow(deltao,2.0) + pow(R,2.0) - pow(Ro,2.0) ); - dRdenominator[i] += wij*2.0*M_PI*R*(deltao + R - Ro); + const double Vo = (4.0/3.0)*MY_PI*pow(Ro,3.0); + dRnumerator[i] += -Vo*(eps_bar_contact - *eps_bar_offset) - wij*MY_PI*ddeltao*( 2.0*deltao*Ro - pow(deltao,2.0) + pow(R,2.0) - pow(Ro,2.0) ); + dRdenominator[i] += wij*2.0*MY_PI*R*(deltao + R - Ro); //if ( (atom->tag[i] == 9) ) { // std::cout << "CT: " << gm->contact_type << ", " << PAIR << "i_tag: " << atom->tag[i] << ", j_tag: " << atom->tag[j] << ", deltae1D: " << deltae1D << ", R: " << R << ", Ro: " << Ro << ", F_MDR: " << F_MDR << ", F_BULK: " << F_BULK << ", wij: " << wij << ", deltao: " << deltao << ", ddeltao: " << ddeltao << ", desp_bar: " << eps_bar_contact - *eps_bar_offset << std::endl; @@ -1061,7 +1061,7 @@ double GranSubModNormalMDR::calculate_forces() Reff = gm->radi; } const double kn = Eeff*Reff; - const double beta = -log(CoR)/sqrt(pow(log(CoR),2.0) + M_PI*M_PI); + const double beta = -log(CoR)/sqrt(pow(log(CoR),2.0) + MY_PI*MY_PI); const double damp_prefactor = beta*sqrt(gm->meff*kn); const double F_DAMP = -damp_prefactor*(gm->vnnr); diff --git a/src/fix_mdr_mean_surf_disp.cpp b/src/fix_mdr_mean_surf_disp.cpp index cdc170f968..91804e51fb 100644 --- a/src/fix_mdr_mean_surf_disp.cpp +++ b/src/fix_mdr_mean_surf_disp.cpp @@ -24,6 +24,7 @@ #include "error.h" #include "force.h" #include "input.h" +#include "math_const.h" #include "memory.h" #include "modify.h" #include "variable.h" @@ -42,6 +43,7 @@ using namespace LAMMPS_NS; using namespace FixConst; using namespace Granular_NS; +using MathConst::MY_PI; /* ---------------------------------------------------------------------- */ @@ -235,7 +237,7 @@ void FixMDRmeanSurfDisp::pre_force(int) const double eny_kj = -dely_jk * rinv_jk; const double enz_kj = -delz_jk * rinv_jk; const double alpha = std::acos(enx_ki*enx_kj + eny_ki*eny_kj + enz_ki*enz_kj); - pij[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/M_PI - 1.0/2.0)) ); + pij[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/MY_PI - 1.0/2.0)) ); } else if (maxIndex == 1) { // the central particle is j const double enx_ji = -delx_ij * rinv_ij; const double eny_ji = -dely_ij * rinv_ij; @@ -244,7 +246,7 @@ void FixMDRmeanSurfDisp::pre_force(int) const double eny_jk = dely_jk * rinv_jk; const double enz_jk = delz_jk * rinv_jk; const double alpha = std::acos(enx_ji*enx_jk + eny_ji*eny_jk + enz_ji*enz_jk); - pik[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/M_PI - 1.0/2.0)) ); + pik[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/MY_PI - 1.0/2.0)) ); } else { // the central particle is i if (j < atom->nlocal || k < atom->nlocal) { const double enx_ij = delx_ij * rinv_ij; @@ -255,7 +257,7 @@ void FixMDRmeanSurfDisp::pre_force(int) const double enz_ik = delz_ik * rinv_ik; const double alpha = std::acos(enx_ij*enx_ik + eny_ij*eny_ik + enz_ij*enz_ik); //std::cout << "Print: " << __LINE__ << std::endl; - pjk[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/M_PI - 1.0/2.0)) ); + pjk[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/MY_PI - 1.0/2.0)) ); //std::cout << "Print: " << __LINE__ << std::endl; } } @@ -534,6 +536,6 @@ void FixMDRmeanSurfDisp::pre_force(int) } -//std::cout << radius[i] << ", " << dR << ", " << dRnumerator[i] << ", " << dRdenominator[i] << ", " << dRdenominator[i] - 4.0*M_PI*pow(R,2.0) << std::endl; +//std::cout << radius[i] << ", " << dR << ", " << dRnumerator[i] << ", " << dRdenominator[i] << ", " << dRdenominator[i] - 4.0*MY_PI*pow(R,2.0) << std::endl; //std::cout << "Fix radius update setup has been entered !!!" << std::endl; //std::cout << Ro[0] << ", " << Vgeo[0] << ", " << Velas[0] << std::endl; diff --git a/src/fix_mdr_radius_update.cpp b/src/fix_mdr_radius_update.cpp index 3f226fb87a..36ada70f55 100644 --- a/src/fix_mdr_radius_update.cpp +++ b/src/fix_mdr_radius_update.cpp @@ -24,10 +24,10 @@ #include "error.h" #include "force.h" #include "input.h" +#include "math_const.h" #include "memory.h" #include "modify.h" #include "variable.h" -#include #include "csv_writer.h" #include "granular_model.h" #include "pair_granular.h" @@ -35,12 +35,14 @@ #include "gran_sub_mod_normal.h" #include "update.h" #include "comm.h" +#include #include #include using namespace LAMMPS_NS; using namespace Granular_NS; using namespace FixConst; +using MathConst::MY_PI; /* ---------------------------------------------------------------------- */ @@ -205,9 +207,9 @@ void FixMDRradiusUpdate::pre_force(int) for (int i = 0; i < nlocal; i++) { if (history_setup_flag[i] < 1e-16) { Ro[i] = radius[i]; - Vgeo[i] = 4.0/3.0*M_PI*pow(Ro[i],3.0); - Velas[i] = 4.0/3.0*M_PI*pow(Ro[i],3.0); - Atot[i] = 4.0*M_PI*pow(Ro[i],2.0); + Vgeo[i] = 4.0/3.0*MY_PI*pow(Ro[i],3.0); + Velas[i] = 4.0/3.0*MY_PI*pow(Ro[i],3.0); + Atot[i] = 4.0*MY_PI*pow(Ro[i],2.0); psi[i] = 1.0; psi_b[i] = norm_model->psi_b; history_setup_flag[i] = 1.0; @@ -301,10 +303,10 @@ void FixMDRradiusUpdate::end_of_step() for (int i = 0; i < nlocal; i++) { const double R = radius[i]; - Atot[i] = 4.0*M_PI*pow(R,2.0) + Atot_sum[i]; + Atot[i] = 4.0*MY_PI*pow(R,2.0) + Atot_sum[i]; - const double Vo = 4.0/3.0*M_PI*pow(Ro[i],3.0); - const double Vgeoi = 4.0/3.0*M_PI*pow(R,3.0) - Vcaps[i]; + const double Vo = 4.0/3.0*MY_PI*pow(Ro[i],3.0); + const double Vgeoi = 4.0/3.0*MY_PI*pow(R,3.0) - Vcaps[i]; Vgeo[i] = std::min(Vgeoi,Vo); //(Vgeoi < Vo) ? Vgeo[i] = Vgeoi : Vgeo[i] = Vo; @@ -315,7 +317,7 @@ void FixMDRradiusUpdate::end_of_step() // std::cout << "psi is: " << psi[i] << std::endl; //} - const double dR = std::max(dRnumerator[i]/(dRdenominator[i] - 4.0*M_PI*pow(R,2.0)),0.0); + const double dR = std::max(dRnumerator[i]/(dRdenominator[i] - 4.0*MY_PI*pow(R,2.0)),0.0); if (psi_b[i] < psi[i]) { if ((radius[i] + dR) < (1.5*Ro[i])) radius[i] += dR; //radius[i] += dR; @@ -325,7 +327,7 @@ void FixMDRradiusUpdate::end_of_step() // std::cout << "big dR change" << std::endl; //} //if (atom->tag[i] == 9){ - // std::cout << i << ", radius: " << radius[i] << ", dR: " << dR << ", dRnum: " << dRnumerator[i] << ", dRdenom " << dRdenominator[i] << ", dRdem_full " << dRdenominator[i] - 4.0*M_PI*pow(R,2.0) << std::endl; + // std::cout << i << ", radius: " << radius[i] << ", dR: " << dR << ", dRnum: " << dRnumerator[i] << ", dRdenom " << dRdenominator[i] << ", dRdem_full " << dRdenominator[i] - 4.0*MY_PI*pow(R,2.0) << std::endl; //} @@ -379,6 +381,6 @@ void FixMDRradiusUpdate::end_of_step() comm->forward_comm(this); } -//std::cout << radius[i] << ", " << dR << ", " << dRnumerator[i] << ", " << dRdenominator[i] << ", " << dRdenominator[i] - 4.0*M_PI*pow(R,2.0) << std::endl; +//std::cout << radius[i] << ", " << dR << ", " << dRnumerator[i] << ", " << dRdenominator[i] << ", " << dRdenominator[i] - 4.0*MY_PI*pow(R,2.0) << std::endl; //std::cout << "Fix radius update setup has been entered !!!" << std::endl; //std::cout << Ro[0] << ", " << Vgeo[0] << ", " << Velas[0] << std::endl; From 97f19d9d54a8e2b6b65a3ed45414c9e40257e0ad Mon Sep 17 00:00:00 2001 From: Sachith Dunatunga Date: Sun, 15 Dec 2024 17:19:16 -0800 Subject: [PATCH 06/74] revert fix_ave_chunk changes --- src/fix_ave_chunk.cpp | 4 ---- src/fix_ave_chunk.h | 2 +- 2 files changed, 1 insertion(+), 5 deletions(-) diff --git a/src/fix_ave_chunk.cpp b/src/fix_ave_chunk.cpp index 8757363933..6a3c2e2032 100644 --- a/src/fix_ave_chunk.cpp +++ b/src/fix_ave_chunk.cpp @@ -431,8 +431,6 @@ FixAveChunk::~FixAveChunk() /* ---------------------------------------------------------------------- */ -// FOR MDR - int FixAveChunk::setmask() { int mask = 0; @@ -501,8 +499,6 @@ void FixAveChunk::setup(int /*vflag*/) /* ---------------------------------------------------------------------- */ -// FOR MDR, DO WHATEVER YOUR FIX NEEDS TO DO. - void FixAveChunk::end_of_step() { int i,j,m,index; diff --git a/src/fix_ave_chunk.h b/src/fix_ave_chunk.h index a25ade9654..0919a17acf 100644 --- a/src/fix_ave_chunk.h +++ b/src/fix_ave_chunk.h @@ -31,7 +31,7 @@ class FixAveChunk : public Fix { int setmask() override; void init() override; void setup(int) override; - void end_of_step() override; // FOR MDR + void end_of_step() override; double compute_array(int, int) override; double memory_usage() override; From a7ba185a4ce3f78d4d2bd929d38fd09c5c096adf Mon Sep 17 00:00:00 2001 From: William Zunker Date: Tue, 17 Dec 2024 11:18:26 -0500 Subject: [PATCH 07/74] cleaned up comments --- .../granular/in.mpfem.triaxial12particles | 2 +- .../granular/{spheres.data => spheres12.data} | 0 examples/granular/spheresSTLgeneration.data | 21 -- src/GRANULAR/fix_wall_gran.cpp | 1 - src/GRANULAR/fix_wall_gran.h | 4 +- src/GRANULAR/fix_wall_gran_region.cpp | 7 +- src/GRANULAR/fix_wall_gran_region.h | 16 +- src/GRANULAR/gran_sub_mod_normal.cpp | 288 ++---------------- src/GRANULAR/gran_sub_mod_rolling.cpp | 3 - src/GRANULAR/granular_model.cpp | 6 +- src/GRANULAR/pair_granular.cpp | 28 +- src/GRANULAR/pair_granular.h | 1 - src/SRD/fix_srd.cpp | 18 +- src/csv_writer.h | 25 -- src/fix_mdr_mean_surf_disp.cpp | 81 +---- src/fix_mdr_radius_update.cpp | 107 ------- 16 files changed, 56 insertions(+), 552 deletions(-) rename examples/granular/{spheres.data => spheres12.data} (100%) delete mode 100644 examples/granular/spheresSTLgeneration.data delete mode 100644 src/csv_writer.h diff --git a/examples/granular/in.mpfem.triaxial12particles b/examples/granular/in.mpfem.triaxial12particles index 8c417086bc..98b5621c1f 100644 --- a/examples/granular/in.mpfem.triaxial12particles +++ b/examples/granular/in.mpfem.triaxial12particles @@ -12,7 +12,7 @@ timestep 1e-6 ######################### SIMULATION BOUNDING BOX, INTEGRATION, AND, GRAVITY ########################### boundary f f f -read_data spheres.data +read_data spheres12.data fix integr all nve/sphere ########################### PARTICLE MATERIAL PROPERTIES AND FORCE MODEL ############################### diff --git a/examples/granular/spheres.data b/examples/granular/spheres12.data similarity index 100% rename from examples/granular/spheres.data rename to examples/granular/spheres12.data diff --git a/examples/granular/spheresSTLgeneration.data b/examples/granular/spheresSTLgeneration.data deleted file mode 100644 index 960c7d357b..0000000000 --- a/examples/granular/spheresSTLgeneration.data +++ /dev/null @@ -1,21 +0,0 @@ -#LAMMPS data file created by matlab. -10 atoms - -1 atom types - --0.005000 0.005000 xlo xhi --0.005000 0.005000 ylo yhi --0.001000 0.020000 zlo zhi - -Atoms - -1 1 0.000249 1560.000000 0.000469 -0.000120 0.008380 -2 1 0.000260 1560.000000 -0.001811 0.000425 0.004090 -3 1 0.000225 1560.000000 -0.001371 0.000426 0.002952 -4 1 0.000252 1560.000000 0.000928 -0.000089 0.004118 -5 1 0.000210 1560.000000 0.000208 0.000384 0.000842 -6 1 0.000218 1560.000000 -0.002456 -0.000587 0.003834 -7 1 0.000201 1560.000000 -0.000278 0.003459 0.003445 -8 1 0.000231 1560.000000 -0.002123 0.003188 0.004799 -9 1 0.000268 1560.000000 -0.000338 -0.001557 0.007382 -10 1 0.000244 1560.000000 0.002537 0.002151 0.005999 diff --git a/src/GRANULAR/fix_wall_gran.cpp b/src/GRANULAR/fix_wall_gran.cpp index 41db281568..3336a8a4d7 100644 --- a/src/GRANULAR/fix_wall_gran.cpp +++ b/src/GRANULAR/fix_wall_gran.cpp @@ -496,7 +496,6 @@ void FixWallGran::post_force(int /*vflag*/) model->dx[2] = dz; model->radi = radius[i]; model->radj = rwall; - if (model->beyond_contact) model->touch = history_one[i][0]; touchflag = model->check_contact(); diff --git a/src/GRANULAR/fix_wall_gran.h b/src/GRANULAR/fix_wall_gran.h index 16b1b228ab..e62ab4e38e 100644 --- a/src/GRANULAR/fix_wall_gran.h +++ b/src/GRANULAR/fix_wall_gran.h @@ -51,8 +51,8 @@ class FixWallGran : public Fix { void reset_dt() override; // for granular model choices - class Granular_NS::GranularModel *model; // MOVED HERE FROM PROTECTED FOR MDR MODEL - void clear_stored_contacts(); // MOVED HERE FROM PROTECTED FOR MDR MODEL + class Granular_NS::GranularModel *model; + void clear_stored_contacts(); protected: int wallstyle, wiggle, wshear, axis; diff --git a/src/GRANULAR/fix_wall_gran_region.cpp b/src/GRANULAR/fix_wall_gran_region.cpp index ba8cd467ec..cc1ac3e04b 100644 --- a/src/GRANULAR/fix_wall_gran_region.cpp +++ b/src/GRANULAR/fix_wall_gran_region.cpp @@ -29,7 +29,6 @@ #include "region.h" #include "update.h" #include "variable.h" -#include using namespace LAMMPS_NS; using namespace Granular_NS; @@ -130,8 +129,6 @@ void FixWallGranRegion::post_force(int /*vflag*/) if (update->setupflag) history_update = 0; model->history_update = history_update; - //std::cout << (uint64_t)this << ", " << (uint64_t)model << std::endl; - // if just reneighbored: // update rigid body masses for owned atoms if using FixRigid // body[i] = which body atom I is in, -1 if none @@ -231,8 +228,8 @@ void FixWallGranRegion::post_force(int /*vflag*/) model->radi = radius[i]; model->radj = region->contact[ic].radius; model->r = region->contact[ic].r; - model->i = i; // Added for MDR - model->j = ic; // Added for MDR + model->i = i; + model->j = ic; if (model->beyond_contact) model->touch = history_many[i][c2r[ic]][0]; diff --git a/src/GRANULAR/fix_wall_gran_region.h b/src/GRANULAR/fix_wall_gran_region.h index 6f9866d8ae..50cd3236b5 100644 --- a/src/GRANULAR/fix_wall_gran_region.h +++ b/src/GRANULAR/fix_wall_gran_region.h @@ -44,13 +44,13 @@ class FixWallGranRegion : public FixWallGran { int size_restart(int) override; int maxsize_restart() override; - class Region *region; // MOVED FROM PRIVATE TO PUBLIC FOR MDR MODEL - void update_contacts(int, int); // MOVED FROM PRIVATE TO PUBLIC FOR MDR MODEL - int *ncontact; // MOVED FROM PRIVATE TO PUBLIC FOR MDR MODEL - int **walls; // MOVED FROM PRIVATE TO PUBLIC FOR MDR MODEL - int *c2r; // MOVED FROM PRIVATE TO PUBLIC FOR MDR MODEL - double ***history_many; // MOVED FROM PRIVATE TO PUBLIC FOR MDR MODEL - int tmax; // MOVED FROM PRIVATE TO PUBLIC FOR MDR MODEL + class Region *region; + void update_contacts(int, int); + int tmax; // max # of region walls one particle can touch + int *ncontact; // # of shear contacts per particle + int **walls; // which wall each contact is with + double ***history_many; // history per particle per contact + int *c2r; // contact to region mapping private: @@ -59,8 +59,6 @@ class FixWallGranRegion : public FixWallGran { // shear history for multiple contacts per particle - - // c2r[i] = index of Ith contact in // region-contact[] list of contacts int motion_resetflag; // used by restart to indicate that region diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 169756b41f..36bbd18982 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -17,11 +17,10 @@ #include "granular_model.h" #include "math_const.h" #include "atom.h" -#include "csv_writer.h" #include "update.h" +#include "citeme.h" #include -#include #include #include @@ -38,6 +37,17 @@ static constexpr double INVROOT6 = 0.40824829046386307274; // 1/sqrt(6) static constexpr double FOURTHIRDS = (4.0 / 3.0); // 4/3 static constexpr double JKRPREFIX = 1.2277228507842888; // cbrt(3*PI**2/16) +static const char cite_mdr[] = + "MDR contact model command: \n\n" + "@Article\n" + " author = \n" + " title = \n" + " journal = ,\n" + " year = ,\n" + " volume = ,\n" + " pages = \n" + "}\n\n"; + /* ---------------------------------------------------------------------- Default normal model ------------------------------------------------------------------------- */ @@ -399,6 +409,8 @@ void GranSubModNormalJKR::set_fncrit() GranSubModNormalMDR::GranSubModNormalMDR(GranularModel *gm, LAMMPS *lmp) : GranSubModNormal(gm, lmp) { + if (lmp->citeme) lmp->citeme->add(cite_mdr); + num_coeffs = 6; // Young's Modulus, Poisson's ratio, yield stress, effective surface energy, psi_b, coefficent of restitution contact_radius_flag = 1; size_history = 26; @@ -441,14 +453,15 @@ double GranSubModNormalMDR::calculate_forces() // The MDR contact model was developed by imagining individual particles being // squished between a number of rigid flats (references below). To allow // for many interacting particles, we extend the idea of isolated particles surrounded - // by rigid flats. In particular, we imagine placing rigid flats at the overlap - // midpoints between particles. The force is calculated seperately on both sides + // by rigid flats. In particular, we imagine placing rigid flats at the overlaps + // between particles. The force is calculated seperately on both sides // of the contact assuming interaction with a rigid flat. The two forces are then // averaged on either side of the contact to determine the final force. If the // contact is between a particle and wall then only one force evaluation is required. // // Zunker and Kamrin, 2024, Part I: https://doi.org/10.1016/j.jmps.2023.105492 // Zunker and Kamrin, 2024, Part II: https://doi.org/10.1016/j.jmps.2023.105493 + // Zunker, Dunatunga, Thakur, Tang, and Kamrin, 2025: const int itag_true = atom->tag[gm->i]; // true i particle tag const int jtag_true = atom->tag[gm->j]; // true j particle tag @@ -457,19 +470,15 @@ double GranSubModNormalMDR::calculate_forces() const double radi_true = gm->radi; // true i particle initial radius const double radj_true = gm->radj; // true j particle initial radius - F = 0.0; // average force - double F0 = 0.0; // force on contact side 0 - double F1 = 0.0; // force on contact side 1 + F = 0.0; // average force + double F0 = 0.0; // force on contact side 0 + double F1 = 0.0; // force on contact side 1 double R0 = 0.0; double R1 = 0.0; int i0 = 0; int i1 = 0; double delta = gm->delta; // apparent overlap - //if (gm->contact_type == PAIR) delta = gm->delta/2.0; // half displacement to imagine interaction with rigid flat - //std::cout << "Normal force is called for: " << i_true << ", " << j_true << std::endl; - //std::cout << "Contact model has been entered " << gm->contact_type << ", " << PAIR << ", " << WALL << ", " << WALLREGION << ", " << gm->itype << ", " << gm->jtype << ", " << gm->delta << std::endl; - // initialize indexing in history array of different constact history variables const int delta_offset_0 = 0; // apparent overlap const int delta_offset_1 = 1; @@ -538,7 +547,6 @@ double GranSubModNormalMDR::calculate_forces() double * contacts = atom->dvector[index_contacts]; double * adhesive_length = atom->dvector[index_adhesive_length]; - double * history = & gm->history[history_index]; // load in all history variables // Rigid flat placement scheme @@ -604,7 +612,6 @@ double GranSubModNormalMDR::calculate_forces() double deltap = deltap0 + deltap1; delta = delta_geo + (deltap0 - delta_geo)/(deltap - deltamax)*(gm->delta-deltamax); - //std::cout << "CS 0: " << gm->radi << ", " << gm->radj << ", gm->delta " << gm->delta << ", delta " << delta << ", deltamax " << deltamax << ", delta_geo " << delta_geo << ", delta_geo_alt " << delta_geo_alt << ", delta_geo/Ri " << delta_geo/gm->radi << ", delta_geo_alt/Rj " << delta_geo_alt/gm->radj << ", delta_geoOpt1 " << delta_geoOpt1 << ", delta_geoOpt2 " << delta_geoOpt2 << ", deltamax-delta " << (deltamax-gm->delta) << std::endl; } delta_offset = & history[delta_offset_0]; deltao_offset = & history[deltao_offset_0]; @@ -648,8 +655,6 @@ double GranSubModNormalMDR::calculate_forces() double deltap = deltap0 + deltap1; delta = delta_geo + (deltap1 - delta_geo)/(deltap - deltamax)*(gm->delta-deltamax); - //std::cout << "CS 1: " << gm->radi << ", " << gm->radj << ", gm->delta " << gm->delta << ", delta " << delta << ", deltamax " << deltamax << ", delta_geo " << delta_geo << ", delta_geo_alt " << delta_geo_alt << ", delta_geo/Ri " << delta_geo/gm->radi << ", delta_geo_alt/Rj " << delta_geo_alt/gm->radj << ", delta_geoOpt1 " << delta_geoOpt1 << ", delta_geoOpt2 " << delta_geoOpt2 << ", deltamax-delta " << (deltamax-gm->delta) << std::endl; - delta_offset = & history[delta_offset_1]; deltao_offset = & history[deltao_offset_1]; delta_MDR_offset = & history[delta_MDR_offset_1]; @@ -668,8 +673,6 @@ double GranSubModNormalMDR::calculate_forces() const int i = gm->i; const int j = gm->j; - //std::cout << lmp->update->ntimestep << std::endl; - // material and geometric property definitions // E, nu, Y gamma , psi_b, and CoR are already defined. const double G = E/(2.0*(1.0+nu)); // shear modulus @@ -714,12 +717,6 @@ double GranSubModNormalMDR::calculate_forces() } } - //if (i_true == 167 && j_true == 204) { - //std::cout << "i " << i << " | j " << j << " | delta_BULK: " << delta_BULK << " | delta_MDR " << delta_MDR << " | ddelta_BULK " << ddelta_BULK << " | ddelta_MDR " << ddelta_MDR << std::endl; - //} - - //std::cout << "Yield Flag: " << *Yflag_offset << ", " << R << std::endl; - // MDR force calculation double F_MDR; double A; // height of elliptical indenter @@ -746,32 +743,21 @@ double GranSubModNormalMDR::calculate_forces() // added for rigid flat placement *deltap_offset = deltamax_MDR - (deltae1Dmax + deltaR); - //std::cout << *deltap_offset << std::endl; } - //std::cout << psi_b << ", " << psi[i] << ", " << A << ", " << B << ", " << pY << ", " << amax << " || " << deltao << ", " << delta << ", " << ddelta << ", " << *delta_offset << ", " << ddelta_bar[i] << " || " << delta_MDR << ", " << ddelta_MDR << ", " << *delta_MDR_offset << ", " << deltamax_MDR << " || " << delta_BULK << ", " << ddelta_BULK << ", " << *delta_BULK_offset << " || " << R << std::endl; - //std::cout << i << ", " << j << ", " << A << ", " << B << " || " << deltao << ", " << delta << ", " << ddelta << ", " << R << ", " << MY_PI*pow(amax,2.0) << std::endl; - double a_na; double a_fac = 0.99; (deltae1D >= 0.0) ? a_na = B*sqrt(A - deltae1D)*sqrt(deltae1D)/A : a_na = 0.0; double aAdh = *aAdh_offset; if (aAdh > a_fac*amax) aAdh = a_fac*amax; - //if (i_true == 4 && j_true == 52){ - //std::cout << "CS: " << contactSide << ", aAdh: " << aAdh << ", deltae1D: " << deltae1D << ", A: " << A << ", B:" << B << ", amax: " << amax << ", deltae1D: " << deltae1D << ", R: " << R << std::endl; - //} - if ( gamma > 0.0 ) { // adhesive contact double g_aAdh; if (delta_MDR == deltamax_MDR || a_na >= aAdh ) { // case 1: no tensile springs, purely compressive contact (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltae1D/A) - (1.0 - 2.0*deltae1D/A)*sqrt(4.0*deltae1D/A - 4.0*pow(deltae1D,2.0)/pow(A,2.0))); if ( std::isnan(F_MDR) ) { - std::cout << "F_MDR is NaN, case 1: no tensile springs" << std::endl; - //std::cout << "Normal model: " << gm->delta << ", " << ddelta << ", " << gm->radi << ", " << gm->radj << " | delta: " << delta0 << ", " << delta1 << " | delta2_offset: " << *delta2_offset0 << ", " << *delta2_offset1 << "| dde: " << dde0 << ", " << dde1 << "| Fold: " << F0old << ", " << F1old << " | a: " << a0 << ", " << a1 << " | k_BULK: " << k_BULK0 << ", " << k_BULK1 << " | h_BULK: " << h_BULK0 << ", " << h_BULK1 << std::endl; - std::cout << "i_true: " << i_true << ", j_true: " << j_true << ", i_tag: " << atom->tag[i_true] << ", j_tag: " << atom->tag[j_true] << ", contact type: " << gm->contact_type << ", deltae1D: " << deltae1D << ", A: " << A << ", B: " << B << ", amax: " << amax << ", deltamax_MDR: " << deltamax_MDR << ", R: " << R << std::endl; - std::exit(1); + error->one(FLERR, "F_MDR is NaN, case 1: no tensile springs"); } *aAdh_offset = a_fac*a_na; } else { @@ -784,27 +770,19 @@ double GranSubModNormalMDR::calculate_forces() pow(Eeff,2),0.3333333333333333))/pow(A,2))/6; if ( (deltae1D + lmax - g_aAdh) >= 0.0) { // case 2: tensile springs, but not exceeding critical length --> deltae + lmax - g(aAdhes) >= 0 - //if (contactSide == 0) { - //std::cout << "Case 2 tensile springs not exceeding critical length, R " << R << "deltae1D " << deltae1D << " , lmax " << lmax << " , g_adh" << g_aAdh << " sum " << (deltae1D + lmax - g_aAdh) << std::endl; - //} const double deltaeAdh = g_aAdh; const double F_na = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltaeAdh/A) - (1.0 - 2.0*deltaeAdh/A)*sqrt(4.0*deltaeAdh/A - 4.0*pow(deltaeAdh,2.0)/pow(A,2.0))); const double F_Adhes = 2.0*Eeff*(deltae1D - deltaeAdh)*aAdh; F_MDR = F_na + F_Adhes; - if ( std::isnan(F_MDR) ) std::cout << "F_MDR is NaN, case 2: tensile springs, but not exceeding critical length" << std::endl; - + if ( std::isnan(F_MDR) ) error->one(FLERR, "F_MDR is NaN, case 2: tensile springs, but not exceeding critical length"); } else { // case 3: tensile springs exceed critical length --> deltae + lmax - g(aAdhes) = 0 - //if (contactSide == 0) { - //std::cout << "Case 3 tensile springs exceed critical length, R " << R << " deltae1D " << deltae1D << " , lmax " << lmax << " , g_adh " << g_aAdh << " sum " << (deltae1D + lmax - g_aAdh) << std::endl; - //} - if ( aAdh < acrit ) { aAdh = 0.0; F_MDR = 0.0; } else { // newton-raphson to find aAdh const double maxIterations = 100; - const double error = 1e-10; + const double error1 = 1e-10; const double error2 = 1e-16; double aAdh_tmp = aAdh; double fa; @@ -812,7 +790,7 @@ double GranSubModNormalMDR::calculate_forces() double dfda; for (int lv1 = 0; lv1 < maxIterations; ++lv1) { fa = deltae1D + sqrt(2.0*MY_PI*aAdh_tmp*gamma/Eeff) - ( A/2 - A/B*sqrt(pow(B,2.0)/4 - pow(aAdh_tmp,2.0)) ); - if (abs(fa) < error) { + if (abs(fa) < error1) { break; } dfda = -((aAdh_tmp*A)/(B*sqrt(-pow(aAdh_tmp,2.0) + pow(B,2.0)/4.0))) + (gamma*sqrt(MY_PI/2.0))/(Eeff*sqrt((aAdh_tmp*gamma)/Eeff)); @@ -832,7 +810,7 @@ double GranSubModNormalMDR::calculate_forces() const double F_na = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltaeAdh/A) - (1.0 - 2.0*deltaeAdh/A)*sqrt(4.0*deltaeAdh/A - 4.0*pow(deltaeAdh,2.0)/pow(A,2.0))); const double F_Adhes = 2.0*Eeff*(deltae1D - deltaeAdh)*aAdh; F_MDR = F_na + F_Adhes; - if ( std::isnan(F_MDR) ) std::cout << "F_MDR is NaN, case 3: tensile springs exceed critical length" << std::endl; + if ( std::isnan(F_MDR) ) error->one(FLERR, "F_MDR is NaN, case 3: tensile springs exceed critical length"); } *aAdh_offset = aAdh; } @@ -841,15 +819,10 @@ double GranSubModNormalMDR::calculate_forces() *aAdh_offset = a_na; (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltae1D/A) - (1.0 - 2.0*deltae1D/A)*sqrt(4.0*deltae1D/A - 4.0*pow(deltae1D,2.0)/pow(A,2.0))); if ( std::isnan(F_MDR) ) { - std::cout << "F_MDR is NaN, non-adhesive case" << std::endl; - //std::cout << "Normal model: " << gm->delta << ", " << ddelta << ", " << gm->radi << ", " << gm->radj << " | delta: " << delta0 << ", " << delta1 << " | delta2_offset: " << *delta2_offset0 << ", " << *delta2_offset1 << "| dde: " << dde0 << ", " << dde1 << "| Fold: " << F0old << ", " << F1old << " | a: " << a0 << ", " << a1 << " | k_BULK: " << k_BULK0 << ", " << k_BULK1 << " | h_BULK: " << h_BULK0 << ", " << h_BULK1 << std::endl; - std::cout << "i_true: " << i_true << ", j_true: " << j_true << ", i_tag: " << atom->tag[i_true] << ", j_tag: " << atom->tag[j_true] << ", deltae1D: " << deltae1D << ", A: " << A << ", B: " << B << ", amax: " << amax << ", deltamax_MDR: " << deltamax_MDR << ", R: " << R << std::endl; - std::exit(1); + error->one(FLERR, "F_MDR is NaN, non-adhesive case"); } } - //std::cout << gm->i << ", " << gm->j << ", aAdh_offset: " << *aAdh_offset << ", aAdh: " << aAdh << ", a_na: " << a_na << std::endl; - contacts[i] += 1; adhesive_length[i] += aAdh; @@ -858,8 +831,6 @@ double GranSubModNormalMDR::calculate_forces() double pij = *penalty_offset; const double wij = std::max(1.0-pij,0.0); - //std::cout << gm->i << ", " << gm->j << ", " << gm->contact_type << ", " << *gm->xi[1] << ", " << *gm->xj[1] << std::endl; - // area related calculations double Ac; (*Yflag_offset == 0.0) ? Ac = MY_PI*delta*R : Ac = MY_PI*((2.0*delta*R - pow(delta,2.0)) + cA/MY_PI); @@ -871,80 +842,9 @@ double GranSubModNormalMDR::calculate_forces() double F_BULK; (delta_BULK <= 0.0) ? F_BULK = 0.0 : F_BULK = (1.0/Vgeo[i])*Acon0[i]*delta_BULK*kappa*Ac; - //if (atom->tag[i_true] == 4135 && lmp->update->ntimestep > 10935000 && gm->contact_type == 2) { - // std::cout << "CS: " << contactSide << ", i_true: " << i_true << ", j_true: " << j_true << ", i_tag: " << atom->tag[i_true] << ", j_tag: " << atom->tag[j_true] << ", deltae1D: " << deltae1D << ", A: " << A << ", B: " << B << ", amax: " << amax << ", deltamax_MDR: " << deltamax_MDR << ", R: " << R << ", F_MDR: " << F_MDR << ", F_BULK: " << F_BULK << ", wij: " << wij << ", gm->delta: " << gm->delta << ", delta: " << delta << ", delmax: " << deltamax << ", deltap: " << *deltap_offset << std::endl; - //} - - //if (i == 35 && lmp->update->ntimestep % 1000 == 0) { - //double **x = atom->x; - //const double xi = x[i_true][0]; - // std::cout << "i: " << i << ", j: " << j << "i_true: " << i_true << ", i_tag: " << atom->tag[i_true] << ", j_true: " << j_true << ", j_tag " << atom->tag[j_true] << ", radi_true: " << radi_true << ", radj_true " << radj_true << ", gm->radi: " << gm->radi << ", gm->radj: " << gm->radj << ", R: " << R << ", Ro: " << Ro << std::endl; - //} - - //if (i_true == 35 && lmp->update->ntimestep >= 736002 && lmp->update->ntimestep <= 736005) { - // //double **x = atom->x; - // //const double xi = x[i_true][0]; - // std::cout << "i_true: " << i_true << ", i_tag: " << atom->tag[i_true] << ", R: " << R << ", Ro: " << Ro << std::endl; - //} - - //if ( ((atom->tag[i_true] == 4 && atom->tag[j_true] == 11) || (atom->tag[i_true] == 11 && atom->tag[j_true] == 4)) && lmp->update->ntimestep == 45000) { - // std::cout << "CS: " << contactSide << ", contact_type: " << gm->contact_type << ", pair: " << PAIR << ", wall: " << WALL << ", WALLREGION " << WALLREGION << ", itag_true: " << atom->tag[i_true] << ", jtag_true: " << atom->tag[j_true] << ", F_MDR: " << F_MDR << ", F_BULK: " << F_BULK << ", wij: " << wij << ", gm->delta: " << gm->delta << ", delta: " << delta << ", delmax: " << deltamax << ", deltap: " << *deltap_offset << std::endl; - //} - - //if ( ((atom->tag[i_true] == 4301) || (atom->tag[j_true] == 4076)) && lmp->update->ntimestep > 1016700) { - // std::cout << "i: " << i << ", j: " << j << "i_true: " << i_true << ", i_tag: " << atom->tag[i_true] << ", j_true: " << j_true << ", j_tag " << atom->tag[j_true] << ", radi_true: " << radi_true << ", radj_true " << radj_true << ", gm->radi: " << gm->radi << ", gm->radj: " << gm->radj << ", R: " << R << ", Ro: " << Ro << ", F_MDR: " << F_MDR << ", F_BULK: " << F_BULK << ", wij: " << wij << ", gm->delta: " << gm->delta << ", delta: " << delta << ", delmax: " << deltamax << ", deltap: " << *deltap_offset << std::endl; - //} - - //if ( ((atom->tag[i_true] == 4) || (atom->tag[j_true] == 4)) && lmp->update->ntimestep == 45000) { - // int rank = 0; - // MPI_Comm_rank(MPI_COMM_WORLD, &rank); - // double **x = atom->x; - // const double xi = x[i][0]; - // const double xj = x[j][0]; - // const double yi = x[i][1]; - // const double yj = x[j][1]; - // const double zi = x[i][2]; - // const double zj = x[j][2]; - // std::cout << "CS: " << contactSide << ", rank, " << rank << ", CT: " << gm->contact_type << ", itag_true: " << atom->tag[i_true] << ", jtag_true: " << atom->tag[j_true] << ", i: " << i << ", j: " << j << ", nlocal: " << atom->nlocal << ", nghost: " << atom->nghost << ", wij: " << wij << ", gm->delta: " << gm->delta << ", delta: " << delta << ", delmax: " << deltamax << ", deltap: " << *deltap_offset << ", R: " << R << ", xi: " << xi << ", xj: " << xj << ", yi: " << yi << ", yj: " << yj << ", zi: " << zi << ", zj: " << zj << std::endl; - //} - - //int rank = 0; - //MPI_Comm_rank(MPI_COMM_WORLD, &rank); - //double **x = atom->x; - //const double xi = x[i][0]; - //const double xj = x[j][0]; - //const double yi = x[i][1]; - //const double yj = x[j][1]; - //const double zi = x[i][2]; - //const double zj = x[j][2]; - //const double dis = sqrt(pow((xi-xj),2.0) + pow((yi-yj),2.0) + pow((zi-zj),2.0)); - //const double delta_test = gm->radi + gm->radj - dis; - //if (delta_test < 0.0 && gm->contact_type != 2) { - // std::cout << "Particles are not touching but a force is evaluated, CS: " << contactSide << ", rank, " << rank << ", contact_type: " << gm->contact_type << ", pair: " << PAIR << ", wall: " << WALL << ", WALLREGION " << WALLREGION << ", itag_true: " << atom->tag[i_true] << ", jtag_true: " << atom->tag[j_true] << ", i: " << i << ", j: " << j << ", nlocal: " << atom->nlocal << ", nghost: " << atom->nghost << ", wij: " << wij << ", gm->delta: " << gm->delta << ", delta: " << delta << ", delmax: " << deltamax << ", deltap: " << *deltap_offset << ", R: " << R << ", xi: " << xi << ", xj: " << xj << ", yi: " << yi << ", yj: " << yj << ", zi: " << zi << ", zj: " << zj << std::endl; - // std::exit(1); - //} - - //if (F_BULK > 0.0) { - // std::cout << "F_BULK is: " << F_BULK << std::endl; - //} - - //std::cout << delta_BULK << ", " << F_BULK << ", " << (1.0/Vgeo[i])*Acon0[i]*delta_BULK*kappa*Ac << std::endl; - - //int rank = 0; - //MPI_Comm_rank(MPI_COMM_WORLD, &rank); - //std::cout << "Step: " << lmp->update->ntimestep << ", CS: " << contactSide << ", itag: " << atom->tag[i] << ", jtag: " << atom->tag[j] << ", rank: " << rank << ", gm->delta: " << gm->delta << ", delta: " << delta << ", ddelta: " << ddelta << ", delta_bar: " << ddelta_bar[i] << ", R: " << R << ", F_MDR: " << F_MDR << ", F_BULK: " << F_BULK << std::endl; - - //std::cout << gm->i << ", " << gm->j << ", " << Vgeo[i] << ", " << Acon0[i] << ", " << Acon1[i] << ", " << Ac << ", " << kappa << " || " << psi[i] << ", " << ddelta_bar[i] << ", " << ddelta << ", " << ddelta_MDR << ", " << ddelta_BULK << ", " << delta << ", " << delta_MDR << ", " << delta_BULK << ", " << F_MDR << ", " << F_BULK << ", " << R << " || " << deltae1D << ", " << A << ", " << B << std::endl; - - //std::cout << gm->i << ", " << gm->j << ", " << (1.0/Vgeo[i])*Acon0[i]*delta_BULK*kappa*Ac << std::endl; - // total force calculation (contactSide == 0) ? F0 = F_MDR + F_BULK : F1 = F_MDR + F_BULK; - - - //std::cout << gm->i << ", " << gm->j << " | " << deltao << ", " << ddelta_bar[i] << ", " << R << ", " << psi[i] << ", " << psi_b << ", " << Ac << " | " << pij << ", " << wij << std::endl; - // mean surface dipslacement calculation *Ac_offset = wij*Ac; @@ -961,64 +861,17 @@ double GranSubModNormalMDR::calculate_forces() const double eps_bar_contact = (1.0/(3*kappa*Velas[i]))*(fx*bx + fy*by + fz*bz); eps_bar[i] += eps_bar_contact; - //double **x = atom->x; - //const double xi = x[i_true][0]; - //const double xj = x[j_true][0]; - //std::cout << i_true << ", " << j_true << ", " << xi << ", " << xj << ", " << gm->nx[0] << ", " << gm->nx[1] << ", " << gm->nx[2] << std::endl; - - //if ( (i == 0 && j == 2 && gm->contact_type == 0) || (i == 2 && j == 0 && gm->contact_type == 0)) { - //std::cout << i << ", " << j << ", " << gm->contact_type << " || " << delta << ", " << *delta_offset << ", " << (uintptr_t)(delta_offset) << " || " << deltao << ", " << *deltao_offset << ", " << (uintptr_t)(deltao_offset) << " || " << delta_MDR << ", " << *delta_MDR_offset << ", " << (uintptr_t)(delta_MDR_offset) << " || " << *Yflag_offset << ", " << (uintptr_t)(Yflag_offset) << " || " << R << std::endl; - //std::cout << i << ", " << j << ", " << gm->contact_type << " || " << fx << ", " << fy << ", " << fz << " || " << bx << ", " << by << ", " << bz << ", " << Velas[i] << std::endl; - //std::cout << i << ", " << j << ", " << gm->contact_type << " || " << eps_bar_contact << ", " << *eps_bar_offset << ", " << (uintptr_t)(eps_bar_offset) << " || " << wij << ", " << ddeltao << ", " << deltao << ", " << delta << ", " << *delta_offset << " || " << Ro << ", " << R << std::endl; - //} - - //if () { - // std::cout << j << ", " << -Vo*(eps_bar_contact - *eps_bar_offset) - wij*MY_PI*ddeltao*( 2.0*deltao*Ro - pow(deltao,2.0) + pow(R,2.0) - pow(Ro,2.0) ) << ", " << -Vo*(eps_bar_contact - *eps_bar_offset) << ", " << wij*MY_PI*ddeltao*( 2.0*deltao*Ro - pow(deltao,2.0) + pow(R,2.0) - pow(Ro,2.0) ) << std::endl; - //std::cout << i << ", " << j << ", " << gm->contact_type << " || " << eps_bar_contact << ", " << *eps_bar_offset << ", " << (uintptr_t)(eps_bar_offset) << " || " << wij << ", " << ddeltao << ", " << deltao << " || " << Ro << ", " << R << std::endl; - //} - - - double desp_bar_contact = eps_bar_contact - *eps_bar_offset; // && desp_bar_contact < 0.0 + double desp_bar_contact = eps_bar_contact - *eps_bar_offset; if(delta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0){ const double Vo = (4.0/3.0)*MY_PI*pow(Ro,3.0); dRnumerator[i] += -Vo*(eps_bar_contact - *eps_bar_offset) - wij*MY_PI*ddeltao*( 2.0*deltao*Ro - pow(deltao,2.0) + pow(R,2.0) - pow(Ro,2.0) ); dRdenominator[i] += wij*2.0*MY_PI*R*(deltao + R - Ro); - - //if ( (atom->tag[i] == 9) ) { - // std::cout << "CT: " << gm->contact_type << ", " << PAIR << "i_tag: " << atom->tag[i] << ", j_tag: " << atom->tag[j] << ", deltae1D: " << deltae1D << ", R: " << R << ", Ro: " << Ro << ", F_MDR: " << F_MDR << ", F_BULK: " << F_BULK << ", wij: " << wij << ", deltao: " << deltao << ", ddeltao: " << ddeltao << ", desp_bar: " << eps_bar_contact - *eps_bar_offset << std::endl; - //} } *eps_bar_offset = eps_bar_contact; sigmaxx[i] += (1.0/Velas[i])*(fx*bx); sigmayy[i] += (1.0/Velas[i])*(fy*by); sigmazz[i] += (1.0/Velas[i])*(fz*bz); - //std::cout << psi_b << ", " << psi[i] << ", " << A << ", " << B << ", " << pY << ", " << amax << " || " << deltao << ", " << delta << ", " << ddelta << ", " << *delta_offset << ", " << ddelta_bar[i] << " || " << delta_MDR << ", " << ddelta_MDR << ", " << *delta_MDR_offset << ", " << deltamax_MDR << " || " << delta_BULK << ", " << ddelta_BULK << ", " << *delta_BULK_offset << " || " << R << " || " << Ac << ", " << *Ac_offset << ", " << Acon0[i] << ", " << Acon1[i] << " || " << F_MDR << ", " << F_BULK << ", " << Vgeo[i] << std::endl; - - //std::cout << gm->i << ", " << gm->j << ", " << gm->radi << ", " << gm->radj << " | " << delta << ", " << F_MDR << " | " << deltae1D << ", " << A << ", " << B << std::endl; - - //if (atom->tag[i] == 1 && lmp->update->ntimestep == 45000) { - // double nx; - // double ny; - // double nz; - // if (i == j_true) { - // nx = gm->nx[0]; - // ny = gm->nx[1]; - // nz = gm->nx[2]; - // } else { - // nx = -gm->nx[0]; - // ny = -gm->nx[1]; - // nz = -gm->nx[2]; - // } - // double deltae = deltamax_MDR - *deltap_offset; - // CSVWriter csvWriter("/Users/willzunker/lammps_mdr_develop/sims/MPFEM/deformed_particle_shape_data.csv"); - // std::stringstream rowDataStream; - // rowDataStream << std::scientific << std::setprecision(8); // Set the format and precision - // rowDataStream << nx << ", " << ny << ", " << nz << ", " << Ro << ", " << R << ", " << delta << ", " << deltae << ", " << A << ", " << B << ", " << a_na; - // std::string rowData = rowDataStream.str(); - // csvWriter.writeRow(rowData); - //} - } gm->i = i_true; @@ -1031,24 +884,13 @@ double GranSubModNormalMDR::calculate_forces() const double wij = std::max(1.0-pij,0.0); *penalty_offset = 0.0; - //std::cout << gm->i << ", " << gm->j << ", " << xi << ", " << xj << std::endl; - - // force magnifiers to prevent over penetration - double * deltao_offset = & history[deltao_offset_0]; - //const double wallForceMagnifer = std::exp(10.0*(*deltao_offset)/Rinitial[gm->i] - 10.0) + 1.0; - const double wallForceMagnifer = 1.0; - // assign final force - //(gm->contact_type != PAIR) ? F = wij*F0*wallForceMagnifer : F = wij*(F0 + F1)/2; // F = 2*wij*pow(1/F0 + 1/F1,-1); - if (gm->contact_type != PAIR) { - F = wij*F0*wallForceMagnifer; + F = wij*F0; } else { F = wij*(F0 + F1)/2.0; } - //std::cout << F << ", " << F0 << ", " << F1 << " | " << R0 << ", " << R1 << std::endl; - // calculate damping force if (F > 0.0) { double Eeff; @@ -1065,53 +907,9 @@ double GranSubModNormalMDR::calculate_forces() const double damp_prefactor = beta*sqrt(gm->meff*kn); const double F_DAMP = -damp_prefactor*(gm->vnnr); - //std:: cout << gm->contact_type << ", " << Eeff << " , " << Reff << ", " << gm->radi << ", " << gm->radj << " || " << kn << ", " << beta << ", " << gm->meff << " || " << F_DAMP << ", " << F << std::endl; F += wij*F_DAMP; } - //double **x = atom->x; - //const double xi = x[gm->i][0]; - //const double xj = x[gm->j][0]; - //const double del = 20.0 - abs(xi-xj); - - //if (i_true == 146 && j_true == 152) { - // CSVWriter csvWriter("/Users/willzunker/lammps_mdr_develop/sims/avicelTableting/rigid_flat_output.csv"); - // std::stringstream rowDataStream; - // rowDataStream << std::scientific << std::setprecision(6); // Set the format and precision - // rowDataStream << gm->delta << ", " << delta0 << ", " << delta1 << ", " << dde0 << ", " << dde1 << ", " << (dde0 + dde1) << ", " << F0old << ", " << F1old << ", " << a0 << ", " << a1 << ", " << h0 << ", " << h1 << ", " << k_BULK0 << ", " << k_BULK1 << ", " << h_BULK0 << ", " << h_BULK1; - // std::string rowData = rowDataStream.str(); - // csvWriter.writeRow(rowData); - //} - - //if (i_true == 0 && j_true == 1) { - // CSVWriter csvWriter("/Users/willzunker/lammps_mdr_develop/sims/twoParticleDifferingRadii/rigid_flat_output.csv"); - // std::stringstream rowDataStream; - // rowDataStream << std::scientific << std::setprecision(6); // Set the format and precision - // rowDataStream << gm->delta << ", " << delta0 << ", " << delta1 << ", " << dde0 << ", " << dde1 << ", " << (dde0 + dde1) << ", " << F0old << ", " << F1old << ", " << a0 << ", " << a1 << ", " << h0 << ", " << h1 << ", " << k_BULK0 << ", " << k_BULK1 << ", " << h_BULK0 << ", " << h_BULK1 << ", " << R0 << ", " << R1; - // std::string rowData = rowDataStream.str(); - // csvWriter.writeRow(rowData); - //} - - //if (i_true == 0 && j_true == 1) { - // CSVWriter csvWriter("/Users/willzunker/lammps_mdr_develop/sims/twoParticleDifferingRadii/rigid_flat_output_fit.csv"); - // std::stringstream rowDataStream; - // rowDataStream << std::scientific << std::setprecision(6); // Set the format and precision - // rowDataStream << gm->delta << ", " << delta0 << ", " << delta1 << ", " << delta01; - // std::string rowData = rowDataStream.str(); - // csvWriter.writeRow(rowData); - //} - - //if (gm->i == 0 && gm->j == 2) { - // CSVWriter csvWriter("/Users/willzunker/lammps/sims/compressionSleeve/pairContactsBotCen.csv"); - // std::stringstream rowDataStream; - // rowDataStream << std::scientific << std::setprecision(4); // Set the format and precision - // rowDataStream << del << ", " << F; - // std::string rowData = rowDataStream.str(); - // csvWriter.writeRow(rowData); - //} - - //std:: cout << "The force F is: " << F << std::endl; - return F; } @@ -1121,33 +919,3 @@ void GranSubModNormalMDR::set_fncrit() { Fncrit = fabs(F); } - -//std::cout << sidata.i << ", " << sidata.j << ", " << R << ", " << deltan << ", " << deltao << ", " << dRsums_i[0] << ", " << dRsums_i[1] << ", " << numQuant << std::endl; -//std::cout << gm->i << ", " << gm->j << " | " << gm->nx[0] << ", " << gm->nx[1] << ", " << gm->nx[2] << std::endl; -//std::cout << "F is: " << F << std::endl; -//std::cout << "Ro from particle history is: " << Ro[gm->i] << std::endl; -//std::cout << "MDR contact model has been entered." << std::endl; -// std::cout << "F is: " << F << std::endl; -//std::cout << "gamma > 0.0: " << F_MDR << ", " << gm->i << ", " << gm->j << std::endl; -//std::cout << "deltae1D <= 0.0: " << F_MDR << ", " << gm->i << ", " << gm->j << std::endl; -//std::cout << "F_MDR should be > 0: " << F_MDR << ", " << gm->i << ", " << gm->j << std::endl; -//std::cout << gm->i << ", " << gm->j << " || " << delta << ", " << delta_MDR << ", " << deltamax_MDR << ", " << deltae1D << " || " << A << ", " << B << std::endl; - -//std::cout << i_true << ", " << j_true << std::endl; - - //std::cout << history_index << ", " << history[0] << ", " << history[1] << ", " << history[2] << std::endl; - - // initialize all history variables - //double delta_offset; - //double deltao_offset; - //double delta_MDR_offset; - //double delta_BULK_offset; - //double deltamax_MDR_offset; - //double Yflag; - //double deltaY_offset; - //double Ac_offset; - //double aAdh_offset; - //double deltap_offset; - //double cA_offset; - //double eps_bar_offset; - //double wall_contact_flag_offset; diff --git a/src/GRANULAR/gran_sub_mod_rolling.cpp b/src/GRANULAR/gran_sub_mod_rolling.cpp index b236b9a142..109bbee65d 100644 --- a/src/GRANULAR/gran_sub_mod_rolling.cpp +++ b/src/GRANULAR/gran_sub_mod_rolling.cpp @@ -17,7 +17,6 @@ #include "gran_sub_mod_normal.h" #include "granular_model.h" #include "math_extra.h" -#include #include @@ -82,8 +81,6 @@ void GranSubModRollingSDS::calculate_forces() hist_temp[1] = gm->history[rhist1]; hist_temp[2] = gm->history[rhist2]; - //std::cout << "Frcrit rolling is: " << Frcrit << std::endl; - if (gm->history_update) { rolldotn = dot3(hist_temp, gm->nx); diff --git a/src/GRANULAR/granular_model.cpp b/src/GRANULAR/granular_model.cpp index d4fb6f66a8..546c7a3d4e 100644 --- a/src/GRANULAR/granular_model.cpp +++ b/src/GRANULAR/granular_model.cpp @@ -243,7 +243,11 @@ void GranularModel::init() // Must have valid normal, damping, and tangential models if (normal_model->name == "none") error->all(FLERR, "Must specify normal granular model"); - //if (damping_model->name == "none") error->all(FLERR, "Must specify damping granular model"); TURNED OFF FOR MDR + if (normal_model->name == "mdr") { + if (damping_model->name != "none") error->all(FLERR, "Damping model must be set to 'none' for the MDR contact model. Specify a coefficient of restitution CoR < 1 if normal damping is desired."); + } else { + if (damping_model->name == "none") error->all(FLERR, "Must specify damping granular model"); + } if (tangential_model->name == "none") error->all(FLERR, "Must specify tangential granular model"); // Twisting, rolling, and heat are optional diff --git a/src/GRANULAR/pair_granular.cpp b/src/GRANULAR/pair_granular.cpp index 230cba446b..aee341aef1 100644 --- a/src/GRANULAR/pair_granular.cpp +++ b/src/GRANULAR/pair_granular.cpp @@ -39,7 +39,6 @@ #include "gran_sub_mod_normal.h" #include -#include using namespace LAMMPS_NS; using namespace Granular_NS; @@ -490,28 +489,7 @@ void PairGranular::init_style() if (!fix_history) error->all(FLERR,"Could not find pair fix neigh history ID"); } - /* - // Example - //Store persistent per atom quantities - if (! fix_flag) { - int tmp1, tmp2; - id_fix = "BOND_BPM_PLASTIC_FIX_PROP_ATOM"; - modify->add_fix( - fmt::format("{} all property/atom d_plastic d_plastic_temp d_viscous_temp d_plastic_heat d_viscous_heat ghost yes", id_fix)); - index_plastic = atom->find_custom("plastic",tmp1,tmp2); - index_pq = atom->find_custom("plastic_heat",tmp1,tmp2); - index_pt = atom->find_custom("plastic_temp",tmp1,tmp2); - index_vq = atom->find_custom("viscous_heat",tmp1,tmp2); - index_vt = atom->find_custom("viscous_temp",tmp1,tmp2); - fix_flag = 1; - } - */ - if (model->normal_model->name == "mdr") { - - std::cout << "MDR history variables have been initialized" << std::endl; - - // FOR MDR CONTACT MODEL //Store persistent per atom quantities if (! fix_flag) { int tmp1, tmp2; @@ -537,11 +515,7 @@ void PairGranular::init_style() index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); // yy-component of the stress tensor, not necessary for force calculation index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); // zz-component of the stress tensor, not necessary for force calculation index_contacts = atom->find_custom("contacts",tmp1,tmp2); // total contacts on particle - index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); // total contacts on particle - - std::cout << "MDR history variables have been initialized 2" << ", " << index_Ro << std::endl; - - //index_volSums = atom->find_custom("volSums",tmp1,tmp2); + index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); // total length of adhesive contact on a particle // Initiate MDR radius update fix modify->add_fix("fix_mdr_radius_update all mdr/radius/update"); diff --git a/src/GRANULAR/pair_granular.h b/src/GRANULAR/pair_granular.h index 10b581968a..199431afe3 100644 --- a/src/GRANULAR/pair_granular.h +++ b/src/GRANULAR/pair_granular.h @@ -49,7 +49,6 @@ class PairGranular : public Pair { size_t get_size_history() const; // granular models - // MOVED HERE FROM PRIVATE FOR MDR MODEL class Granular_NS::GranularModel** models_list; int **types_indices; int nmodels, maxmodels; diff --git a/src/SRD/fix_srd.cpp b/src/SRD/fix_srd.cpp index 054ef83349..9b153a1c28 100644 --- a/src/SRD/fix_srd.cpp +++ b/src/SRD/fix_srd.cpp @@ -40,7 +40,6 @@ #include #include -#include using namespace LAMMPS_NS; using namespace FixConst; @@ -55,7 +54,7 @@ enum { SHIFT_NO, SHIFT_YES, SHIFT_POSSIBLE }; static constexpr double EINERTIA = 0.2; // moment of inertia prefactor for ellipsoid -static constexpr int ATOMPERBIN = 100; +static constexpr int ATOMPERBIN = 30; static constexpr double BIG = 1.0e20; static constexpr int VBINSIZE = 5; static constexpr double TOLERANCE = 0.00001; @@ -1322,7 +1321,6 @@ void FixSRD::collisions_single() #endif if (t_remain > dt) { - print_collision(i, j, ibounce, t_remain, dt, xscoll, xbcoll, norm, type); ninside++; if (insideflag == INSIDE_ERROR || insideflag == INSIDE_WARN) { std::string mesg; @@ -2605,17 +2603,14 @@ void FixSRD::parameterize() for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) { if (rmass) { - if (mass_srd == 0.0) { + if (mass_srd == 0.0) mass_srd = rmass[i]; - std::cout << "mass if #1: " << rmass[i] << std::endl; - std::cout << "srd radius is: " << radius[i] << std::endl; - } else if (rmass[i] != mass_srd) + else if (rmass[i] != mass_srd) flag = 1; } else { - if (mass_srd == 0.0) { + if (mass_srd == 0.0) mass_srd = mass[type[i]]; - std::cout << "mass if #2: " << mass[type[i]] << std::endl; - } else if (mass[type[i]] != mass_srd) + else if (mass[type[i]] != mass_srd) flag = 1; } } @@ -2717,7 +2712,6 @@ void FixSRD::parameterize() if (dimension == 3) { volsrd = (domain->xprd * domain->yprd * domain->zprd) - volbig; density_srd = nsrd * mass_srd / (domain->xprd * domain->yprd * domain->zprd - volbig); - std::cout << nsrd << ", " << mass_srd << ", " << domain->xprd << ", " << domain->yprd << ", " << domain->zprd << ", " << volbig << std::endl; } else { volsrd = (domain->xprd * domain->yprd) - volbig; density_srd = nsrd * mass_srd / (domain->xprd * domain->yprd - volbig); @@ -2779,7 +2773,7 @@ void FixSRD::parameterize() gridsrd, binsize3x, binsize3y, binsize3z); mesg += fmt::format(" SRD per actual grid cell = {:.8}\n", srd_per_cell); mesg += fmt::format(" SRD viscosity = {:.8}\n", viscosity); - mesg += fmt::format(" big/SRD mass density ratio = {:.8} | big density = {:.8}, small density = {:.8}\n", mdratio,density_big,density_srd); + mesg += fmt::format(" big/SRD mass density ratio = {:.8}\n", mdratio); utils::logmesg(lmp, mesg); } diff --git a/src/csv_writer.h b/src/csv_writer.h deleted file mode 100644 index 29bb44e419..0000000000 --- a/src/csv_writer.h +++ /dev/null @@ -1,25 +0,0 @@ -#include -#include -#include - -class CSVWriter { -public: - CSVWriter(const std::string& filename) : filename_(filename) {} - - void writeRow(const std::string& data) { - std::ofstream file; - // Use the append mode to add data to the end of the file if it exists - file.open(filename_, std::ios::out | std::ios::app); - - if (!file.is_open()) { - std::cerr << "Failed to open file: " << filename_ << std::endl; - return; - } - - file << data << std::endl; - file.close(); - } - -private: - std::string filename_; -}; diff --git a/src/fix_mdr_mean_surf_disp.cpp b/src/fix_mdr_mean_surf_disp.cpp index 91804e51fb..324f9fbd1b 100644 --- a/src/fix_mdr_mean_surf_disp.cpp +++ b/src/fix_mdr_mean_surf_disp.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -37,7 +36,6 @@ #include "update.h" #include "fix_wall_gran_region.h" #include "comm.h" -#include #include using namespace LAMMPS_NS; @@ -53,8 +51,6 @@ FixMDRmeanSurfDisp::FixMDRmeanSurfDisp(LAMMPS *lmp, int narg, char **arg) : comm_forward = 1; // value needs to match number of values you communicate } -// FOR MDR - int FixMDRmeanSurfDisp::setmask() { int mask = 0; @@ -79,7 +75,6 @@ int FixMDRmeanSurfDisp::pack_forward_comm(int n, int *list, double *buf, int /*p for (int i = 0; i < n; i++) { int j = list[i]; buf[m++] = ddelta_bar[j]; - //buf[m++] = Acon0[j]; } return m; } @@ -90,7 +85,6 @@ void FixMDRmeanSurfDisp::unpack_forward_comm(int n, int first, double *buf) int last = first + n; for (int i = first; i < last; i++) { ddelta_bar[i] = buf[m++]; - //Acon0[i] = buf[m++]; } } @@ -102,9 +96,6 @@ void FixMDRmeanSurfDisp::pre_force(int) const int size_history = pair->get_size_history(); - //std::cout << " " << std::endl; - //std::cout << "New Step" << std::endl; - { int i,j,k,lv1,ii,jj,inum,jnum,itype,jtype,ktype; @@ -114,10 +105,6 @@ void FixMDRmeanSurfDisp::pre_force(int) bool touchflag = false; - //class GranularModel* model; - //class GranularModel** models_list = pair->models_list; - //int ** types_indices = pair->types_indices; - double **x = atom->x; int *type = atom->type; double *radius = atom->radius; @@ -186,8 +173,8 @@ void FixMDRmeanSurfDisp::pre_force(int) history_ik = &allhistory[size_history * kk]; double * pik = &history_ik[22]; // penalty for contact i and k - // we don't know if who owns the contact ahead of time, k might be in j's neigbor list or vice versa, so we need to manually search to figure out the owner - // check if k is in the neighbor list of j + // we don't know if who owns the contact ahead of time, k might be in j's neigbor list or vice versa, + // so we need to manually search to figure out the owner check if k is in the neighbor list of j double * pjk = NULL; int * const jklist = firstneigh[j]; const int jknum = numneigh[j]; @@ -197,10 +184,6 @@ void FixMDRmeanSurfDisp::pre_force(int) allhistory_j = firsthistory[j]; history_jk = &allhistory_j[size_history * jk]; pjk = &history_jk[22]; // penalty for contact j and k - //int rank = 0; - //MPI_Comm_rank(MPI_COMM_WORLD, &rank); - //std::cout << "Print 183 pjk: " << rank << ", " << pjk << std::endl; - //std::cout << "Print 183 pjk[0]: " << rank << ", " << pjk[0] << std::endl; break; } } @@ -215,16 +198,11 @@ void FixMDRmeanSurfDisp::pre_force(int) allhistory_k = firsthistory[k]; history_kj = &allhistory_k[size_history * kj]; pjk = &history_kj[22]; // penalty for contact j and k - //int rank = 0; - //MPI_Comm_rank(MPI_COMM_WORLD, &rank); - //std::cout << "Print 198 pjk: " << rank << ", " << pjk << std::endl; - //std::cout << "Print 198 pjk[0]: " << rank << ", " << pjk[0] << std::endl; break; } } } - //std::cout << "Print: " << __LINE__ << std::endl; std::vector distances = {r_ij,r_ik,r_jk}; auto maxElement = std::max_element(distances.begin(), distances.end()); double maxValue = *maxElement; @@ -256,9 +234,7 @@ void FixMDRmeanSurfDisp::pre_force(int) const double eny_ik = dely_ik * rinv_ik; const double enz_ik = delz_ik * rinv_ik; const double alpha = std::acos(enx_ij*enx_ik + eny_ij*eny_ik + enz_ij*enz_ik); - //std::cout << "Print: " << __LINE__ << std::endl; pjk[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/MY_PI - 1.0/2.0)) ); - //std::cout << "Print: " << __LINE__ << std::endl; } } } @@ -334,8 +310,6 @@ void FixMDRmeanSurfDisp::pre_force(int) history = &allhistory[size_history * jj]; model->history = history; - //const double pij = history[22]; - //const double wij = std::max(1.0-pij,0.0); const double delta = model->radsum - sqrt(model->rsq); const int delta_offset_0 = 0; // apparent overlap @@ -365,18 +339,6 @@ void FixMDRmeanSurfDisp::pre_force(int) i1 = i; } - int rank = 0; - MPI_Comm_rank(MPI_COMM_WORLD, &rank); - int i_ghost; - int j_ghost; - (i >= atom->nlocal) ? i_ghost = 1 : i_ghost = 0; - (j >= atom->nlocal) ? j_ghost = 1 : j_ghost = 0; - if (i_ghost == 1) { - std::cout << "rank: " << rank << ", i: " << i << ", j: " << j << ", i is ghost? " << i_ghost << ", j is ghost? " << j_ghost << ", nlocal: " << atom->nlocal << ", itag: " << atom->tag[i] << ", jtag: " << atom->tag[j] << std::endl; - } - - //int i0 = std::max(i,j); - //int i1 = std::min(i,j); double R0 = radius[i0]; double R1 = radius[i1]; @@ -407,32 +369,13 @@ void FixMDRmeanSurfDisp::pre_force(int) if (Acon0[i0] != 0.0) { const double Ac_offset0 = history[Ac_offset_0]; - ddelta_bar[i0] += Ac_offset0/Acon0[i0]*ddel0; // Multiply by 0.5 since displacement is shared equally between deformable particles. + ddelta_bar[i0] += Ac_offset0/Acon0[i0]*ddel0; } if (Acon0[i1] != 0.0) { const double Ac_offset1 = history[Ac_offset_1]; ddelta_bar[i1] += Ac_offset1/Acon0[i1]*ddel1; } - - //int rank = 0; - //MPI_Comm_rank(MPI_COMM_WORLD, &rank); - //std::cout << "delta_bar calc: Step: " << lmp->update->ntimestep << ", itag: " << atom->tag[i] << ", jtag: " << atom->tag[j] << ", i: " << i << ", j: " << j << ", rank: " << rank << ", Ac_offset0: " << history[Ac_offset_0] << ", Ac_offset1: " << history[Ac_offset_1] << ", Acon[i0]: " << Acon0[i0] << ", Acon[i1]: " << Acon0[i1] << ", ddel0: " << ddel0 << ", ddel1: " << ddel1 << ", ddelta_bar[i0]: " << ddelta_bar[i0] << ", ddelta_bar[i1]: " << ddelta_bar[i1] << std::endl; - - //if (Acon0[j] != 0.0) { - // const double delta_offset0 = history[0]; - // const double ddelta = delta/2.0 - delta_offset0; // Divide by 2.0 since we are storing 1/2 deltan in main MDR script - // const double Ac_offset0 = history[18]; - // ddelta_bar[j] += Ac_offset0/Acon0[j]*ddelta; // Multiply by 0.5 since displacement is shared equally between deformable particles. - //} -// - //if (Acon0[i] != 0.0) { - // const double delta_offset1 = history[1]; - // const double ddelta = delta/2.0 - delta_offset1; // Divide by 2.0 since we are storing 1/2 deltan in main MDR script - // const double Ac_offset1 = history[19]; - // ddelta_bar[i] += Ac_offset1/Acon0[i]*ddelta; - //} - } } } @@ -515,27 +458,11 @@ void FixMDRmeanSurfDisp::pre_force(int) const double delta_offset0 = fix->history_many[i][fix->c2r[ic]][0]; const double ddelta = delta - delta_offset0; const double Ac_offset0 = fix->history_many[i][fix->c2r[ic]][18]; - ddelta_bar[i] += wij*Ac_offset0/Acon0[i]*ddelta; // Multiply by 0.5 since displacement is shared equally between deformable particles. - //std::cout << delta << ", " << delta_offset0 << " || " << Ac_offset0 << ", " << Acon0[i] << ", " << ddelta << ", " << ddelta_bar[i] << std::endl; + ddelta_bar[i] += wij*Ac_offset0/Acon0[i]*ddelta; } } } } } - comm->forward_comm(this); - -//and the function delcarations in the header: - -//int pack_forward_comm(int, int *, double *, int, int *) override; -//void unpack_forward_comm(int, int, double *) override; - -//Then the methods would look like:: - -//where comm_stage is a public flag to control hich quantity is being communicated - } - -//std::cout << radius[i] << ", " << dR << ", " << dRnumerator[i] << ", " << dRdenominator[i] << ", " << dRdenominator[i] - 4.0*MY_PI*pow(R,2.0) << std::endl; -//std::cout << "Fix radius update setup has been entered !!!" << std::endl; -//std::cout << Ro[0] << ", " << Vgeo[0] << ", " << Velas[0] << std::endl; diff --git a/src/fix_mdr_radius_update.cpp b/src/fix_mdr_radius_update.cpp index 36ada70f55..7ff883a0cf 100644 --- a/src/fix_mdr_radius_update.cpp +++ b/src/fix_mdr_radius_update.cpp @@ -1,4 +1,3 @@ -// clang-format off /* ---------------------------------------------------------------------- LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator https://www.lammps.org/, Sandia National Laboratories @@ -28,14 +27,12 @@ #include "memory.h" #include "modify.h" #include "variable.h" -#include "csv_writer.h" #include "granular_model.h" #include "pair_granular.h" #include "pair.h" #include "gran_sub_mod_normal.h" #include "update.h" #include "comm.h" -#include #include #include @@ -52,8 +49,6 @@ FixMDRradiusUpdate::FixMDRradiusUpdate(LAMMPS *lmp, int narg, char **arg) : comm_forward = 20; // value needs to match number of values you communicate } -// FOR MDR - int FixMDRradiusUpdate::setmask() { int mask = 0; @@ -167,43 +162,10 @@ void FixMDRradiusUpdate::pre_force(int) if (model->normal_model->name == "mdr") norm_model = dynamic_cast(model->normal_model); } if (norm_model == nullptr) error->all(FLERR, "Did not find mdr model"); - //model = models_list[0]; - //class GranSubModNormalMDR* norm_model = dynamic_cast(model->normal_model); - - //std::cout << "Preforce was called radius update" << std::endl; - - // assign correct value to initially non-zero MDR particle history variables - //int tmp1, tmp2; - //int index_Ro = atom->find_custom("Ro",tmp1,tmp2); - //int index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); - //int index_Velas = atom->find_custom("Velas",tmp1,tmp2); - //int index_Atot = atom->find_custom("Atot",tmp1,tmp2); - //int index_psi = atom->find_custom("psi",tmp1,tmp2); - //int index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); - //int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); - //int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); - //int index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); - //int index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); - //int index_contacts = atom->find_custom("contacts",tmp1,tmp2); - //int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); - //double * Ro = atom->dvector[index_Ro]; - //double * Vgeo = atom->dvector[index_Vgeo]; - //double * Velas = atom->dvector[index_Velas]; - //double * Atot = atom->dvector[index_Atot]; - //double * psi = atom->dvector[index_psi]; - //double * psi_b = atom->dvector[index_psi_b]; - //double * sigmaxx = atom->dvector[index_sigmaxx]; - //double * sigmayy = atom->dvector[index_sigmayy]; - //double * sigmazz = atom->dvector[index_sigmazz]; - //double * history_setup_flag = atom->dvector[index_history_setup_flag]; - //double * contacts = atom->dvector[index_contacts]; - //double * adhesive_length = atom->dvector[index_adhesive_length]; double *radius = atom->radius; int nlocal = atom->nlocal; - //std::cout << "ntotal " << ntotal << ", nlocal " << atom->nlocal << ", nghost " << atom->nghost << std::endl; - for (int i = 0; i < nlocal; i++) { if (history_setup_flag[i] < 1e-16) { Ro[i] = radius[i]; @@ -220,9 +182,7 @@ void FixMDRradiusUpdate::pre_force(int) contacts[i] = 0.0; adhesive_length[i] = 0.0; } - comm->forward_comm(this); - } int FixMDRradiusUpdate::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/,int * /*pbc*/) @@ -284,21 +244,9 @@ void FixMDRradiusUpdate::unpack_forward_comm(int n, int first, double *buf) void FixMDRradiusUpdate::end_of_step() { - - //comm->forward_comm(this); - - //std::cout << "end_of_step() was called radius update" << std::endl; - // update the apparent radius of every particle - double *radius = atom->radius; int nlocal = atom->nlocal; - double sigmaxx_sum = 0.0; - double sigmayy_sum = 0.0; - double sigmazz_sum = 0.0; - double Vparticles = 0.0; - - //std::cout << "New step" << std::endl; for (int i = 0; i < nlocal; i++) { @@ -308,32 +256,15 @@ void FixMDRradiusUpdate::end_of_step() const double Vo = 4.0/3.0*MY_PI*pow(Ro[i],3.0); const double Vgeoi = 4.0/3.0*MY_PI*pow(R,3.0) - Vcaps[i]; Vgeo[i] = std::min(Vgeoi,Vo); - //(Vgeoi < Vo) ? Vgeo[i] = Vgeoi : Vgeo[i] = Vo; const double Afree = Atot[i] - Acon1[i]; psi[i] = Afree/Atot[i]; - //if (psi[i] < 0.08) { - // std::cout << "psi is: " << psi[i] << std::endl; - //} - const double dR = std::max(dRnumerator[i]/(dRdenominator[i] - 4.0*MY_PI*pow(R,2.0)),0.0); if (psi_b[i] < psi[i]) { if ((radius[i] + dR) < (1.5*Ro[i])) radius[i] += dR; - //radius[i] += dR; } - //if (dR > 1e-7) { - // std::cout << "big dR change" << std::endl; - //} - //if (atom->tag[i] == 9){ - // std::cout << i << ", radius: " << radius[i] << ", dR: " << dR << ", dRnum: " << dRnumerator[i] << ", dRdenom " << dRdenominator[i] << ", dRdem_full " << dRdenominator[i] - 4.0*MY_PI*pow(R,2.0) << std::endl; - //} - - - //std::cout << i << ", " << radius[i] << " | " << psi_b[i] << ", " << psi[i] << " | " << Acon1[i] << ", " << Atot[i] << std::endl; - - Velas[i] = Vo*(1.0 + eps_bar[i]); Vcaps[i] = 0.0; eps_bar[i] = 0.0; @@ -341,46 +272,8 @@ void FixMDRradiusUpdate::end_of_step() dRdenominator[i] = 0.0; Acon0[i] = Acon1[i]; Acon1[i] = 0.0; - //std::cout << "Acon reset: " << Acon0[i] << ", " << Acon1[i] << std::endl; Atot_sum[i] = 0.0; ddelta_bar[i] = 0.0; - //adhesive_length[i] = adhesive_length[i]/contacts[i]; // convert adhesive length to average aAdh for each particle - - - //if (lmp->update->ntimestep == 487500) { - // double **x = atom->x; - // CSVWriter csvWriter("/Users/willzunker/lammps_mdr_develop/sims/avicelTableting/atom_stresses_at_mid_compression.csv"); - // std::stringstream rowDataStream; - // rowDataStream << std::scientific << std::setprecision(4); // Set the format and precision - // rowDataStream << sigmaxx[i] << ", " << sigmayy[i] << ", " << sigmazz[i] << ", " << Velas[i] << ", " << x[i][2]; - // std::string rowData = rowDataStream.str(); - // csvWriter.writeRow(rowData); - //} -// - //if (lmp->update->ntimestep == 595750) { - // double **x = atom->x; - // CSVWriter csvWriter("/Users/willzunker/lammps_mdr_develop/sims/avicelTableting/atom_stresses_at_max_compression.csv"); - // std::stringstream rowDataStream; - // rowDataStream << std::scientific << std::setprecision(4); // Set the format and precision - // rowDataStream << sigmaxx[i] << ", " << sigmayy[i] << ", " << sigmazz[i] << ", " << Velas[i] << ", " << x[i][2]; - // std::string rowData = rowDataStream.str(); - // csvWriter.writeRow(rowData); - //} - - - //sigmaxx_sum += sigmaxx[i]; - //sigmayy_sum += sigmayy[i]; - //sigmazz_sum += sigmazz[i]; - //Vparticles += Velas[i]; } - - //double sigmaxx_avg = sigmaxx_sum/nlocal; - //double sigmayy_avg = sigmayy_sum/nlocal; - //double sigmazz_avg = sigmazz_sum/nlocal; - comm->forward_comm(this); } - -//std::cout << radius[i] << ", " << dR << ", " << dRnumerator[i] << ", " << dRdenominator[i] << ", " << dRdenominator[i] - 4.0*MY_PI*pow(R,2.0) << std::endl; -//std::cout << "Fix radius update setup has been entered !!!" << std::endl; -//std::cout << Ro[0] << ", " << Vgeo[0] << ", " << Velas[0] << std::endl; From 6fe5f373d958dd9eaf42a836612ea43d947e2396 Mon Sep 17 00:00:00 2001 From: William Zunker Date: Tue, 17 Dec 2024 11:24:32 -0500 Subject: [PATCH 08/74] cleaned up remaining comments in pair_granular --- src/GRANULAR/pair_granular.cpp | 12 ------------ 1 file changed, 12 deletions(-) diff --git a/src/GRANULAR/pair_granular.cpp b/src/GRANULAR/pair_granular.cpp index aee341aef1..a131635e24 100644 --- a/src/GRANULAR/pair_granular.cpp +++ b/src/GRANULAR/pair_granular.cpp @@ -198,8 +198,6 @@ void PairGranular::compute(int eflag, int vflag) jtype = type[j]; model = models_list[types_indices[itype][jtype]]; - //std::cout << "Pair Granular: " << i << ", " << j << std::endl; - // Reset model and copy initial geometric data model->xi = x[i]; model->xj = x[j]; @@ -210,16 +208,6 @@ void PairGranular::compute(int eflag, int vflag) model->itype = itype; model->jtype = jtype; - /* - if (radius[i] < 0.00065 || radius[j] < 0.00065) { - std::cout << "Pair Granular: " << i << ", " << j << " || " << radius[i] << ", " << radius[j] << std::endl; - } - - if (std::isnan(radius[i]) || std::isnan(radius[j])) { - std::cout << "Pair Granular: " << i << ", " << j << " || " << radius[i] << ", " << radius[j] << std::endl; - } - */ - if (use_history) model->touch = touch[jj]; touchflag = model->check_contact(); From 9732efa32c6a9b144f535d36aab2a1f05cee93e0 Mon Sep 17 00:00:00 2001 From: Sachith Dunatunga Date: Tue, 17 Dec 2024 08:31:29 -0800 Subject: [PATCH 09/74] fix whitespace --- src/GRANULAR/fix_wall_gran.h | 4 ++-- src/GRANULAR/fix_wall_gran_region.cpp | 4 ++-- src/GRANULAR/fix_wall_gran_region.h | 4 ++-- src/GRANULAR/gran_sub_mod_normal.cpp | 8 ++++---- src/fix_mdr_mean_surf_disp.cpp | 6 +++--- 5 files changed, 13 insertions(+), 13 deletions(-) diff --git a/src/GRANULAR/fix_wall_gran.h b/src/GRANULAR/fix_wall_gran.h index e62ab4e38e..8964870b9f 100644 --- a/src/GRANULAR/fix_wall_gran.h +++ b/src/GRANULAR/fix_wall_gran.h @@ -51,8 +51,8 @@ class FixWallGran : public Fix { void reset_dt() override; // for granular model choices - class Granular_NS::GranularModel *model; - void clear_stored_contacts(); + class Granular_NS::GranularModel *model; + void clear_stored_contacts(); protected: int wallstyle, wiggle, wshear, axis; diff --git a/src/GRANULAR/fix_wall_gran_region.cpp b/src/GRANULAR/fix_wall_gran_region.cpp index cc1ac3e04b..c0c7dd1dcb 100644 --- a/src/GRANULAR/fix_wall_gran_region.cpp +++ b/src/GRANULAR/fix_wall_gran_region.cpp @@ -228,8 +228,8 @@ void FixWallGranRegion::post_force(int /*vflag*/) model->radi = radius[i]; model->radj = region->contact[ic].radius; model->r = region->contact[ic].r; - model->i = i; - model->j = ic; + model->i = i; + model->j = ic; if (model->beyond_contact) model->touch = history_many[i][c2r[ic]][0]; diff --git a/src/GRANULAR/fix_wall_gran_region.h b/src/GRANULAR/fix_wall_gran_region.h index 50cd3236b5..3f6fe453f0 100644 --- a/src/GRANULAR/fix_wall_gran_region.h +++ b/src/GRANULAR/fix_wall_gran_region.h @@ -44,8 +44,8 @@ class FixWallGranRegion : public FixWallGran { int size_restart(int) override; int maxsize_restart() override; - class Region *region; - void update_contacts(int, int); + class Region *region; + void update_contacts(int, int); int tmax; // max # of region walls one particle can touch int *ncontact; // # of shear contacts per particle int **walls; // which wall each contact is with diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 36bbd18982..e43e662834 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -410,7 +410,7 @@ GranSubModNormalMDR::GranSubModNormalMDR(GranularModel *gm, LAMMPS *lmp) : GranSubModNormal(gm, lmp) { if (lmp->citeme) lmp->citeme->add(cite_mdr); - + num_coeffs = 6; // Young's Modulus, Poisson's ratio, yield stress, effective surface energy, psi_b, coefficent of restitution contact_radius_flag = 1; size_history = 26; @@ -453,7 +453,7 @@ double GranSubModNormalMDR::calculate_forces() // The MDR contact model was developed by imagining individual particles being // squished between a number of rigid flats (references below). To allow // for many interacting particles, we extend the idea of isolated particles surrounded - // by rigid flats. In particular, we imagine placing rigid flats at the overlaps + // by rigid flats. In particular, we imagine placing rigid flats at the overlaps // between particles. The force is calculated seperately on both sides // of the contact assuming interaction with a rigid flat. The two forces are then // averaged on either side of the contact to determine the final force. If the @@ -461,7 +461,7 @@ double GranSubModNormalMDR::calculate_forces() // // Zunker and Kamrin, 2024, Part I: https://doi.org/10.1016/j.jmps.2023.105492 // Zunker and Kamrin, 2024, Part II: https://doi.org/10.1016/j.jmps.2023.105493 - // Zunker, Dunatunga, Thakur, Tang, and Kamrin, 2025: + // Zunker, Dunatunga, Thakur, Tang, and Kamrin, 2025: const int itag_true = atom->tag[gm->i]; // true i particle tag const int jtag_true = atom->tag[gm->j]; // true j particle tag @@ -861,7 +861,7 @@ double GranSubModNormalMDR::calculate_forces() const double eps_bar_contact = (1.0/(3*kappa*Velas[i]))*(fx*bx + fy*by + fz*bz); eps_bar[i] += eps_bar_contact; - double desp_bar_contact = eps_bar_contact - *eps_bar_offset; + double desp_bar_contact = eps_bar_contact - *eps_bar_offset; if(delta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0){ const double Vo = (4.0/3.0)*MY_PI*pow(Ro,3.0); dRnumerator[i] += -Vo*(eps_bar_contact - *eps_bar_offset) - wij*MY_PI*ddeltao*( 2.0*deltao*Ro - pow(deltao,2.0) + pow(R,2.0) - pow(Ro,2.0) ); diff --git a/src/fix_mdr_mean_surf_disp.cpp b/src/fix_mdr_mean_surf_disp.cpp index 324f9fbd1b..89d94514fa 100644 --- a/src/fix_mdr_mean_surf_disp.cpp +++ b/src/fix_mdr_mean_surf_disp.cpp @@ -173,7 +173,7 @@ void FixMDRmeanSurfDisp::pre_force(int) history_ik = &allhistory[size_history * kk]; double * pik = &history_ik[22]; // penalty for contact i and k - // we don't know if who owns the contact ahead of time, k might be in j's neigbor list or vice versa, + // we don't know if who owns the contact ahead of time, k might be in j's neigbor list or vice versa, // so we need to manually search to figure out the owner check if k is in the neighbor list of j double * pjk = NULL; int * const jklist = firstneigh[j]; @@ -369,7 +369,7 @@ void FixMDRmeanSurfDisp::pre_force(int) if (Acon0[i0] != 0.0) { const double Ac_offset0 = history[Ac_offset_0]; - ddelta_bar[i0] += Ac_offset0/Acon0[i0]*ddel0; + ddelta_bar[i0] += Ac_offset0/Acon0[i0]*ddel0; } if (Acon0[i1] != 0.0) { @@ -458,7 +458,7 @@ void FixMDRmeanSurfDisp::pre_force(int) const double delta_offset0 = fix->history_many[i][fix->c2r[ic]][0]; const double ddelta = delta - delta_offset0; const double Ac_offset0 = fix->history_many[i][fix->c2r[ic]][18]; - ddelta_bar[i] += wij*Ac_offset0/Acon0[i]*ddelta; + ddelta_bar[i] += wij*Ac_offset0/Acon0[i]*ddelta; } } } From 1ba8ec4a0a341f1e92f78a33370460b2b2c61f45 Mon Sep 17 00:00:00 2001 From: William Zunker Date: Tue, 17 Dec 2024 18:56:59 -0500 Subject: [PATCH 10/74] fixed adhesion in elastic limit by updating amax assignment --- src/GRANULAR/gran_sub_mod_normal.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index e43e662834..43e77b1c4e 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -730,7 +730,7 @@ double GranSubModNormalMDR::calculate_forces() A = 4.0*R; B = 2.0*R; deltae1D = delta_MDR; - (deltae1D > 0) ? amax = sqrt(deltae1D*R) : amax = 0.0; + amax = sqrt(deltamax_MDR*R); } else { // plastic contact amax = sqrt((2.0*deltamax_MDR*R - pow(deltamax_MDR,2.0)) + cA/MY_PI); A = 4.0*pY/Eeff*amax; From 61734a414c6cba8a911d471650aba5a286641c91 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Tue, 17 Dec 2024 18:40:48 -0700 Subject: [PATCH 11/74] Remove unused includes --- src/GRANULAR/pair_granular.cpp | 4 +--- 1 file changed, 1 insertion(+), 3 deletions(-) diff --git a/src/GRANULAR/pair_granular.cpp b/src/GRANULAR/pair_granular.cpp index a131635e24..b524488fde 100644 --- a/src/GRANULAR/pair_granular.cpp +++ b/src/GRANULAR/pair_granular.cpp @@ -32,11 +32,9 @@ #include "math_extra.h" #include "memory.h" #include "modify.h" -#include "group.h" #include "neigh_list.h" #include "neighbor.h" #include "update.h" -#include "gran_sub_mod_normal.h" #include @@ -477,7 +475,7 @@ void PairGranular::init_style() if (!fix_history) error->all(FLERR,"Could not find pair fix neigh history ID"); } - if (model->normal_model->name == "mdr") { + if (model->sub_models[NORMAL]->name == "mdr") { //Store persistent per atom quantities if (! fix_flag) { int tmp1, tmp2; From ab6e3f6015faad680e0dca3d01a0af89eb50802b Mon Sep 17 00:00:00 2001 From: jtclemm Date: Wed, 18 Dec 2024 12:58:37 -0700 Subject: [PATCH 12/74] Combining fixes --- src/.gitignore | 2 + .../fix_granular_mdr.cpp} | 278 +++++++++++++++-- .../fix_granular_mdr.h} | 13 +- src/GRANULAR/pair_granular.cpp | 3 +- src/fix_mdr_mean_surf_disp.h | 46 --- src/fix_mdr_radius_update.cpp | 279 ------------------ 6 files changed, 261 insertions(+), 360 deletions(-) rename src/{fix_mdr_mean_surf_disp.cpp => GRANULAR/fix_granular_mdr.cpp} (62%) rename src/{fix_mdr_radius_update.h => GRANULAR/fix_granular_mdr.h} (85%) delete mode 100644 src/fix_mdr_mean_surf_disp.h delete mode 100644 src/fix_mdr_radius_update.cpp diff --git a/src/.gitignore b/src/.gitignore index f0554e3bfe..487bb22007 100644 --- a/src/.gitignore +++ b/src/.gitignore @@ -845,6 +845,8 @@ /fix_ffl.h /fix_filter_corotate.cpp /fix_filter_corotate.h +/fix_granular_mdr.cpp +/fix_granular_mdr.h /fix_viscosity.cpp /fix_viscosity.h /fix_ehex.cpp diff --git a/src/fix_mdr_mean_surf_disp.cpp b/src/GRANULAR/fix_granular_mdr.cpp similarity index 62% rename from src/fix_mdr_mean_surf_disp.cpp rename to src/GRANULAR/fix_granular_mdr.cpp index 89d94514fa..3f955d8906 100644 --- a/src/fix_mdr_mean_surf_disp.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -17,78 +17,189 @@ Dan Bolintineanu (SNL), Joel Clemmer (SNL) ----------------------------------------------------------------------- */ -#include "fix_mdr_mean_surf_disp.h" +#include "fix_granular_mdr.h" #include "atom.h" +#include "comm.h" #include "error.h" +#include "fix_wall_gran_region.h" +#include "fix_neigh_history.h" #include "force.h" +#include "granular_model.h" +#include "gran_sub_mod_normal.h" #include "input.h" #include "math_const.h" #include "memory.h" #include "modify.h" -#include "variable.h" -#include "fix_neigh_history.h" +#include "neigh_list.h" #include "pair.h" #include "pair_granular.h" -#include "granular_model.h" -#include "neigh_list.h" #include "region.h" #include "update.h" -#include "fix_wall_gran_region.h" -#include "comm.h" +#include "variable.h" + #include +#include +#include using namespace LAMMPS_NS; -using namespace FixConst; using namespace Granular_NS; +using namespace FixConst; using MathConst::MY_PI; +enum {MEAN_SURF_DISP, RADIUS_UPDATE}; + /* ---------------------------------------------------------------------- */ -FixMDRmeanSurfDisp::FixMDRmeanSurfDisp(LAMMPS *lmp, int narg, char **arg) : +FixGranularMDR::FixGranularMDR(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) { - comm_forward = 1; // value needs to match number of values you communicate + comm_forward = 20; // value needs to match number of values you communicate } -int FixMDRmeanSurfDisp::setmask() +int FixGranularMDR::setmask() { int mask = 0; - mask |= PRE_FORCE; + mask |= PRE_FORCE | END_OF_STEP; return mask; } -void FixMDRmeanSurfDisp::setup_pre_force(int /*vflag*/) +void FixGranularMDR::setup_pre_force(int /*vflag*/) { int tmp1, tmp2; + int index_Ro = atom->find_custom("Ro",tmp1,tmp2); + int index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); + int index_Velas = atom->find_custom("Velas",tmp1,tmp2); + int index_Vcaps = atom->find_custom("Vcaps",tmp1,tmp2); + int index_eps_bar = atom->find_custom("eps_bar",tmp1,tmp2); + int index_dRnumerator = atom->find_custom("dRnumerator",tmp1,tmp2); + int index_dRdenominator = atom->find_custom("dRdenominator",tmp1,tmp2); int index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); + int index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); + int index_Atot = atom->find_custom("Atot",tmp1,tmp2); + int index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); int index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); + int index_psi = atom->find_custom("psi",tmp1,tmp2); + int index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); + int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); + int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); + int index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); + int index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); + int index_contacts = atom->find_custom("contacts",tmp1,tmp2); + int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); + Ro = atom->dvector[index_Ro]; + Vgeo = atom->dvector[index_Vgeo]; + Velas = atom->dvector[index_Velas]; + Vcaps = atom->dvector[index_Vcaps]; + eps_bar = atom->dvector[index_eps_bar]; + dRnumerator = atom->dvector[index_dRnumerator]; + dRdenominator = atom->dvector[index_dRdenominator]; Acon0 = atom->dvector[index_Acon0]; + Acon1 = atom->dvector[index_Acon1]; + Atot = atom->dvector[index_Atot]; + Atot_sum = atom->dvector[index_Atot_sum]; ddelta_bar = atom->dvector[index_ddelta_bar]; + psi = atom->dvector[index_psi]; + psi_b = atom->dvector[index_psi_b]; + sigmaxx = atom->dvector[index_sigmaxx]; + sigmayy = atom->dvector[index_sigmayy]; + sigmazz = atom->dvector[index_sigmazz]; + history_setup_flag = atom->dvector[index_history_setup_flag]; + contacts = atom->dvector[index_contacts]; + adhesive_length = atom->dvector[index_adhesive_length]; pre_force(0); } -int FixMDRmeanSurfDisp::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/,int * /*pbc*/) +void FixGranularMDR::setup(int /*vflag*/) { - int m = 0; - for (int i = 0; i < n; i++) { - int j = list[i]; - buf[m++] = ddelta_bar[j]; - } - return m; + int tmp1, tmp2; + int index_Ro = atom->find_custom("Ro",tmp1,tmp2); + int index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); + int index_Velas = atom->find_custom("Velas",tmp1,tmp2); + int index_Vcaps = atom->find_custom("Vcaps",tmp1,tmp2); + int index_eps_bar = atom->find_custom("eps_bar",tmp1,tmp2); + int index_dRnumerator = atom->find_custom("dRnumerator",tmp1,tmp2); + int index_dRdenominator = atom->find_custom("dRdenominator",tmp1,tmp2); + int index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); + int index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); + int index_Atot = atom->find_custom("Atot",tmp1,tmp2); + int index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); + int index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); + int index_psi = atom->find_custom("psi",tmp1,tmp2); + int index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); + int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); + int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); + int index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); + int index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); + int index_contacts = atom->find_custom("contacts",tmp1,tmp2); + int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); + Ro = atom->dvector[index_Ro]; + Vgeo = atom->dvector[index_Vgeo]; + Velas = atom->dvector[index_Velas]; + Vcaps = atom->dvector[index_Vcaps]; + eps_bar = atom->dvector[index_eps_bar]; + dRnumerator = atom->dvector[index_dRnumerator]; + dRdenominator = atom->dvector[index_dRdenominator]; + Acon0 = atom->dvector[index_Acon0]; + Acon1 = atom->dvector[index_Acon1]; + Atot = atom->dvector[index_Atot]; + Atot_sum = atom->dvector[index_Atot_sum]; + ddelta_bar = atom->dvector[index_ddelta_bar]; + psi = atom->dvector[index_psi]; + psi_b = atom->dvector[index_psi_b]; + sigmaxx = atom->dvector[index_sigmaxx]; + sigmayy = atom->dvector[index_sigmayy]; + sigmazz = atom->dvector[index_sigmazz]; + history_setup_flag = atom->dvector[index_history_setup_flag]; + contacts = atom->dvector[index_contacts]; + adhesive_length = atom->dvector[index_adhesive_length]; + + end_of_step(); } -void FixMDRmeanSurfDisp::unpack_forward_comm(int n, int first, double *buf) +void FixGranularMDR::pre_force(int) { - int m = 0; - int last = first + n; - for (int i = first; i < last; i++) { - ddelta_bar[i] = buf[m++]; - } + radius_update(); + mean_surf_disp(); } -void FixMDRmeanSurfDisp::pre_force(int) +void FixGranularMDR::radius_update() +{ + PairGranular * pair = dynamic_cast(force->pair_match("granular",1)); + class GranularModel* model; + class GranularModel** models_list = pair->models_list; + class GranSubModNormalMDR* norm_model = nullptr; + for (int i = 0; i < pair->nmodels; i++) { + model = models_list[i]; + if (model->normal_model->name == "mdr") norm_model = dynamic_cast(model->normal_model); + } + if (norm_model == nullptr) error->all(FLERR, "Did not find mdr model"); + + double *radius = atom->radius; + int nlocal = atom->nlocal; + + for (int i = 0; i < nlocal; i++) { + if (history_setup_flag[i] < 1e-16) { + Ro[i] = radius[i]; + Vgeo[i] = 4.0/3.0*MY_PI*pow(Ro[i],3.0); + Velas[i] = 4.0/3.0*MY_PI*pow(Ro[i],3.0); + Atot[i] = 4.0*MY_PI*pow(Ro[i],2.0); + psi[i] = 1.0; + psi_b[i] = norm_model->psi_b; + history_setup_flag[i] = 1.0; + } + sigmaxx[i] = 0.0; + sigmayy[i] = 0.0; + sigmazz[i] = 0.0; + contacts[i] = 0.0; + adhesive_length[i] = 0.0; + } + comm_stage = RADIUS_UPDATE; + comm->forward_comm(this, 20); +} + +void FixGranularMDR::mean_surf_disp() { FixNeighHistory * fix_history = dynamic_cast(modify->get_fix_by_id("NEIGH_HISTORY_GRANULAR")); PairGranular * pair = dynamic_cast(force->pair_match("granular",1)); @@ -464,5 +575,116 @@ void FixMDRmeanSurfDisp::pre_force(int) } } } - comm->forward_comm(this); + + comm_stage = MEAN_SURF_DISP; + comm->forward_comm(this, 1); +} + + +int FixGranularMDR::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/,int * /*pbc*/) +{ + int m = 0; + if (comm_stage == RADIUS_UPDATE) { + for (int i = 0; i < n; i++) { + int j = list[i]; + buf[m++] = Ro[j]; // 1 + buf[m++] = Vgeo[j]; // 2 + buf[m++] = Velas[j]; // 3 + buf[m++] = Vcaps[j]; // 4 + buf[m++] = eps_bar[j]; // 5 + buf[m++] = dRnumerator[j]; // 6 + buf[m++] = dRdenominator[j]; // 7 + buf[m++] = Acon0[j]; // 8 + buf[m++] = Acon1[j]; // 9 + buf[m++] = Atot[j]; // 10 + buf[m++] = Atot_sum[j]; // 11 + buf[m++] = ddelta_bar[j]; // 12 + buf[m++] = psi[j]; // 13 + buf[m++] = psi_b[j]; // 14 + buf[m++] = sigmaxx[j]; // 15 + buf[m++] = sigmayy[j]; // 16 + buf[m++] = sigmazz[j]; // 17 + buf[m++] = history_setup_flag[j]; // 18 + buf[m++] = contacts[j]; // 19 + buf[m++] = adhesive_length[j]; // 20 + } + } else { + for (int i = 0; i < n; i++) { + int j = list[i]; + buf[m++] = ddelta_bar[j]; + } + } + return m; +} + +void FixGranularMDR::unpack_forward_comm(int n, int first, double *buf) +{ + int m = 0; + int last = first + n; + + if (comm_stage == RADIUS_UPDATE) { + for (int i = first; i < last; i++) { + Ro[i] = buf[m++]; // 1 + Vgeo[i] = buf[m++]; // 2 + Velas[i] = buf[m++]; // 3 + Vcaps[i] = buf[m++]; // 4 + eps_bar[i] = buf[m++]; // 5 + dRnumerator[i] = buf[m++]; // 6 + dRdenominator[i] = buf[m++]; // 7 + Acon0[i] = buf[m++]; // 8 + Acon1[i] = buf[m++]; // 9 + Atot[i] = buf[m++]; // 10 + Atot_sum[i] = buf[m++]; // 11 + ddelta_bar[i] = buf[m++]; // 12 + psi[i] = buf[m++]; // 13 + psi_b[i] = buf[m++]; // 14 + sigmaxx[i] = buf[m++]; // 15 + sigmayy[i] = buf[m++]; // 16 + sigmazz[i] = buf[m++]; // 17 + history_setup_flag[i] = buf[m++]; // 18 + contacts[i] = buf[m++]; // 19 + adhesive_length[i] = buf[m++]; // 20 + } + } else { + for (int i = first; i < last; i++) { + ddelta_bar[i] = buf[m++]; + } + } +} + +void FixGranularMDR::end_of_step() +{ + // update the apparent radius of every particle + double *radius = atom->radius; + int nlocal = atom->nlocal; + + for (int i = 0; i < nlocal; i++) { + + const double R = radius[i]; + Atot[i] = 4.0*MY_PI*pow(R,2.0) + Atot_sum[i]; + + const double Vo = 4.0/3.0*MY_PI*pow(Ro[i],3.0); + const double Vgeoi = 4.0/3.0*MY_PI*pow(R,3.0) - Vcaps[i]; + Vgeo[i] = std::min(Vgeoi,Vo); + + const double Afree = Atot[i] - Acon1[i]; + psi[i] = Afree/Atot[i]; + + const double dR = std::max(dRnumerator[i]/(dRdenominator[i] - 4.0*MY_PI*pow(R,2.0)),0.0); + if (psi_b[i] < psi[i]) { + if ((radius[i] + dR) < (1.5*Ro[i])) radius[i] += dR; + } + + Velas[i] = Vo*(1.0 + eps_bar[i]); + Vcaps[i] = 0.0; + eps_bar[i] = 0.0; + dRnumerator[i] = 0.0; + dRdenominator[i] = 0.0; + Acon0[i] = Acon1[i]; + Acon1[i] = 0.0; + Atot_sum[i] = 0.0; + ddelta_bar[i] = 0.0; + } + comm_stage = RADIUS_UPDATE; + comm->forward_comm(this, 20); } diff --git a/src/fix_mdr_radius_update.h b/src/GRANULAR/fix_granular_mdr.h similarity index 85% rename from src/fix_mdr_radius_update.h rename to src/GRANULAR/fix_granular_mdr.h index f431c0d13d..78c34b1b99 100644 --- a/src/fix_mdr_radius_update.h +++ b/src/GRANULAR/fix_granular_mdr.h @@ -13,18 +13,18 @@ #ifdef FIX_CLASS // clang-format off -FixStyle(mdr/radius/update,FixMDRradiusUpdate); +FixStyle(GRANULAR/MDR,FixGranularMDR); // clang-format on #else -#ifndef LMP_FIX_MDR_RADIUS_UPDATE_H -#define LMP_FIX_MDR_RADIUS_UPDATE_H +#ifndef LMP_FIX_GRANULAR_MDR_H +#define LMP_FIX_GRANULAR_MDR_H #include "fix.h" namespace LAMMPS_NS { -class FixMDRradiusUpdate : public Fix { +class FixGranularMDR : public Fix { public: double * Ro; double * Vgeo; @@ -47,7 +47,7 @@ class FixMDRradiusUpdate : public Fix { double * contacts; double * adhesive_length; - FixMDRradiusUpdate(class LAMMPS *, int, char **); + FixGranularMDR(class LAMMPS *, int, char **); int setmask() override; void setup(int) override; void setup_pre_force(int) override; @@ -57,7 +57,10 @@ class FixMDRradiusUpdate : public Fix { void unpack_forward_comm(int, int, double *) override; private: + int comm_stage; + void radius_update(); + void mean_surf_disp(); }; } // namespace LAMMPS_NS diff --git a/src/GRANULAR/pair_granular.cpp b/src/GRANULAR/pair_granular.cpp index b524488fde..23522608c8 100644 --- a/src/GRANULAR/pair_granular.cpp +++ b/src/GRANULAR/pair_granular.cpp @@ -504,8 +504,7 @@ void PairGranular::init_style() index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); // total length of adhesive contact on a particle // Initiate MDR radius update fix - modify->add_fix("fix_mdr_radius_update all mdr/radius/update"); - modify->add_fix("fix_mdr_mean_surf_disp all mdr/mean/surf/disp"); + modify->add_fix("fix_mdr all GRANULAR/MDR"); fix_flag = 1; } diff --git a/src/fix_mdr_mean_surf_disp.h b/src/fix_mdr_mean_surf_disp.h deleted file mode 100644 index daacb660e0..0000000000 --- a/src/fix_mdr_mean_surf_disp.h +++ /dev/null @@ -1,46 +0,0 @@ -/* -*- c++ -*- ---------------------------------------------------------- - LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - https://www.lammps.org/, Sandia National Laboratories - LAMMPS development team: developers@lammps.org - - Copyright (2003) Sandia Corporation. Under the terms of Contract - DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains - certain rights in this software. This software is distributed under - the GNU General Public License. - - See the README file in the top-level LAMMPS directory. -------------------------------------------------------------------------- */ - -#ifdef FIX_CLASS -// clang-format off -FixStyle(mdr/mean/surf/disp,FixMDRmeanSurfDisp); -// clang-format on -#else - -#ifndef LMP_FIX_MDR_MEAN_SURF_DISP_H -#define LMP_FIX_MDR_MEAN_SURF_DISP_H - -#include "fix.h" - -namespace LAMMPS_NS { - -class FixMDRmeanSurfDisp : public Fix { - public: - double * Acon0; - double * ddelta_bar; - - FixMDRmeanSurfDisp(class LAMMPS *, int, char **); - int setmask() override; - void setup_pre_force(int) override; - void pre_force(int) override; // FOR MDR - int pack_forward_comm(int, int *, double *, int, int *) override; - void unpack_forward_comm(int, int, double *) override; - - private: - -}; - -} // namespace LAMMPS_NS - -#endif -#endif diff --git a/src/fix_mdr_radius_update.cpp b/src/fix_mdr_radius_update.cpp deleted file mode 100644 index 7ff883a0cf..0000000000 --- a/src/fix_mdr_radius_update.cpp +++ /dev/null @@ -1,279 +0,0 @@ -/* ---------------------------------------------------------------------- - LAMMPS - Large-scale Atomic/Molecular Massively Parallel Simulator - https://www.lammps.org/, Sandia National Laboratories - LAMMPS development team: developers@lammps.org - - Copyright (2003) Sandia Corporation. Under the terms of Contract - DE-AC04-94AL85000 with Sandia Corporation, the U.S. Government retains - certain rights in this software. This software is distributed under - the GNU General Public License. - - See the README file in the top-level LAMMPS directory. -------------------------------------------------------------------------- */ - -/* ---------------------------------------------------------------------- - Contributing authors: - William Zunker (MIT), Sachith Dunatunga (MIT), - Dan Bolintineanu (SNL), Joel Clemmer (SNL) ------------------------------------------------------------------------ */ - -#include "fix_mdr_radius_update.h" - -#include "atom.h" -#include "error.h" -#include "force.h" -#include "input.h" -#include "math_const.h" -#include "memory.h" -#include "modify.h" -#include "variable.h" -#include "granular_model.h" -#include "pair_granular.h" -#include "pair.h" -#include "gran_sub_mod_normal.h" -#include "update.h" -#include "comm.h" -#include -#include - -using namespace LAMMPS_NS; -using namespace Granular_NS; -using namespace FixConst; -using MathConst::MY_PI; - -/* ---------------------------------------------------------------------- */ - -FixMDRradiusUpdate::FixMDRradiusUpdate(LAMMPS *lmp, int narg, char **arg) : - Fix(lmp, narg, arg) -{ - comm_forward = 20; // value needs to match number of values you communicate -} - -int FixMDRradiusUpdate::setmask() -{ - int mask = 0; - mask |= PRE_FORCE | END_OF_STEP; - return mask; -} - -void FixMDRradiusUpdate::setup_pre_force(int /*vflag*/) -{ - int tmp1, tmp2; - int index_Ro = atom->find_custom("Ro",tmp1,tmp2); - int index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); - int index_Velas = atom->find_custom("Velas",tmp1,tmp2); - int index_Vcaps = atom->find_custom("Vcaps",tmp1,tmp2); - int index_eps_bar = atom->find_custom("eps_bar",tmp1,tmp2); - int index_dRnumerator = atom->find_custom("dRnumerator",tmp1,tmp2); - int index_dRdenominator = atom->find_custom("dRdenominator",tmp1,tmp2); - int index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); - int index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); - int index_Atot = atom->find_custom("Atot",tmp1,tmp2); - int index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); - int index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); - int index_psi = atom->find_custom("psi",tmp1,tmp2); - int index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); - int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); - int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); - int index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); - int index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); - int index_contacts = atom->find_custom("contacts",tmp1,tmp2); - int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); - Ro = atom->dvector[index_Ro]; - Vgeo = atom->dvector[index_Vgeo]; - Velas = atom->dvector[index_Velas]; - Vcaps = atom->dvector[index_Vcaps]; - eps_bar = atom->dvector[index_eps_bar]; - dRnumerator = atom->dvector[index_dRnumerator]; - dRdenominator = atom->dvector[index_dRdenominator]; - Acon0 = atom->dvector[index_Acon0]; - Acon1 = atom->dvector[index_Acon1]; - Atot = atom->dvector[index_Atot]; - Atot_sum = atom->dvector[index_Atot_sum]; - ddelta_bar = atom->dvector[index_ddelta_bar]; - psi = atom->dvector[index_psi]; - psi_b = atom->dvector[index_psi_b]; - sigmaxx = atom->dvector[index_sigmaxx]; - sigmayy = atom->dvector[index_sigmayy]; - sigmazz = atom->dvector[index_sigmazz]; - history_setup_flag = atom->dvector[index_history_setup_flag]; - contacts = atom->dvector[index_contacts]; - adhesive_length = atom->dvector[index_adhesive_length]; - - pre_force(0); -} - -void FixMDRradiusUpdate::setup(int /*vflag*/) -{ - int tmp1, tmp2; - int index_Ro = atom->find_custom("Ro",tmp1,tmp2); - int index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); - int index_Velas = atom->find_custom("Velas",tmp1,tmp2); - int index_Vcaps = atom->find_custom("Vcaps",tmp1,tmp2); - int index_eps_bar = atom->find_custom("eps_bar",tmp1,tmp2); - int index_dRnumerator = atom->find_custom("dRnumerator",tmp1,tmp2); - int index_dRdenominator = atom->find_custom("dRdenominator",tmp1,tmp2); - int index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); - int index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); - int index_Atot = atom->find_custom("Atot",tmp1,tmp2); - int index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); - int index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); - int index_psi = atom->find_custom("psi",tmp1,tmp2); - int index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); - int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); - int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); - int index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); - int index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); - int index_contacts = atom->find_custom("contacts",tmp1,tmp2); - int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); - Ro = atom->dvector[index_Ro]; - Vgeo = atom->dvector[index_Vgeo]; - Velas = atom->dvector[index_Velas]; - Vcaps = atom->dvector[index_Vcaps]; - eps_bar = atom->dvector[index_eps_bar]; - dRnumerator = atom->dvector[index_dRnumerator]; - dRdenominator = atom->dvector[index_dRdenominator]; - Acon0 = atom->dvector[index_Acon0]; - Acon1 = atom->dvector[index_Acon1]; - Atot = atom->dvector[index_Atot]; - Atot_sum = atom->dvector[index_Atot_sum]; - ddelta_bar = atom->dvector[index_ddelta_bar]; - psi = atom->dvector[index_psi]; - psi_b = atom->dvector[index_psi_b]; - sigmaxx = atom->dvector[index_sigmaxx]; - sigmayy = atom->dvector[index_sigmayy]; - sigmazz = atom->dvector[index_sigmazz]; - history_setup_flag = atom->dvector[index_history_setup_flag]; - contacts = atom->dvector[index_contacts]; - adhesive_length = atom->dvector[index_adhesive_length]; - - end_of_step(); -} - -void FixMDRradiusUpdate::pre_force(int) -{ - - PairGranular * pair = dynamic_cast(force->pair_match("granular",1)); - class GranularModel* model; - class GranularModel** models_list = pair->models_list; - class GranSubModNormalMDR* norm_model = nullptr; - for (int i = 0; i < pair->nmodels; i++) { - model = models_list[i]; - if (model->normal_model->name == "mdr") norm_model = dynamic_cast(model->normal_model); - } - if (norm_model == nullptr) error->all(FLERR, "Did not find mdr model"); - - double *radius = atom->radius; - int nlocal = atom->nlocal; - - for (int i = 0; i < nlocal; i++) { - if (history_setup_flag[i] < 1e-16) { - Ro[i] = radius[i]; - Vgeo[i] = 4.0/3.0*MY_PI*pow(Ro[i],3.0); - Velas[i] = 4.0/3.0*MY_PI*pow(Ro[i],3.0); - Atot[i] = 4.0*MY_PI*pow(Ro[i],2.0); - psi[i] = 1.0; - psi_b[i] = norm_model->psi_b; - history_setup_flag[i] = 1.0; - } - sigmaxx[i] = 0.0; - sigmayy[i] = 0.0; - sigmazz[i] = 0.0; - contacts[i] = 0.0; - adhesive_length[i] = 0.0; - } - comm->forward_comm(this); -} - -int FixMDRradiusUpdate::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/,int * /*pbc*/) -{ - int m = 0; - for (int i = 0; i < n; i++) { - int j = list[i]; - buf[m++] = Ro[j]; // 1 - buf[m++] = Vgeo[j]; // 2 - buf[m++] = Velas[j]; // 3 - buf[m++] = Vcaps[j]; // 4 - buf[m++] = eps_bar[j]; // 5 - buf[m++] = dRnumerator[j]; // 6 - buf[m++] = dRdenominator[j]; // 7 - buf[m++] = Acon0[j]; // 8 - buf[m++] = Acon1[j]; // 9 - buf[m++] = Atot[j]; // 10 - buf[m++] = Atot_sum[j]; // 11 - buf[m++] = ddelta_bar[j]; // 12 - buf[m++] = psi[j]; // 13 - buf[m++] = psi_b[j]; // 14 - buf[m++] = sigmaxx[j]; // 15 - buf[m++] = sigmayy[j]; // 16 - buf[m++] = sigmazz[j]; // 17 - buf[m++] = history_setup_flag[j]; // 18 - buf[m++] = contacts[j]; // 19 - buf[m++] = adhesive_length[j]; // 20 - } - return m; -} - -void FixMDRradiusUpdate::unpack_forward_comm(int n, int first, double *buf) -{ - int m = 0; - int last = first + n; - for (int i = first; i < last; i++) { - Ro[i] = buf[m++]; // 1 - Vgeo[i] = buf[m++]; // 2 - Velas[i] = buf[m++]; // 3 - Vcaps[i] = buf[m++]; // 4 - eps_bar[i] = buf[m++]; // 5 - dRnumerator[i] = buf[m++]; // 6 - dRdenominator[i] = buf[m++]; // 7 - Acon0[i] = buf[m++]; // 8 - Acon1[i] = buf[m++]; // 9 - Atot[i] = buf[m++]; // 10 - Atot_sum[i] = buf[m++]; // 11 - ddelta_bar[i] = buf[m++]; // 12 - psi[i] = buf[m++]; // 13 - psi_b[i] = buf[m++]; // 14 - sigmaxx[i] = buf[m++]; // 15 - sigmayy[i] = buf[m++]; // 16 - sigmazz[i] = buf[m++]; // 17 - history_setup_flag[i] = buf[m++]; // 18 - contacts[i] = buf[m++]; // 19 - adhesive_length[i] = buf[m++]; // 20 - } -} - -void FixMDRradiusUpdate::end_of_step() -{ - // update the apparent radius of every particle - double *radius = atom->radius; - int nlocal = atom->nlocal; - - for (int i = 0; i < nlocal; i++) { - - const double R = radius[i]; - Atot[i] = 4.0*MY_PI*pow(R,2.0) + Atot_sum[i]; - - const double Vo = 4.0/3.0*MY_PI*pow(Ro[i],3.0); - const double Vgeoi = 4.0/3.0*MY_PI*pow(R,3.0) - Vcaps[i]; - Vgeo[i] = std::min(Vgeoi,Vo); - - const double Afree = Atot[i] - Acon1[i]; - psi[i] = Afree/Atot[i]; - - const double dR = std::max(dRnumerator[i]/(dRdenominator[i] - 4.0*MY_PI*pow(R,2.0)),0.0); - if (psi_b[i] < psi[i]) { - if ((radius[i] + dR) < (1.5*Ro[i])) radius[i] += dR; - } - - Velas[i] = Vo*(1.0 + eps_bar[i]); - Vcaps[i] = 0.0; - eps_bar[i] = 0.0; - dRnumerator[i] = 0.0; - dRdenominator[i] = 0.0; - Acon0[i] = Acon1[i]; - Acon1[i] = 0.0; - Atot_sum[i] = 0.0; - ddelta_bar[i] = 0.0; - } - comm->forward_comm(this); -} From d764c367c7ef89e35f20668f97b0b7a8bba0df14 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Wed, 18 Dec 2024 13:41:58 -0700 Subject: [PATCH 13/74] Reorganizing MDR fix --- src/GRANULAR/fix_granular_mdr.cpp | 430 ++++++++++++++++-------------- src/GRANULAR/fix_granular_mdr.h | 3 + src/GRANULAR/pair_granular.h | 1 - 3 files changed, 240 insertions(+), 194 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index 3f955d8906..b9c245416f 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -57,6 +57,8 @@ FixGranularMDR::FixGranularMDR(LAMMPS *lmp, int narg, char **arg) : comm_forward = 20; // value needs to match number of values you communicate } +/* ---------------------------------------------------------------------- */ + int FixGranularMDR::setmask() { int mask = 0; @@ -64,6 +66,8 @@ int FixGranularMDR::setmask() return mask; } +/* ---------------------------------------------------------------------- */ + void FixGranularMDR::setup_pre_force(int /*vflag*/) { int tmp1, tmp2; @@ -111,6 +115,8 @@ void FixGranularMDR::setup_pre_force(int /*vflag*/) pre_force(0); } +/* ---------------------------------------------------------------------- */ + void FixGranularMDR::setup(int /*vflag*/) { int tmp1, tmp2; @@ -158,12 +164,147 @@ void FixGranularMDR::setup(int /*vflag*/) end_of_step(); } +/* ---------------------------------------------------------------------- */ + void FixGranularMDR::pre_force(int) { radius_update(); + + comm_stage = RADIUS_UPDATE; + comm->forward_comm(this, 20); + + calculate_contact_penalty(); mean_surf_disp(); + + auto fix_list = modify->get_fix_by_style("wall/gran/region"); + + for (int w = 0; w < fix_list.size(); w++) { + update_fix_gran_wall(fix_list[w]); + } + + comm_stage = MEAN_SURF_DISP; + comm->forward_comm(this, 1); } +/* ---------------------------------------------------------------------- */ + +int FixGranularMDR::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/,int * /*pbc*/) +{ + int m = 0; + if (comm_stage == RADIUS_UPDATE) { + for (int i = 0; i < n; i++) { + int j = list[i]; + buf[m++] = Ro[j]; // 1 + buf[m++] = Vgeo[j]; // 2 + buf[m++] = Velas[j]; // 3 + buf[m++] = Vcaps[j]; // 4 + buf[m++] = eps_bar[j]; // 5 + buf[m++] = dRnumerator[j]; // 6 + buf[m++] = dRdenominator[j]; // 7 + buf[m++] = Acon0[j]; // 8 + buf[m++] = Acon1[j]; // 9 + buf[m++] = Atot[j]; // 10 + buf[m++] = Atot_sum[j]; // 11 + buf[m++] = ddelta_bar[j]; // 12 + buf[m++] = psi[j]; // 13 + buf[m++] = psi_b[j]; // 14 + buf[m++] = sigmaxx[j]; // 15 + buf[m++] = sigmayy[j]; // 16 + buf[m++] = sigmazz[j]; // 17 + buf[m++] = history_setup_flag[j]; // 18 + buf[m++] = contacts[j]; // 19 + buf[m++] = adhesive_length[j]; // 20 + } + } else { + for (int i = 0; i < n; i++) { + int j = list[i]; + buf[m++] = ddelta_bar[j]; + } + } + return m; +} + +/* ---------------------------------------------------------------------- */ + +void FixGranularMDR::unpack_forward_comm(int n, int first, double *buf) +{ + int m = 0; + int last = first + n; + + if (comm_stage == RADIUS_UPDATE) { + for (int i = first; i < last; i++) { + Ro[i] = buf[m++]; // 1 + Vgeo[i] = buf[m++]; // 2 + Velas[i] = buf[m++]; // 3 + Vcaps[i] = buf[m++]; // 4 + eps_bar[i] = buf[m++]; // 5 + dRnumerator[i] = buf[m++]; // 6 + dRdenominator[i] = buf[m++]; // 7 + Acon0[i] = buf[m++]; // 8 + Acon1[i] = buf[m++]; // 9 + Atot[i] = buf[m++]; // 10 + Atot_sum[i] = buf[m++]; // 11 + ddelta_bar[i] = buf[m++]; // 12 + psi[i] = buf[m++]; // 13 + psi_b[i] = buf[m++]; // 14 + sigmaxx[i] = buf[m++]; // 15 + sigmayy[i] = buf[m++]; // 16 + sigmazz[i] = buf[m++]; // 17 + history_setup_flag[i] = buf[m++]; // 18 + contacts[i] = buf[m++]; // 19 + adhesive_length[i] = buf[m++]; // 20 + } + } else { + for (int i = first; i < last; i++) { + ddelta_bar[i] = buf[m++]; + } + } +} + +/* ---------------------------------------------------------------------- */ + +void FixGranularMDR::end_of_step() +{ + // update the apparent radius of every particle + double *radius = atom->radius; + int nlocal = atom->nlocal; + + for (int i = 0; i < nlocal; i++) { + + const double R = radius[i]; + Atot[i] = 4.0*MY_PI*pow(R,2.0) + Atot_sum[i]; + + const double Vo = 4.0/3.0*MY_PI*pow(Ro[i],3.0); + const double Vgeoi = 4.0/3.0*MY_PI*pow(R,3.0) - Vcaps[i]; + Vgeo[i] = std::min(Vgeoi,Vo); + + const double Afree = Atot[i] - Acon1[i]; + psi[i] = Afree/Atot[i]; + + const double dR = std::max(dRnumerator[i]/(dRdenominator[i] - 4.0*MY_PI*pow(R,2.0)),0.0); + if (psi_b[i] < psi[i]) { + if ((radius[i] + dR) < (1.5*Ro[i])) radius[i] += dR; + } + + Velas[i] = Vo*(1.0 + eps_bar[i]); + Vcaps[i] = 0.0; + eps_bar[i] = 0.0; + dRnumerator[i] = 0.0; + dRdenominator[i] = 0.0; + Acon0[i] = Acon1[i]; + Acon1[i] = 0.0; + Atot_sum[i] = 0.0; + ddelta_bar[i] = 0.0; + } + comm_stage = RADIUS_UPDATE; + comm->forward_comm(this, 20); +} + + +/* ---------------------------------------------------------------------- + calculate updated radius for atoms +------------------------------------------------------------------------- */ + void FixGranularMDR::radius_update() { PairGranular * pair = dynamic_cast(force->pair_match("granular",1)); @@ -195,11 +336,13 @@ void FixGranularMDR::radius_update() contacts[i] = 0.0; adhesive_length[i] = 0.0; } - comm_stage = RADIUS_UPDATE; - comm->forward_comm(this, 20); } -void FixGranularMDR::mean_surf_disp() +/* ---------------------------------------------------------------------- + ... +------------------------------------------------------------------------- */ + +void FixGranularMDR::calculate_contact_penalty() { FixNeighHistory * fix_history = dynamic_cast(modify->get_fix_by_id("NEIGH_HISTORY_GRANULAR")); PairGranular * pair = dynamic_cast(force->pair_match("granular",1)); @@ -207,7 +350,7 @@ void FixGranularMDR::mean_surf_disp() const int size_history = pair->get_size_history(); - { + int i,j,k,lv1,ii,jj,inum,jnum,itype,jtype,ktype; int *ilist,*jlist,*numneigh,**firstneigh; @@ -354,10 +497,22 @@ void FixGranularMDR::mean_surf_disp() } } } - } +} + + +/* ---------------------------------------------------------------------- + ... +------------------------------------------------------------------------- */ + +void FixGranularMDR::mean_surf_disp() +{ + FixNeighHistory * fix_history = dynamic_cast(modify->get_fix_by_id("NEIGH_HISTORY_GRANULAR")); + PairGranular * pair = dynamic_cast(force->pair_match("granular",1)); + NeighList * list = pair->list; + + const int size_history = pair->get_size_history(); - { int i,j,k,ii,jj,inum,jnum,itype,jtype; int *ilist,*jlist,*numneigh,**firstneigh; @@ -491,200 +646,89 @@ void FixGranularMDR::mean_surf_disp() } } - auto fix_list = modify->get_fix_by_style("wall/gran/region"); +/* ---------------------------------------------------------------------- + Update instance of fix gran/wall +------------------------------------------------------------------------- */ - for (int w = 0; w < fix_list.size(); w++) { - - FixWallGranRegion* fix = dynamic_cast(fix_list[w]); - GranularModel * model = fix->model; - Region * region = fix->region; - - { - int i, m, nc, iwall; - double vwall[3]; - bool touchflag = false; - - int history_update = 1; - model->history_update = history_update; - - int regiondynamic = region->dynamic_check(); - if (!regiondynamic) vwall[0] = vwall[1] = vwall[2] = 0.0; - - double **x = atom->x; - double *radius = atom->radius; - int *mask = atom->mask; - int nlocal = atom->nlocal; - - if (regiondynamic) { - region->prematch(); - region->set_velocity(); - } - - if (fix->peratom_flag) fix->clear_stored_contacts(); - - model->radj = 0.0; - - for (i = 0; i < nlocal; i++) { - if (!(mask[i] & groupbit)) continue; - if (! region->match(x[i][0], x[i][1], x[i][2])) continue; - - nc = region->surface(x[i][0], x[i][1], x[i][2], radius[i] + model->pulloff_distance(radius[i], 0.0)); - - if (nc == 0) { - fix->ncontact[i] = 0; - continue; - } - if (nc == 1) { - fix->c2r[0] = 0; - iwall = region->contact[0].iwall; - if (fix->ncontact[i] == 0) { - fix->ncontact[i] = 1; - fix->walls[i][0] = iwall; - for (m = 0; m < size_history; m++) fix->history_many[i][0][m] = 0.0; - } else if (fix->ncontact[i] > 1 || iwall != fix->walls[i][0]) - fix->update_contacts(i, nc); - } else - fix->update_contacts(i, nc); - - - // process current contacts - for (int ic = 0; ic < nc; ic++) { - - // Reset model and copy initial geometric data - model->dx[0] = region->contact[ic].delx; - model->dx[1] = region->contact[ic].dely; - model->dx[2] = region->contact[ic].delz; - model->radi = radius[i]; - model->radj = region->contact[ic].radius; - model->r = region->contact[ic].r; - - if (model->beyond_contact) model->touch = fix->history_many[i][fix->c2r[ic]][0]; - - touchflag = model->check_contact(); - - const double wij = 1.0; - - if (Acon0[i] != 0.0) { - const double delta = model->radsum - model->r; - const double delta_offset0 = fix->history_many[i][fix->c2r[ic]][0]; - const double ddelta = delta - delta_offset0; - const double Ac_offset0 = fix->history_many[i][fix->c2r[ic]][18]; - ddelta_bar[i] += wij*Ac_offset0/Acon0[i]*ddelta; - } - } - } - } - } - - comm_stage = MEAN_SURF_DISP; - comm->forward_comm(this, 1); -} - - -int FixGranularMDR::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/,int * /*pbc*/) +void FixGranularMDR::update_fix_gran_wall(Fix* fix_in) { - int m = 0; - if (comm_stage == RADIUS_UPDATE) { - for (int i = 0; i < n; i++) { - int j = list[i]; - buf[m++] = Ro[j]; // 1 - buf[m++] = Vgeo[j]; // 2 - buf[m++] = Velas[j]; // 3 - buf[m++] = Vcaps[j]; // 4 - buf[m++] = eps_bar[j]; // 5 - buf[m++] = dRnumerator[j]; // 6 - buf[m++] = dRdenominator[j]; // 7 - buf[m++] = Acon0[j]; // 8 - buf[m++] = Acon1[j]; // 9 - buf[m++] = Atot[j]; // 10 - buf[m++] = Atot_sum[j]; // 11 - buf[m++] = ddelta_bar[j]; // 12 - buf[m++] = psi[j]; // 13 - buf[m++] = psi_b[j]; // 14 - buf[m++] = sigmaxx[j]; // 15 - buf[m++] = sigmayy[j]; // 16 - buf[m++] = sigmazz[j]; // 17 - buf[m++] = history_setup_flag[j]; // 18 - buf[m++] = contacts[j]; // 19 - buf[m++] = adhesive_length[j]; // 20 - } - } else { - for (int i = 0; i < n; i++) { - int j = list[i]; - buf[m++] = ddelta_bar[j]; - } - } - return m; -} + FixWallGranRegion* fix = dynamic_cast(fix_in); + GranularModel * model = fix->model; + Region * region = fix->region; -void FixGranularMDR::unpack_forward_comm(int n, int first, double *buf) -{ - int m = 0; - int last = first + n; + const int size_history = model->size_history; - if (comm_stage == RADIUS_UPDATE) { - for (int i = first; i < last; i++) { - Ro[i] = buf[m++]; // 1 - Vgeo[i] = buf[m++]; // 2 - Velas[i] = buf[m++]; // 3 - Vcaps[i] = buf[m++]; // 4 - eps_bar[i] = buf[m++]; // 5 - dRnumerator[i] = buf[m++]; // 6 - dRdenominator[i] = buf[m++]; // 7 - Acon0[i] = buf[m++]; // 8 - Acon1[i] = buf[m++]; // 9 - Atot[i] = buf[m++]; // 10 - Atot_sum[i] = buf[m++]; // 11 - ddelta_bar[i] = buf[m++]; // 12 - psi[i] = buf[m++]; // 13 - psi_b[i] = buf[m++]; // 14 - sigmaxx[i] = buf[m++]; // 15 - sigmayy[i] = buf[m++]; // 16 - sigmazz[i] = buf[m++]; // 17 - history_setup_flag[i] = buf[m++]; // 18 - contacts[i] = buf[m++]; // 19 - adhesive_length[i] = buf[m++]; // 20 - } - } else { - for (int i = first; i < last; i++) { - ddelta_bar[i] = buf[m++]; - } - } -} + int i, m, nc, iwall; + double vwall[3]; + bool touchflag = false; -void FixGranularMDR::end_of_step() -{ - // update the apparent radius of every particle + int history_update = 1; + model->history_update = history_update; + + int regiondynamic = region->dynamic_check(); + if (!regiondynamic) vwall[0] = vwall[1] = vwall[2] = 00; + + double **x = atom->x; double *radius = atom->radius; + int *mask = atom->mask; int nlocal = atom->nlocal; - for (int i = 0; i < nlocal; i++) { - - const double R = radius[i]; - Atot[i] = 4.0*MY_PI*pow(R,2.0) + Atot_sum[i]; - - const double Vo = 4.0/3.0*MY_PI*pow(Ro[i],3.0); - const double Vgeoi = 4.0/3.0*MY_PI*pow(R,3.0) - Vcaps[i]; - Vgeo[i] = std::min(Vgeoi,Vo); - - const double Afree = Atot[i] - Acon1[i]; - psi[i] = Afree/Atot[i]; - - const double dR = std::max(dRnumerator[i]/(dRdenominator[i] - 4.0*MY_PI*pow(R,2.0)),0.0); - if (psi_b[i] < psi[i]) { - if ((radius[i] + dR) < (1.5*Ro[i])) radius[i] += dR; - } - - Velas[i] = Vo*(1.0 + eps_bar[i]); - Vcaps[i] = 0.0; - eps_bar[i] = 0.0; - dRnumerator[i] = 0.0; - dRdenominator[i] = 0.0; - Acon0[i] = Acon1[i]; - Acon1[i] = 0.0; - Atot_sum[i] = 0.0; - ddelta_bar[i] = 0.0; + if (regiondynamic) { + region->prematch(); + region->set_velocity(); + } + + if (fix->peratom_flag) fix->clear_stored_contacts(); + + model->radj = 0.0; + + for (i = 0; i < nlocal; i++) { + if (!(mask[i] & groupbit)) continue; + if (! region->match(x[i][0], x[i][1], x[i][2])) continue; + + nc = region->surface(x[i][0], x[i][1], x[i][2], radius[i] + model->pulloff_distance(radius[i], 0.0)); + + if (nc == 0) { + fix->ncontact[i] = 0; + continue; + } + if (nc == 1) { + fix->c2r[0] = 0; + iwall = region->contact[0].iwall; + if (fix->ncontact[i] == 0) { + fix->ncontact[i] = 1; + fix->walls[i][0] = iwall; + for (m = 0; m < size_history; m++) fix->history_many[i][0][m] = 0.0; + } else if (fix->ncontact[i] > 1 || iwall != fix->walls[i][0]) + fix->update_contacts(i, nc); + } else + fix->update_contacts(i, nc); + + + // process current contacts + for (int ic = 0; ic < nc; ic++) { + + // Reset model and copy initial geometric data + model->dx[0] = region->contact[ic].delx; + model->dx[1] = region->contact[ic].dely; + model->dx[2] = region->contact[ic].delz; + model->radi = radius[i]; + model->radj = region->contact[ic].radius; + model->r = region->contact[ic].r; + + if (model->beyond_contact) model->touch = fix->history_many[i][fix->c2r[ic]][0]; + + touchflag = model->check_contact(); + + const double wij = 1.0; + + if (Acon0[i] != 0.0) { + const double delta = model->radsum - model->r; + const double delta_offset0 = fix->history_many[i][fix->c2r[ic]][0]; + const double ddelta = delta - delta_offset0; + const double Ac_offset0 = fix->history_many[i][fix->c2r[ic]][18]; + ddelta_bar[i] += wij*Ac_offset0/Acon0[i]*ddelta; + } + } } - comm_stage = RADIUS_UPDATE; - comm->forward_comm(this, 20); } diff --git a/src/GRANULAR/fix_granular_mdr.h b/src/GRANULAR/fix_granular_mdr.h index 78c34b1b99..149bb61ec7 100644 --- a/src/GRANULAR/fix_granular_mdr.h +++ b/src/GRANULAR/fix_granular_mdr.h @@ -61,6 +61,9 @@ class FixGranularMDR : public Fix { void radius_update(); void mean_surf_disp(); + void calculate_contact_penalty(); + void update_fix_gran_wall(Fix*); + }; } // namespace LAMMPS_NS diff --git a/src/GRANULAR/pair_granular.h b/src/GRANULAR/pair_granular.h index 199431afe3..490133be09 100644 --- a/src/GRANULAR/pair_granular.h +++ b/src/GRANULAR/pair_granular.h @@ -55,7 +55,6 @@ class PairGranular : public Pair { class FixStoreAtom * fix_store; - protected: int freeze_group_bit; int use_history; From 844d3a6cabfbd041fac3fa5bd5fbd8e7c0d8fa20 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Wed, 18 Dec 2024 17:44:12 -0700 Subject: [PATCH 14/74] Minimizing changes to pair granular --- src/GRANULAR/fix_granular_mdr.cpp | 306 ++++++++++++--------------- src/GRANULAR/fix_granular_mdr.h | 46 ++-- src/GRANULAR/gran_sub_mod_normal.cpp | 105 +++++---- src/GRANULAR/gran_sub_mod_normal.h | 7 + src/GRANULAR/pair_granular.cpp | 37 ---- src/GRANULAR/pair_granular.h | 25 --- 6 files changed, 231 insertions(+), 295 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index b9c245416f..68d9dd4e5e 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -54,7 +54,15 @@ enum {MEAN_SURF_DISP, RADIUS_UPDATE}; FixGranularMDR::FixGranularMDR(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) { - comm_forward = 20; // value needs to match number of values you communicate + comm_forward = 20; // value needs to match number of values you communicate + id_fix = nullptr; +} + +/* ---------------------------------------------------------------------- */ + +FixGranularMDR::~FixGranularMDR() +{ + if (id_fix) modify->delete_fix(id_fix); } /* ---------------------------------------------------------------------- */ @@ -68,13 +76,16 @@ int FixGranularMDR::setmask() /* ---------------------------------------------------------------------- */ -void FixGranularMDR::setup_pre_force(int /*vflag*/) +void FixGranularMDR::post_constructor() { int tmp1, tmp2; + id_fix = utils::strdup("MDR_PARTICLE_HISTORY_VARIABLES"); + modify->add_fix(fmt::format("{} all property/atom d_Ro d_Vcaps d_Vgeo d_Velas d_eps_bar d_dRnumerator d_dRdenominator d_Acon0 d_Acon1 d_Atot d_Atot_sum d_ddelta_bar d_psi d_psi_b d_history_setup_flag d_sigmaxx d_sigmayy d_sigmazz d_contacts d_adhesive_length ghost yes", id_fix)); + int index_Ro = atom->find_custom("Ro",tmp1,tmp2); + int index_Vcaps = atom->find_custom("Vcaps",tmp1,tmp2); int index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); int index_Velas = atom->find_custom("Velas",tmp1,tmp2); - int index_Vcaps = atom->find_custom("Vcaps",tmp1,tmp2); int index_eps_bar = atom->find_custom("eps_bar",tmp1,tmp2); int index_dRnumerator = atom->find_custom("dRnumerator",tmp1,tmp2); int index_dRdenominator = atom->find_custom("dRdenominator",tmp1,tmp2); @@ -85,12 +96,13 @@ void FixGranularMDR::setup_pre_force(int /*vflag*/) int index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); int index_psi = atom->find_custom("psi",tmp1,tmp2); int index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); + int index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); int index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); - int index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); int index_contacts = atom->find_custom("contacts",tmp1,tmp2); int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); + Ro = atom->dvector[index_Ro]; Vgeo = atom->dvector[index_Vgeo]; Velas = atom->dvector[index_Velas]; @@ -111,7 +123,12 @@ void FixGranularMDR::setup_pre_force(int /*vflag*/) history_setup_flag = atom->dvector[index_history_setup_flag]; contacts = atom->dvector[index_contacts]; adhesive_length = atom->dvector[index_adhesive_length]; +} +/* ---------------------------------------------------------------------- */ + +void FixGranularMDR::setup_pre_force(int /*vflag*/) +{ pre_force(0); } @@ -119,48 +136,6 @@ void FixGranularMDR::setup_pre_force(int /*vflag*/) void FixGranularMDR::setup(int /*vflag*/) { - int tmp1, tmp2; - int index_Ro = atom->find_custom("Ro",tmp1,tmp2); - int index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); - int index_Velas = atom->find_custom("Velas",tmp1,tmp2); - int index_Vcaps = atom->find_custom("Vcaps",tmp1,tmp2); - int index_eps_bar = atom->find_custom("eps_bar",tmp1,tmp2); - int index_dRnumerator = atom->find_custom("dRnumerator",tmp1,tmp2); - int index_dRdenominator = atom->find_custom("dRdenominator",tmp1,tmp2); - int index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); - int index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); - int index_Atot = atom->find_custom("Atot",tmp1,tmp2); - int index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); - int index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); - int index_psi = atom->find_custom("psi",tmp1,tmp2); - int index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); - int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); - int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); - int index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); - int index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); - int index_contacts = atom->find_custom("contacts",tmp1,tmp2); - int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); - Ro = atom->dvector[index_Ro]; - Vgeo = atom->dvector[index_Vgeo]; - Velas = atom->dvector[index_Velas]; - Vcaps = atom->dvector[index_Vcaps]; - eps_bar = atom->dvector[index_eps_bar]; - dRnumerator = atom->dvector[index_dRnumerator]; - dRdenominator = atom->dvector[index_dRdenominator]; - Acon0 = atom->dvector[index_Acon0]; - Acon1 = atom->dvector[index_Acon1]; - Atot = atom->dvector[index_Atot]; - Atot_sum = atom->dvector[index_Atot_sum]; - ddelta_bar = atom->dvector[index_ddelta_bar]; - psi = atom->dvector[index_psi]; - psi_b = atom->dvector[index_psi_b]; - sigmaxx = atom->dvector[index_sigmaxx]; - sigmayy = atom->dvector[index_sigmayy]; - sigmazz = atom->dvector[index_sigmazz]; - history_setup_flag = atom->dvector[index_history_setup_flag]; - contacts = atom->dvector[index_contacts]; - adhesive_length = atom->dvector[index_adhesive_length]; - end_of_step(); } @@ -381,121 +356,121 @@ void FixGranularMDR::calculate_contact_penalty() double radi = radius[i]; jlist = firstneigh[i]; jnum = numneigh[i]; - for (int jj = 0; jj < jnum; jj++) { - j = jlist[jj]; - j &= NEIGHMASK; - jtype = type[j]; - double radj = radius[j]; - const double delx_ij = x[j][0] - xtmp; - const double dely_ij = x[j][1] - ytmp; - const double delz_ij = x[j][2] - ztmp; - const double rsq_ij = delx_ij*delx_ij + dely_ij*dely_ij + delz_ij*delz_ij; - const double r_ij = sqrt(rsq_ij); - const double rinv_ij = 1.0/r_ij; - const double radsum_ij = radi + radj; - const double deltan_ij = radsum_ij - r_ij; - if (deltan_ij >= 0.0) { - for (int kk = jj; kk < jnum; kk++) { - k = jlist[kk]; - k &= NEIGHMASK; - ktype = type[k]; - if (kk != jj) { - const double delx_ik = x[k][0] - xtmp; - const double dely_ik = x[k][1] - ytmp; - const double delz_ik = x[k][2] - ztmp; - const double rsq_ik = delx_ik*delx_ik + dely_ik*dely_ik + delz_ik*delz_ik; - const double r_ik = sqrt(rsq_ik); - const double rinv_ik = 1.0/r_ik; - const double radk = radius[k]; - const double radsum_ik = radi + radk; - const double deltan_ik = radsum_ik - r_ik; - const double delx_jk = x[k][0] - x[j][0]; - const double dely_jk = x[k][1] - x[j][1]; - const double delz_jk = x[k][2] - x[j][2]; - const double rsq_jk = delx_jk*delx_jk + dely_jk*dely_jk + delz_jk*delz_jk; - const double r_jk = sqrt(rsq_jk); - const double rinv_jk = 1.0/r_jk; - const double radsum_jk = radj + radk; - const double deltan_jk = radsum_jk - r_jk; - if (deltan_ik >= 0.0 && deltan_jk >= 0.0) { + for (int jj = 0; jj < jnum; jj++) { + j = jlist[jj]; + j &= NEIGHMASK; + jtype = type[j]; + double radj = radius[j]; + const double delx_ij = x[j][0] - xtmp; + const double dely_ij = x[j][1] - ytmp; + const double delz_ij = x[j][2] - ztmp; + const double rsq_ij = delx_ij*delx_ij + dely_ij*dely_ij + delz_ij*delz_ij; + const double r_ij = sqrt(rsq_ij); + const double rinv_ij = 1.0/r_ij; + const double radsum_ij = radi + radj; + const double deltan_ij = radsum_ij - r_ij; + if (deltan_ij >= 0.0) { + for (int kk = jj; kk < jnum; kk++) { + k = jlist[kk]; + k &= NEIGHMASK; + ktype = type[k]; + if (kk != jj) { + const double delx_ik = x[k][0] - xtmp; + const double dely_ik = x[k][1] - ytmp; + const double delz_ik = x[k][2] - ztmp; + const double rsq_ik = delx_ik*delx_ik + dely_ik*dely_ik + delz_ik*delz_ik; + const double r_ik = sqrt(rsq_ik); + const double rinv_ik = 1.0/r_ik; + const double radk = radius[k]; + const double radsum_ik = radi + radk; + const double deltan_ik = radsum_ik - r_ik; + const double delx_jk = x[k][0] - x[j][0]; + const double dely_jk = x[k][1] - x[j][1]; + const double delz_jk = x[k][2] - x[j][2]; + const double rsq_jk = delx_jk*delx_jk + dely_jk*dely_jk + delz_jk*delz_jk; + const double r_jk = sqrt(rsq_jk); + const double rinv_jk = 1.0/r_jk; + const double radsum_jk = radj + radk; + const double deltan_jk = radsum_jk - r_jk; + if (deltan_ik >= 0.0 && deltan_jk >= 0.0) { - // pull ij history - history_ij = &allhistory[size_history * jj]; - double * pij = &history_ij[22]; // penalty for contact i and j + // pull ij history + history_ij = &allhistory[size_history * jj]; + double * pij = &history_ij[22]; // penalty for contact i and j - // pull ik history - history_ik = &allhistory[size_history * kk]; - double * pik = &history_ik[22]; // penalty for contact i and k + // pull ik history + history_ik = &allhistory[size_history * kk]; + double * pik = &history_ik[22]; // penalty for contact i and k - // we don't know if who owns the contact ahead of time, k might be in j's neigbor list or vice versa, - // so we need to manually search to figure out the owner check if k is in the neighbor list of j - double * pjk = NULL; - int * const jklist = firstneigh[j]; - const int jknum = numneigh[j]; - for (int jk = 0; jk < jknum; jk++) { - const int kneigh = jklist[jk] & NEIGHMASK; - if (k == kneigh) { - allhistory_j = firsthistory[j]; - history_jk = &allhistory_j[size_history * jk]; - pjk = &history_jk[22]; // penalty for contact j and k + // we don't know if who owns the contact ahead of time, k might be in j's neigbor list or vice versa, + // so we need to manually search to figure out the owner check if k is in the neighbor list of j + double * pjk = NULL; + int * const jklist = firstneigh[j]; + const int jknum = numneigh[j]; + for (int jk = 0; jk < jknum; jk++) { + const int kneigh = jklist[jk] & NEIGHMASK; + if (k == kneigh) { + allhistory_j = firsthistory[j]; + history_jk = &allhistory_j[size_history * jk]; + pjk = &history_jk[22]; // penalty for contact j and k + break; + } + } + + // check if j is in the neighbor list of k + if (pjk == NULL) { + int * const kjlist = firstneigh[k]; + const int kjnum = numneigh[k]; + for (int kj = 0; kj < kjnum; kj++) { + const int jneigh = kjlist[kj] & NEIGHMASK; + if (j == jneigh) { + allhistory_k = firsthistory[k]; + history_kj = &allhistory_k[size_history * kj]; + pjk = &history_kj[22]; // penalty for contact j and k break; } } + } - // check if j is in the neighbor list of k - if (pjk == NULL) { - int * const kjlist = firstneigh[k]; - const int kjnum = numneigh[k]; - for (int kj = 0; kj < kjnum; kj++) { - const int jneigh = kjlist[kj] & NEIGHMASK; - if (j == jneigh) { - allhistory_k = firsthistory[k]; - history_kj = &allhistory_k[size_history * kj]; - pjk = &history_kj[22]; // penalty for contact j and k - break; - } - } - } - - std::vector distances = {r_ij,r_ik,r_jk}; - auto maxElement = std::max_element(distances.begin(), distances.end()); - double maxValue = *maxElement; - int maxIndex = std::distance(distances.begin(), maxElement); - if (maxIndex == 0) { // the central particle is k - const double enx_ki = -delx_ik * rinv_ik; - const double eny_ki = -dely_ik * rinv_ik; - const double enz_ki = -delz_ik * rinv_ik; - const double enx_kj = -delx_jk * rinv_jk; - const double eny_kj = -dely_jk * rinv_jk; - const double enz_kj = -delz_jk * rinv_jk; - const double alpha = std::acos(enx_ki*enx_kj + eny_ki*eny_kj + enz_ki*enz_kj); - pij[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/MY_PI - 1.0/2.0)) ); - } else if (maxIndex == 1) { // the central particle is j - const double enx_ji = -delx_ij * rinv_ij; - const double eny_ji = -dely_ij * rinv_ij; - const double enz_ji = -delz_ij * rinv_ij; - const double enx_jk = delx_jk * rinv_jk; - const double eny_jk = dely_jk * rinv_jk; - const double enz_jk = delz_jk * rinv_jk; - const double alpha = std::acos(enx_ji*enx_jk + eny_ji*eny_jk + enz_ji*enz_jk); - pik[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/MY_PI - 1.0/2.0)) ); - } else { // the central particle is i - if (j < atom->nlocal || k < atom->nlocal) { - const double enx_ij = delx_ij * rinv_ij; - const double eny_ij = dely_ij * rinv_ij; - const double enz_ij = delz_ij * rinv_ij; - const double enx_ik = delx_ik * rinv_ik; - const double eny_ik = dely_ik * rinv_ik; - const double enz_ik = delz_ik * rinv_ik; - const double alpha = std::acos(enx_ij*enx_ik + eny_ij*eny_ik + enz_ij*enz_ik); - pjk[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/MY_PI - 1.0/2.0)) ); - } + std::vector distances = {r_ij,r_ik,r_jk}; + auto maxElement = std::max_element(distances.begin(), distances.end()); + double maxValue = *maxElement; + int maxIndex = std::distance(distances.begin(), maxElement); + if (maxIndex == 0) { // the central particle is k + const double enx_ki = -delx_ik * rinv_ik; + const double eny_ki = -dely_ik * rinv_ik; + const double enz_ki = -delz_ik * rinv_ik; + const double enx_kj = -delx_jk * rinv_jk; + const double eny_kj = -dely_jk * rinv_jk; + const double enz_kj = -delz_jk * rinv_jk; + const double alpha = std::acos(enx_ki*enx_kj + eny_ki*eny_kj + enz_ki*enz_kj); + pij[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/MY_PI - 1.0/2.0))); + } else if (maxIndex == 1) { // the central particle is j + const double enx_ji = -delx_ij * rinv_ij; + const double eny_ji = -dely_ij * rinv_ij; + const double enz_ji = -delz_ij * rinv_ij; + const double enx_jk = delx_jk * rinv_jk; + const double eny_jk = dely_jk * rinv_jk; + const double enz_jk = delz_jk * rinv_jk; + const double alpha = std::acos(enx_ji*enx_jk + eny_ji*eny_jk + enz_ji*enz_jk); + pik[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/MY_PI - 1.0/2.0))); + } else { // the central particle is i + if (j < atom->nlocal || k < atom->nlocal) { + const double enx_ij = delx_ij * rinv_ij; + const double eny_ij = dely_ij * rinv_ij; + const double enz_ij = delz_ij * rinv_ij; + const double enx_ik = delx_ik * rinv_ik; + const double eny_ik = dely_ik * rinv_ik; + const double enz_ik = delz_ik * rinv_ik; + const double alpha = std::acos(enx_ij*enx_ik + eny_ij*eny_ik + enz_ij*enz_ik); + pjk[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/MY_PI - 1.0/2.0))); } } } } } } + } } } @@ -511,16 +486,12 @@ void FixGranularMDR::mean_surf_disp() NeighList * list = pair->list; const int size_history = pair->get_size_history(); - - int i,j,k,ii,jj,inum,jnum,itype,jtype; - int *ilist,*jlist,*numneigh,**firstneigh; int *touch,**firsttouch; double *history,*allhistory,**firsthistory; bool touchflag = false; - class GranularModel* model; class GranularModel** models_list = pair->models_list; int ** types_indices = pair->types_indices; @@ -530,7 +501,6 @@ void FixGranularMDR::mean_surf_disp() double *radius = atom->radius; int nlocal = atom->nlocal; - inum = list->inum; ilist = list->ilist; numneigh = list->numneigh; @@ -657,11 +627,9 @@ void FixGranularMDR::update_fix_gran_wall(Fix* fix_in) Region * region = fix->region; const int size_history = model->size_history; - int i, m, nc, iwall; double vwall[3]; bool touchflag = false; - int history_update = 1; model->history_update = history_update; @@ -688,21 +656,21 @@ void FixGranularMDR::update_fix_gran_wall(Fix* fix_in) nc = region->surface(x[i][0], x[i][1], x[i][2], radius[i] + model->pulloff_distance(radius[i], 0.0)); - if (nc == 0) { - fix->ncontact[i] = 0; - continue; - } - if (nc == 1) { - fix->c2r[0] = 0; - iwall = region->contact[0].iwall; - if (fix->ncontact[i] == 0) { - fix->ncontact[i] = 1; - fix->walls[i][0] = iwall; - for (m = 0; m < size_history; m++) fix->history_many[i][0][m] = 0.0; - } else if (fix->ncontact[i] > 1 || iwall != fix->walls[i][0]) - fix->update_contacts(i, nc); - } else + if (nc == 0) { + fix->ncontact[i] = 0; + continue; + } + if (nc == 1) { + fix->c2r[0] = 0; + iwall = region->contact[0].iwall; + if (fix->ncontact[i] == 0) { + fix->ncontact[i] = 1; + fix->walls[i][0] = iwall; + for (m = 0; m < size_history; m++) fix->history_many[i][0][m] = 0.0; + } else if (fix->ncontact[i] > 1 || iwall != fix->walls[i][0]) fix->update_contacts(i, nc); + } else + fix->update_contacts(i, nc); // process current contacts diff --git a/src/GRANULAR/fix_granular_mdr.h b/src/GRANULAR/fix_granular_mdr.h index 149bb61ec7..319300cc7b 100644 --- a/src/GRANULAR/fix_granular_mdr.h +++ b/src/GRANULAR/fix_granular_mdr.h @@ -26,44 +26,46 @@ namespace LAMMPS_NS { class FixGranularMDR : public Fix { public: - double * Ro; - double * Vgeo; - double * Velas; - double * Vcaps; - double * eps_bar; - double * dRnumerator; - double * dRdenominator; - double * Acon0; - double * Acon1; - double * Atot; - double * Atot_sum; - double * ddelta_bar; - double * psi; - double * psi_b; - double * sigmaxx; - double * sigmayy; - double * sigmazz; - double * history_setup_flag; - double * contacts; - double * adhesive_length; - FixGranularMDR(class LAMMPS *, int, char **); + ~FixGranularMDR() override; int setmask() override; + void post_constructor() override; void setup(int) override; void setup_pre_force(int) override; void pre_force(int) override; - void end_of_step() override; // FOR MDR + void end_of_step() override; int pack_forward_comm(int, int *, double *, int, int *) override; void unpack_forward_comm(int, int, double *) override; private: int comm_stage; + char *id_fix; void radius_update(); void mean_surf_disp(); void calculate_contact_penalty(); void update_fix_gran_wall(Fix*); + double *Ro; // initial radius + double *Vgeo; // geometric particle volume of apparent particle afterremoving spherical cap volume + double *Velas; // particle volume from linear elasticity + double *Vcaps; // spherical cap volume from intersection of apparentradius particle and contact planes + double *eps_bar; // volume-averaged infinitesimal strain tensor + double *dRnumerator; // summation of numerator terms in calculation of dR + double *dRdenominator; // summation of denominator terms in calculation of dR + double *Acon0; // total area involved in contacts: Acon^{n} + double *Acon1; // total area involved in contacts: Acon^{n+1} + double *Atot; // total particle area + double *Atot_sum; // running sum of contact area minus cap area + double *ddelta_bar; // change in mean surface displacement + double *psi; // ratio of free surface area to total surface area + double *psi_b; // TEMPORARY, SINCE PSI_B IS ALREADY DEFINED IN THEINPUT SCRIPT + double *sigmaxx; // xx-component of the stress tensor, not necessary forforce calculation + double *sigmayy; // yy-component of the stress tensor, not necessary forforce calculation + double *sigmazz; // zz-component of the stress tensor, not necessary forforce calculation + double *history_setup_flag; // flag to check if history variables have beeninitialized + double *contacts; // total contacts on particle + double *adhesive_length; // total length of adhesive contact on a particle }; } // namespace LAMMPS_NS diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 43e77b1c4e..9eddc827ff 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -13,12 +13,13 @@ #include "gran_sub_mod_normal.h" +#include "atom.h" #include "error.h" +#include "citeme.h" #include "granular_model.h" #include "math_const.h" -#include "atom.h" +#include "modify.h" #include "update.h" -#include "citeme.h" #include #include @@ -414,6 +415,7 @@ GranSubModNormalMDR::GranSubModNormalMDR(GranularModel *gm, LAMMPS *lmp) : num_coeffs = 6; // Young's Modulus, Poisson's ratio, yield stress, effective surface energy, psi_b, coefficent of restitution contact_radius_flag = 1; size_history = 26; + fix_mdr_flag = 0; nondefault_history_transfer = 1; transfer_history_factor = new double[size_history]; @@ -425,6 +427,14 @@ GranSubModNormalMDR::GranSubModNormalMDR(GranularModel *gm, LAMMPS *lmp) : /* ---------------------------------------------------------------------- */ +GranSubModNormalMDR::~GranSubModNormalMDR() +{ + if (fix_mdr_flag) + modify->delete_fix("MDR"); +} + +/* ---------------------------------------------------------------------- */ + void GranSubModNormalMDR::coeffs_to_local() { E = coeffs[0]; // Young's modulus @@ -444,6 +454,57 @@ void GranSubModNormalMDR::coeffs_to_local() /* ---------------------------------------------------------------------- */ +void GranSubModNormalMDR::init() +{ + if (!fix_mdr_flag) { + if (modify->get_fix_by_style("MDR").size() == 0) + modify->add_fix("MDR all GRANULAR/MDR"); + fix_mdr_flag = 1; + } + + // initialize particle history variables + int tmp1, tmp2; + int index_Ro = atom->find_custom("Ro", tmp1, tmp2); // initial radius + int index_Vcaps = atom->find_custom("Vcaps", tmp1, tmp2); // spherical cap volume from intersection of apparent radius particle and contact planes + int index_Vgeo = atom->find_custom("Vgeo", tmp1, tmp2); // geometric particle volume of apparent particle after removing spherical cap volume + int index_Velas = atom->find_custom("Velas", tmp1, tmp2); // particle volume from linear elasticity + int index_eps_bar = atom->find_custom("eps_bar", tmp1, tmp2); // volume-averaged infinitesimal strain tensor + int index_dRnumerator = atom->find_custom("dRnumerator", tmp1, tmp2); // summation of numerator terms in calculation of dR + int index_dRdenominator = atom->find_custom("dRdenominator", tmp1, tmp2); // summation of denominator terms in calculation of dR + int index_Acon0 = atom->find_custom("Acon0", tmp1, tmp2); // total area involved in contacts: Acon^{n} + int index_Acon1 = atom->find_custom("Acon1", tmp1, tmp2); // total area involved in contacts: Acon^{n+1} + int index_Atot = atom->find_custom("Atot", tmp1, tmp2); // total particle area + int index_Atot_sum = atom->find_custom("Atot_sum", tmp1, tmp2); // running sum of contact area minus cap area + int index_ddelta_bar = atom->find_custom("ddelta_bar", tmp1, tmp2); // change in mean surface displacement + int index_psi = atom->find_custom("psi", tmp1, tmp2); // ratio of free surface area to total surface area + int index_sigmaxx = atom->find_custom("sigmaxx", tmp1, tmp2); // xx-component of the stress tensor, not necessary for force calculation + int index_sigmayy = atom->find_custom("sigmayy", tmp1, tmp2); // yy-component of the stress tensor, not necessary for force calculation + int index_sigmazz = atom->find_custom("sigmazz", tmp1, tmp2); // zz-component of the stress tensor, not necessary for force calculation + int index_contacts = atom->find_custom("contacts", tmp1, tmp2); // total contacts on particle + int index_adhesive_length = atom->find_custom("adhesive_length", tmp1, tmp2); // total contacts on particle + + Rinitial = atom->dvector[index_Ro]; + Vgeo = atom->dvector[index_Vgeo]; + Velas = atom->dvector[index_Velas]; + Vcaps = atom->dvector[index_Vcaps]; + eps_bar = atom->dvector[index_eps_bar]; + dRnumerator = atom->dvector[index_dRnumerator]; + dRdenominator = atom->dvector[index_dRdenominator]; + Acon0 = atom->dvector[index_Acon0]; + Acon1 = atom->dvector[index_Acon1]; + Atot = atom->dvector[index_Atot]; + Atot_sum = atom->dvector[index_Atot_sum]; + ddelta_bar = atom->dvector[index_ddelta_bar]; + psi = atom->dvector[index_psi]; + sigmaxx = atom->dvector[index_sigmaxx]; + sigmayy = atom->dvector[index_sigmayy]; + sigmazz = atom->dvector[index_sigmazz]; + contacts = atom->dvector[index_contacts]; + adhesive_length = atom->dvector[index_adhesive_length]; +} + +/* ---------------------------------------------------------------------- */ + double GranSubModNormalMDR::calculate_forces() { @@ -507,46 +568,6 @@ double GranSubModNormalMDR::calculate_forces() const int deltap_offset_0 = 24; const int deltap_offset_1 = 25; - - // initialize particle history variables - int tmp1, tmp2; - int index_Ro = atom->find_custom("Ro",tmp1,tmp2); // initial radius - int index_Vcaps = atom->find_custom("Vcaps",tmp1,tmp2); // spherical cap volume from intersection of apparent radius particle and contact planes - int index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); // geometric particle volume of apparent particle after removing spherical cap volume - int index_Velas = atom->find_custom("Velas",tmp1,tmp2); // particle volume from linear elasticity - int index_eps_bar = atom->find_custom("eps_bar",tmp1,tmp2); // volume-averaged infinitesimal strain tensor - int index_dRnumerator = atom->find_custom("dRnumerator",tmp1,tmp2); // summation of numerator terms in calculation of dR - int index_dRdenominator = atom->find_custom("dRdenominator",tmp1,tmp2); // summation of denominator terms in calculation of dR - int index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); // total area involved in contacts: Acon^{n} - int index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); // total area involved in contacts: Acon^{n+1} - int index_Atot = atom->find_custom("Atot",tmp1,tmp2); // total particle area - int index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); // running sum of contact area minus cap area - int index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); // change in mean surface displacement - int index_psi = atom->find_custom("psi",tmp1,tmp2); // ratio of free surface area to total surface area - int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); // xx-component of the stress tensor, not necessary for force calculation - int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); // yy-component of the stress tensor, not necessary for force calculation - int index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); // zz-component of the stress tensor, not necessary for force calculation - int index_contacts = atom->find_custom("contacts",tmp1,tmp2); // total contacts on particle - int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); // total contacts on particle - double * Rinitial = atom->dvector[index_Ro]; - double * Vgeo = atom->dvector[index_Vgeo]; - double * Velas = atom->dvector[index_Velas]; - double * Vcaps = atom->dvector[index_Vcaps]; - double * eps_bar = atom->dvector[index_eps_bar]; - double * dRnumerator = atom->dvector[index_dRnumerator]; - double * dRdenominator = atom->dvector[index_dRdenominator]; - double * Acon0 = atom->dvector[index_Acon0]; - double * Acon1 = atom->dvector[index_Acon1]; - double * Atot = atom->dvector[index_Atot]; - double * Atot_sum = atom->dvector[index_Atot_sum]; - double * ddelta_bar = atom->dvector[index_ddelta_bar]; - double * psi = atom->dvector[index_psi]; - double * sigmaxx = atom->dvector[index_sigmaxx]; - double * sigmayy = atom->dvector[index_sigmayy]; - double * sigmazz = atom->dvector[index_sigmazz]; - double * contacts = atom->dvector[index_contacts]; - double * adhesive_length = atom->dvector[index_adhesive_length]; - double * history = & gm->history[history_index]; // load in all history variables // Rigid flat placement scheme diff --git a/src/GRANULAR/gran_sub_mod_normal.h b/src/GRANULAR/gran_sub_mod_normal.h index bfd6121ec8..29e201245a 100644 --- a/src/GRANULAR/gran_sub_mod_normal.h +++ b/src/GRANULAR/gran_sub_mod_normal.h @@ -139,13 +139,20 @@ namespace Granular_NS { class GranSubModNormalMDR : public GranSubModNormal { public: GranSubModNormalMDR(class GranularModel *, class LAMMPS *); + ~GranSubModNormalMDR() override; void coeffs_to_local() override; + void init() override; double calculate_forces() override; void set_fncrit() override; double psi_b; protected: double E, nu, Y, gamma, CoR, F; + + double *Rinitial, *Vgeo, *Velas, *Vcaps, *eps_bar, *dRnumerator; + double *dRdenominator, *Acon0, *Acon1, *Atot, *Atot_sum, *ddelta_bar; + double *psi, *sigmaxx, *sigmayy, *sigmazz, *contacts, *adhesive_length; + int fix_mdr_flag; }; } // namespace Granular_NS diff --git a/src/GRANULAR/pair_granular.cpp b/src/GRANULAR/pair_granular.cpp index 23522608c8..fe0c75a2af 100644 --- a/src/GRANULAR/pair_granular.cpp +++ b/src/GRANULAR/pair_granular.cpp @@ -78,8 +78,6 @@ PairGranular::PairGranular(LAMMPS *lmp) : Pair(lmp) fix_history = nullptr; fix_dummy = dynamic_cast(modify->add_fix("NEIGH_HISTORY_GRANULAR_DUMMY all DUMMY")); - - fix_flag = 0; } /* ---------------------------------------------------------------------- */ @@ -475,41 +473,6 @@ void PairGranular::init_style() if (!fix_history) error->all(FLERR,"Could not find pair fix neigh history ID"); } - if (model->sub_models[NORMAL]->name == "mdr") { - //Store persistent per atom quantities - if (! fix_flag) { - int tmp1, tmp2; - const char * id_fix = "MDR_PARTICLE_HISTORY_VARIABLES"; - modify->add_fix(fmt::format("{} all property/atom d_Ro d_Vcaps d_Vgeo d_Velas d_eps_bar d_dRnumerator d_dRdenominator d_Acon0 d_Acon1 d_Atot d_Atot_sum d_ddelta_bar d_psi d_psi_b d_history_setup_flag d_sigmaxx d_sigmayy d_sigmazz d_contacts d_adhesive_length ghost yes", id_fix)); - // d2_volSums 4 --> allows an array of 4 to defined. - index_Ro = atom->find_custom("Ro",tmp1,tmp2); // initial radius - index_Vcaps = atom->find_custom("Vcaps",tmp1,tmp2); // spherical cap volume from intersection of apparent radius particle and contact planes - index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); // geometric particle volume of apparent particle after removing spherical cap volume - index_Velas = atom->find_custom("Velas",tmp1,tmp2); // particle volume from linear elasticity - index_eps_bar = atom->find_custom("eps_bar",tmp1,tmp2); // volume-averaged infinitesimal strain tensor - index_dRnumerator = atom->find_custom("dRnumerator",tmp1,tmp2); // summation of numerator terms in calculation of dR - index_dRdenominator = atom->find_custom("dRdenominator",tmp1,tmp2); // summation of denominator terms in calculation of dR - index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); // total area involved in contacts: Acon^{n} - index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); // total area involved in contacts: Acon^{n+1} - index_Atot = atom->find_custom("Atot",tmp1,tmp2); // total particle area - index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); // running sum of contact area minus cap area - index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); // change in mean surface displacement - index_psi = atom->find_custom("psi",tmp1,tmp2); // ratio of free surface area to total surface area - index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); // TEMPORARY, SINCE PSI_B IS ALREADY DEFINED IN THE INPUT SCRIPT - index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); // flag to check if history variables have been initialized - index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); // xx-component of the stress tensor, not necessary for force calculation - index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); // yy-component of the stress tensor, not necessary for force calculation - index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); // zz-component of the stress tensor, not necessary for force calculation - index_contacts = atom->find_custom("contacts",tmp1,tmp2); // total contacts on particle - index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); // total length of adhesive contact on a particle - - // Initiate MDR radius update fix - modify->add_fix("fix_mdr all GRANULAR/MDR"); - - fix_flag = 1; - } - } - // check for FixFreeze and set freeze_group_bit auto fixlist = modify->get_fix_by_style("^freeze"); diff --git a/src/GRANULAR/pair_granular.h b/src/GRANULAR/pair_granular.h index 490133be09..1454291cd8 100644 --- a/src/GRANULAR/pair_granular.h +++ b/src/GRANULAR/pair_granular.h @@ -53,8 +53,6 @@ class PairGranular : public Pair { int **types_indices; int nmodels, maxmodels; - class FixStoreAtom * fix_store; - protected: int freeze_group_bit; int use_history; @@ -67,29 +65,6 @@ class PairGranular : public Pair { class FixDummy *fix_dummy; class FixNeighHistory *fix_history; - // MDR particle history variables - int fix_flag; - int index_Ro; - int index_Vcaps; - int index_Vgeo; - int index_Velas; - int index_eps_bar; - int index_dRnumerator; - int index_dRdenominator; - int index_Acon0; - int index_Acon1; - int index_Atot; - int index_Atot_sum; - int index_ddelta_bar; - int index_psi; - int index_psi_b; - int index_history_setup_flag; - int index_sigmaxx; - int index_sigmayy; - int index_sigmazz; - int index_contacts; - int index_adhesive_length; - // storage of rigid body masses for use in granular interactions class Fix *fix_rigid; // ptr to rigid body fix, null pointer if none From 82b0687a15519673b26558a1ed62af46f8921110 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Wed, 18 Dec 2024 21:10:46 -0700 Subject: [PATCH 15/74] More robust dvector handling --- src/GRANULAR/fix_granular_mdr.cpp | 211 ++++++++++++++++----------- src/GRANULAR/fix_granular_mdr.h | 41 +++--- src/GRANULAR/gran_sub_mod_normal.cpp | 74 +++++----- src/GRANULAR/gran_sub_mod_normal.h | 6 +- 4 files changed, 189 insertions(+), 143 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index 68d9dd4e5e..788fa1f553 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -55,6 +55,8 @@ FixGranularMDR::FixGranularMDR(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) { comm_forward = 20; // value needs to match number of values you communicate + create_attribute = 1; + id_fix = nullptr; } @@ -82,47 +84,26 @@ void FixGranularMDR::post_constructor() id_fix = utils::strdup("MDR_PARTICLE_HISTORY_VARIABLES"); modify->add_fix(fmt::format("{} all property/atom d_Ro d_Vcaps d_Vgeo d_Velas d_eps_bar d_dRnumerator d_dRdenominator d_Acon0 d_Acon1 d_Atot d_Atot_sum d_ddelta_bar d_psi d_psi_b d_history_setup_flag d_sigmaxx d_sigmayy d_sigmazz d_contacts d_adhesive_length ghost yes", id_fix)); - int index_Ro = atom->find_custom("Ro",tmp1,tmp2); - int index_Vcaps = atom->find_custom("Vcaps",tmp1,tmp2); - int index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); - int index_Velas = atom->find_custom("Velas",tmp1,tmp2); - int index_eps_bar = atom->find_custom("eps_bar",tmp1,tmp2); - int index_dRnumerator = atom->find_custom("dRnumerator",tmp1,tmp2); - int index_dRdenominator = atom->find_custom("dRdenominator",tmp1,tmp2); - int index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); - int index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); - int index_Atot = atom->find_custom("Atot",tmp1,tmp2); - int index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); - int index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); - int index_psi = atom->find_custom("psi",tmp1,tmp2); - int index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); - int index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); - int index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); - int index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); - int index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); - int index_contacts = atom->find_custom("contacts",tmp1,tmp2); - int index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); - - Ro = atom->dvector[index_Ro]; - Vgeo = atom->dvector[index_Vgeo]; - Velas = atom->dvector[index_Velas]; - Vcaps = atom->dvector[index_Vcaps]; - eps_bar = atom->dvector[index_eps_bar]; - dRnumerator = atom->dvector[index_dRnumerator]; - dRdenominator = atom->dvector[index_dRdenominator]; - Acon0 = atom->dvector[index_Acon0]; - Acon1 = atom->dvector[index_Acon1]; - Atot = atom->dvector[index_Atot]; - Atot_sum = atom->dvector[index_Atot_sum]; - ddelta_bar = atom->dvector[index_ddelta_bar]; - psi = atom->dvector[index_psi]; - psi_b = atom->dvector[index_psi_b]; - sigmaxx = atom->dvector[index_sigmaxx]; - sigmayy = atom->dvector[index_sigmayy]; - sigmazz = atom->dvector[index_sigmazz]; - history_setup_flag = atom->dvector[index_history_setup_flag]; - contacts = atom->dvector[index_contacts]; - adhesive_length = atom->dvector[index_adhesive_length]; + index_Ro = atom->find_custom("Ro",tmp1,tmp2); + index_Vcaps = atom->find_custom("Vcaps",tmp1,tmp2); + index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); + index_Velas = atom->find_custom("Velas",tmp1,tmp2); + index_eps_bar = atom->find_custom("eps_bar",tmp1,tmp2); + index_dRnumerator = atom->find_custom("dRnumerator",tmp1,tmp2); + index_dRdenominator = atom->find_custom("dRdenominator",tmp1,tmp2); + index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); + index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); + index_Atot = atom->find_custom("Atot",tmp1,tmp2); + index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); + index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); + index_psi = atom->find_custom("psi",tmp1,tmp2); + index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); + index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); + index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); + index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); + index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); + index_contacts = atom->find_custom("contacts",tmp1,tmp2); + index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); } /* ---------------------------------------------------------------------- */ @@ -165,35 +146,36 @@ void FixGranularMDR::pre_force(int) int FixGranularMDR::pack_forward_comm(int n, int *list, double *buf, int /*pbc_flag*/,int * /*pbc*/) { + double **dvector = atom->dvector; int m = 0; if (comm_stage == RADIUS_UPDATE) { for (int i = 0; i < n; i++) { int j = list[i]; - buf[m++] = Ro[j]; // 1 - buf[m++] = Vgeo[j]; // 2 - buf[m++] = Velas[j]; // 3 - buf[m++] = Vcaps[j]; // 4 - buf[m++] = eps_bar[j]; // 5 - buf[m++] = dRnumerator[j]; // 6 - buf[m++] = dRdenominator[j]; // 7 - buf[m++] = Acon0[j]; // 8 - buf[m++] = Acon1[j]; // 9 - buf[m++] = Atot[j]; // 10 - buf[m++] = Atot_sum[j]; // 11 - buf[m++] = ddelta_bar[j]; // 12 - buf[m++] = psi[j]; // 13 - buf[m++] = psi_b[j]; // 14 - buf[m++] = sigmaxx[j]; // 15 - buf[m++] = sigmayy[j]; // 16 - buf[m++] = sigmazz[j]; // 17 - buf[m++] = history_setup_flag[j]; // 18 - buf[m++] = contacts[j]; // 19 - buf[m++] = adhesive_length[j]; // 20 + buf[m++] = dvector[index_Ro][j]; // 1 + buf[m++] = dvector[index_Vgeo][j]; // 2 + buf[m++] = dvector[index_Velas][j]; // 3 + buf[m++] = dvector[index_Vcaps][j]; // 4 + buf[m++] = dvector[index_eps_bar][j]; // 5 + buf[m++] = dvector[index_dRnumerator][j]; // 6 + buf[m++] = dvector[index_dRdenominator][j]; // 7 + buf[m++] = dvector[index_Acon0][j]; // 8 + buf[m++] = dvector[index_Acon1][j]; // 9 + buf[m++] = dvector[index_Atot][j]; // 10 + buf[m++] = dvector[index_Atot_sum][j]; // 11 + buf[m++] = dvector[index_ddelta_bar][j]; // 12 + buf[m++] = dvector[index_psi][j]; // 13 + buf[m++] = dvector[index_psi_b][j]; // 14 + buf[m++] = dvector[index_sigmaxx][j]; // 15 + buf[m++] = dvector[index_sigmayy][j]; // 16 + buf[m++] = dvector[index_sigmazz][j]; // 17 + buf[m++] = dvector[index_history_setup_flag][j]; // 18 + buf[m++] = dvector[index_contacts][j]; // 19 + buf[m++] = dvector[index_adhesive_length][j]; // 20 } } else { for (int i = 0; i < n; i++) { int j = list[i]; - buf[m++] = ddelta_bar[j]; + buf[m++] = dvector[index_ddelta_bar][j]; } } return m; @@ -203,35 +185,36 @@ int FixGranularMDR::pack_forward_comm(int n, int *list, double *buf, int /*pbc_f void FixGranularMDR::unpack_forward_comm(int n, int first, double *buf) { + double **dvector = atom->dvector; int m = 0; int last = first + n; if (comm_stage == RADIUS_UPDATE) { for (int i = first; i < last; i++) { - Ro[i] = buf[m++]; // 1 - Vgeo[i] = buf[m++]; // 2 - Velas[i] = buf[m++]; // 3 - Vcaps[i] = buf[m++]; // 4 - eps_bar[i] = buf[m++]; // 5 - dRnumerator[i] = buf[m++]; // 6 - dRdenominator[i] = buf[m++]; // 7 - Acon0[i] = buf[m++]; // 8 - Acon1[i] = buf[m++]; // 9 - Atot[i] = buf[m++]; // 10 - Atot_sum[i] = buf[m++]; // 11 - ddelta_bar[i] = buf[m++]; // 12 - psi[i] = buf[m++]; // 13 - psi_b[i] = buf[m++]; // 14 - sigmaxx[i] = buf[m++]; // 15 - sigmayy[i] = buf[m++]; // 16 - sigmazz[i] = buf[m++]; // 17 - history_setup_flag[i] = buf[m++]; // 18 - contacts[i] = buf[m++]; // 19 - adhesive_length[i] = buf[m++]; // 20 + dvector[index_Ro][i] = buf[m++]; // 1 + dvector[index_Vgeo][i] = buf[m++]; // 2 + dvector[index_Velas][i] = buf[m++]; // 3 + dvector[index_Vcaps][i] = buf[m++]; // 4 + dvector[index_eps_bar][i] = buf[m++]; // 5 + dvector[index_dRnumerator][i] = buf[m++]; // 6 + dvector[index_dRdenominator][i] = buf[m++]; // 7 + dvector[index_Acon0][i] = buf[m++]; // 8 + dvector[index_Acon1][i] = buf[m++]; // 9 + dvector[index_Atot][i] = buf[m++]; // 10 + dvector[index_Atot_sum][i] = buf[m++]; // 11 + dvector[index_ddelta_bar][i] = buf[m++]; // 12 + dvector[index_psi][i] = buf[m++]; // 13 + dvector[index_psi_b][i] = buf[m++]; // 14 + dvector[index_sigmaxx][i] = buf[m++]; // 15 + dvector[index_sigmayy][i] = buf[m++]; // 16 + dvector[index_sigmazz][i] = buf[m++]; // 17 + dvector[index_history_setup_flag][i] = buf[m++]; // 18 + dvector[index_contacts][i] = buf[m++]; // 19 + dvector[index_adhesive_length][i] = buf[m++]; // 20 } } else { for (int i = first; i < last; i++) { - ddelta_bar[i] = buf[m++]; + dvector[index_ddelta_bar][i] = buf[m++]; } } } @@ -244,6 +227,21 @@ void FixGranularMDR::end_of_step() double *radius = atom->radius; int nlocal = atom->nlocal; + double *Ro = atom->dvector[index_Ro]; + double *Vgeo = atom->dvector[index_Vgeo]; + double *Velas = atom->dvector[index_Velas]; + double *Vcaps = atom->dvector[index_Vcaps]; + double *eps_bar = atom->dvector[index_eps_bar]; + double *dRnumerator = atom->dvector[index_dRnumerator]; + double *dRdenominator = atom->dvector[index_dRdenominator]; + double *Acon0 = atom->dvector[index_Acon0]; + double *Acon1 = atom->dvector[index_Acon1]; + double *Atot = atom->dvector[index_Atot]; + double *Atot_sum = atom->dvector[index_Atot_sum]; + double *ddelta_bar = atom->dvector[index_ddelta_bar]; + double *psi = atom->dvector[index_psi]; + double *psi_b = atom->dvector[index_psi_b]; + for (int i = 0; i < nlocal; i++) { const double R = radius[i]; @@ -276,6 +274,34 @@ void FixGranularMDR::end_of_step() } +/* ---------------------------------------------------------------------- + initialize values to zero, called when atom is created +------------------------------------------------------------------------- */ + +void FixGranularMDR::set_arrays(int i) +{ + atom->dvector[index_Ro][i] = 0.0; + atom->dvector[index_Vgeo][i] = 0.0; + atom->dvector[index_Velas][i] = 0.0; + atom->dvector[index_Vcaps][i] = 0.0; + atom->dvector[index_eps_bar][i] = 0.0; + atom->dvector[index_dRnumerator][i] = 0.0; + atom->dvector[index_dRdenominator][i] = 0.0; + atom->dvector[index_Acon0][i] = 0.0; + atom->dvector[index_Acon1][i] = 0.0; + atom->dvector[index_Atot][i] = 0.0; + atom->dvector[index_Atot_sum][i] = 0.0; + atom->dvector[index_ddelta_bar][i] = 0.0; + atom->dvector[index_psi][i] = 0.0; + atom->dvector[index_psi_b][i] = 0.0; + atom->dvector[index_sigmaxx][i] = 0.0; + atom->dvector[index_sigmayy][i] = 0.0; + atom->dvector[index_sigmazz][i] = 0.0; + atom->dvector[index_history_setup_flag][i] = 0.0; + atom->dvector[index_contacts][i] = 0.0; + atom->dvector[index_adhesive_length][i] = 0.0; +} + /* ---------------------------------------------------------------------- calculate updated radius for atoms ------------------------------------------------------------------------- */ @@ -295,6 +321,19 @@ void FixGranularMDR::radius_update() double *radius = atom->radius; int nlocal = atom->nlocal; + double *Ro = atom->dvector[index_Ro]; + double *Vgeo = atom->dvector[index_Vgeo]; + double *Velas = atom->dvector[index_Velas]; + double *Atot = atom->dvector[index_Atot]; + double *psi = atom->dvector[index_psi]; + double *psi_b = atom->dvector[index_psi_b]; + double *sigmaxx = atom->dvector[index_sigmaxx]; + double *sigmayy = atom->dvector[index_sigmayy]; + double *sigmazz = atom->dvector[index_sigmazz]; + double *contacts = atom->dvector[index_contacts]; + double *adhesive_length = atom->dvector[index_adhesive_length]; + double *history_setup_flag = atom->dvector[index_history_setup_flag]; + for (int i = 0; i < nlocal; i++) { if (history_setup_flag[i] < 1e-16) { Ro[i] = radius[i]; @@ -501,6 +540,9 @@ void FixGranularMDR::mean_surf_disp() double *radius = atom->radius; int nlocal = atom->nlocal; + double *Acon0 = atom->dvector[index_Acon0]; + double *ddelta_bar = atom->dvector[index_ddelta_bar]; + inum = list->inum; ilist = list->ilist; numneigh = list->numneigh; @@ -641,6 +683,9 @@ void FixGranularMDR::update_fix_gran_wall(Fix* fix_in) int *mask = atom->mask; int nlocal = atom->nlocal; + double *Acon0 = atom->dvector[index_Acon0]; + double *ddelta_bar = atom->dvector[index_ddelta_bar]; + if (regiondynamic) { region->prematch(); region->set_velocity(); diff --git a/src/GRANULAR/fix_granular_mdr.h b/src/GRANULAR/fix_granular_mdr.h index 319300cc7b..4261cbbd70 100644 --- a/src/GRANULAR/fix_granular_mdr.h +++ b/src/GRANULAR/fix_granular_mdr.h @@ -36,6 +36,7 @@ class FixGranularMDR : public Fix { void end_of_step() override; int pack_forward_comm(int, int *, double *, int, int *) override; void unpack_forward_comm(int, int, double *) override; + void set_arrays(int) override; private: int comm_stage; @@ -46,26 +47,26 @@ class FixGranularMDR : public Fix { void calculate_contact_penalty(); void update_fix_gran_wall(Fix*); - double *Ro; // initial radius - double *Vgeo; // geometric particle volume of apparent particle afterremoving spherical cap volume - double *Velas; // particle volume from linear elasticity - double *Vcaps; // spherical cap volume from intersection of apparentradius particle and contact planes - double *eps_bar; // volume-averaged infinitesimal strain tensor - double *dRnumerator; // summation of numerator terms in calculation of dR - double *dRdenominator; // summation of denominator terms in calculation of dR - double *Acon0; // total area involved in contacts: Acon^{n} - double *Acon1; // total area involved in contacts: Acon^{n+1} - double *Atot; // total particle area - double *Atot_sum; // running sum of contact area minus cap area - double *ddelta_bar; // change in mean surface displacement - double *psi; // ratio of free surface area to total surface area - double *psi_b; // TEMPORARY, SINCE PSI_B IS ALREADY DEFINED IN THEINPUT SCRIPT - double *sigmaxx; // xx-component of the stress tensor, not necessary forforce calculation - double *sigmayy; // yy-component of the stress tensor, not necessary forforce calculation - double *sigmazz; // zz-component of the stress tensor, not necessary forforce calculation - double *history_setup_flag; // flag to check if history variables have beeninitialized - double *contacts; // total contacts on particle - double *adhesive_length; // total length of adhesive contact on a particle + int index_Ro; // initial radius + int index_Vgeo; // geometric particle volume of apparent particle afterremoving spherical cap volume + int index_Velas; // particle volume from linear elasticity + int index_Vcaps; // spherical cap volume from intersection of apparentradius particle and contact planes + int index_eps_bar; // volume-averaged infinitesimal strain tensor + int index_dRnumerator; // summation of numerator terms in calculation of dR + int index_dRdenominator; // summation of denominator terms in calculation of dR + int index_Acon0; // total area involved in contacts: Acon^{n} + int index_Acon1; // total area involved in contacts: Acon^{n+1} + int index_Atot; // total particle area + int index_Atot_sum; // running sum of contact area minus cap area + int index_ddelta_bar; // change in mean surface displacement + int index_psi; // ratio of free surface area to total surface area + int index_psi_b; // TEMPORARY, SINCE PSI_B IS ALREADY DEFINED IN THEINPUT SCRIPT + int index_sigmaxx; // xx-component of the stress tensor, not necessary forforce calculation + int index_sigmayy; // yy-component of the stress tensor, not necessary forforce calculation + int index_sigmazz; // zz-component of the stress tensor, not necessary forforce calculation + int index_history_setup_flag; // flag to check if history variables have beeninitialized + int index_contacts; // total contacts on particle + int index_adhesive_length; // total length of adhesive contact on a particle }; } // namespace LAMMPS_NS diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 9eddc827ff..855f441e84 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -464,43 +464,24 @@ void GranSubModNormalMDR::init() // initialize particle history variables int tmp1, tmp2; - int index_Ro = atom->find_custom("Ro", tmp1, tmp2); // initial radius - int index_Vcaps = atom->find_custom("Vcaps", tmp1, tmp2); // spherical cap volume from intersection of apparent radius particle and contact planes - int index_Vgeo = atom->find_custom("Vgeo", tmp1, tmp2); // geometric particle volume of apparent particle after removing spherical cap volume - int index_Velas = atom->find_custom("Velas", tmp1, tmp2); // particle volume from linear elasticity - int index_eps_bar = atom->find_custom("eps_bar", tmp1, tmp2); // volume-averaged infinitesimal strain tensor - int index_dRnumerator = atom->find_custom("dRnumerator", tmp1, tmp2); // summation of numerator terms in calculation of dR - int index_dRdenominator = atom->find_custom("dRdenominator", tmp1, tmp2); // summation of denominator terms in calculation of dR - int index_Acon0 = atom->find_custom("Acon0", tmp1, tmp2); // total area involved in contacts: Acon^{n} - int index_Acon1 = atom->find_custom("Acon1", tmp1, tmp2); // total area involved in contacts: Acon^{n+1} - int index_Atot = atom->find_custom("Atot", tmp1, tmp2); // total particle area - int index_Atot_sum = atom->find_custom("Atot_sum", tmp1, tmp2); // running sum of contact area minus cap area - int index_ddelta_bar = atom->find_custom("ddelta_bar", tmp1, tmp2); // change in mean surface displacement - int index_psi = atom->find_custom("psi", tmp1, tmp2); // ratio of free surface area to total surface area - int index_sigmaxx = atom->find_custom("sigmaxx", tmp1, tmp2); // xx-component of the stress tensor, not necessary for force calculation - int index_sigmayy = atom->find_custom("sigmayy", tmp1, tmp2); // yy-component of the stress tensor, not necessary for force calculation - int index_sigmazz = atom->find_custom("sigmazz", tmp1, tmp2); // zz-component of the stress tensor, not necessary for force calculation - int index_contacts = atom->find_custom("contacts", tmp1, tmp2); // total contacts on particle - int index_adhesive_length = atom->find_custom("adhesive_length", tmp1, tmp2); // total contacts on particle - - Rinitial = atom->dvector[index_Ro]; - Vgeo = atom->dvector[index_Vgeo]; - Velas = atom->dvector[index_Velas]; - Vcaps = atom->dvector[index_Vcaps]; - eps_bar = atom->dvector[index_eps_bar]; - dRnumerator = atom->dvector[index_dRnumerator]; - dRdenominator = atom->dvector[index_dRdenominator]; - Acon0 = atom->dvector[index_Acon0]; - Acon1 = atom->dvector[index_Acon1]; - Atot = atom->dvector[index_Atot]; - Atot_sum = atom->dvector[index_Atot_sum]; - ddelta_bar = atom->dvector[index_ddelta_bar]; - psi = atom->dvector[index_psi]; - sigmaxx = atom->dvector[index_sigmaxx]; - sigmayy = atom->dvector[index_sigmayy]; - sigmazz = atom->dvector[index_sigmazz]; - contacts = atom->dvector[index_contacts]; - adhesive_length = atom->dvector[index_adhesive_length]; + index_Ro = atom->find_custom("Ro", tmp1, tmp2); // initial radius + index_Vcaps = atom->find_custom("Vcaps", tmp1, tmp2); // spherical cap volume from intersection of apparent radius particle and contact planes + index_Vgeo = atom->find_custom("Vgeo", tmp1, tmp2); // geometric particle volume of apparent particle after removing spherical cap volume + index_Velas = atom->find_custom("Velas", tmp1, tmp2); // particle volume from linear elasticity + index_eps_bar = atom->find_custom("eps_bar", tmp1, tmp2); // volume-averaged infinitesimal strain tensor + index_dRnumerator = atom->find_custom("dRnumerator", tmp1, tmp2); // summation of numerator terms in calculation of dR + index_dRdenominator = atom->find_custom("dRdenominator", tmp1, tmp2); // summation of denominator terms in calculation of dR + index_Acon0 = atom->find_custom("Acon0", tmp1, tmp2); // total area involved in contacts: Acon^{n} + index_Acon1 = atom->find_custom("Acon1", tmp1, tmp2); // total area involved in contacts: Acon^{n+1} + index_Atot = atom->find_custom("Atot", tmp1, tmp2); // total particle area + index_Atot_sum = atom->find_custom("Atot_sum", tmp1, tmp2); // running sum of contact area minus cap area + index_ddelta_bar = atom->find_custom("ddelta_bar", tmp1, tmp2); // change in mean surface displacement + index_psi = atom->find_custom("psi", tmp1, tmp2); // ratio of free surface area to total surface area + index_sigmaxx = atom->find_custom("sigmaxx", tmp1, tmp2); // xx-component of the stress tensor, not necessary for force calculation + index_sigmayy = atom->find_custom("sigmayy", tmp1, tmp2); // yy-component of the stress tensor, not necessary for force calculation + index_sigmazz = atom->find_custom("sigmazz", tmp1, tmp2); // zz-component of the stress tensor, not necessary for force calculation + index_contacts = atom->find_custom("contacts", tmp1, tmp2); // total contacts on particle + index_adhesive_length = atom->find_custom("adhesive_length", tmp1, tmp2); // total contacts on particle } /* ---------------------------------------------------------------------- */ @@ -524,6 +505,25 @@ double GranSubModNormalMDR::calculate_forces() // Zunker and Kamrin, 2024, Part II: https://doi.org/10.1016/j.jmps.2023.105493 // Zunker, Dunatunga, Thakur, Tang, and Kamrin, 2025: + double *Rinitial = atom->dvector[index_Ro]; + double *Vgeo = atom->dvector[index_Vgeo]; + double *Velas = atom->dvector[index_Velas]; + double *Vcaps = atom->dvector[index_Vcaps]; + double *eps_bar = atom->dvector[index_eps_bar]; + double *dRnumerator = atom->dvector[index_dRnumerator]; + double *dRdenominator = atom->dvector[index_dRdenominator]; + double *Acon0 = atom->dvector[index_Acon0]; + double *Acon1 = atom->dvector[index_Acon1]; + double *Atot = atom->dvector[index_Atot]; + double *Atot_sum = atom->dvector[index_Atot_sum]; + double *ddelta_bar = atom->dvector[index_ddelta_bar]; + double *psi = atom->dvector[index_psi]; + double *sigmaxx = atom->dvector[index_sigmaxx]; + double *sigmayy = atom->dvector[index_sigmayy]; + double *sigmazz = atom->dvector[index_sigmazz]; + double *contacts = atom->dvector[index_contacts]; + double *adhesive_length = atom->dvector[index_adhesive_length]; + const int itag_true = atom->tag[gm->i]; // true i particle tag const int jtag_true = atom->tag[gm->j]; // true j particle tag const int i_true = gm->i; // true i particle index diff --git a/src/GRANULAR/gran_sub_mod_normal.h b/src/GRANULAR/gran_sub_mod_normal.h index 29e201245a..53ce52978c 100644 --- a/src/GRANULAR/gran_sub_mod_normal.h +++ b/src/GRANULAR/gran_sub_mod_normal.h @@ -149,9 +149,9 @@ namespace Granular_NS { protected: double E, nu, Y, gamma, CoR, F; - double *Rinitial, *Vgeo, *Velas, *Vcaps, *eps_bar, *dRnumerator; - double *dRdenominator, *Acon0, *Acon1, *Atot, *Atot_sum, *ddelta_bar; - double *psi, *sigmaxx, *sigmayy, *sigmazz, *contacts, *adhesive_length; + int index_Ro, index_Vgeo, index_Velas, index_Vcaps, index_eps_bar, index_dRnumerator; + int index_dRdenominator, index_Acon0, index_Acon1, index_Atot, index_Atot_sum, index_ddelta_bar; + int index_psi, index_sigmaxx, index_sigmayy, index_sigmazz, index_contacts, index_adhesive_length; int fix_mdr_flag; }; From 1717840c3f0acae1554d089d390fc2a7bc2cf5e1 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Thu, 19 Dec 2024 11:38:22 -0700 Subject: [PATCH 16/74] Fixing deconstructors --- src/GRANULAR/fix_granular_mdr.cpp | 4 +++- src/GRANULAR/gran_sub_mod_normal.cpp | 12 ++++++++---- src/GRANULAR/gran_sub_mod_normal.h | 2 ++ 3 files changed, 13 insertions(+), 5 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index 788fa1f553..fbcda42af2 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -64,7 +64,9 @@ FixGranularMDR::FixGranularMDR(LAMMPS *lmp, int narg, char **arg) : FixGranularMDR::~FixGranularMDR() { - if (id_fix) modify->delete_fix(id_fix); + if (id_fix && modify->nfix) + modify->delete_fix(id_fix); + delete[] id_fix; } /* ---------------------------------------------------------------------- */ diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 855f441e84..f08de89d42 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -416,6 +416,7 @@ GranSubModNormalMDR::GranSubModNormalMDR(GranularModel *gm, LAMMPS *lmp) : contact_radius_flag = 1; size_history = 26; fix_mdr_flag = 0; + id_fix = nullptr; nondefault_history_transfer = 1; transfer_history_factor = new double[size_history]; @@ -429,8 +430,9 @@ GranSubModNormalMDR::GranSubModNormalMDR(GranularModel *gm, LAMMPS *lmp) : GranSubModNormalMDR::~GranSubModNormalMDR() { - if (fix_mdr_flag) - modify->delete_fix("MDR"); + if (id_fix && modify->nfix) + modify->delete_fix(id_fix); + delete[] id_fix; } /* ---------------------------------------------------------------------- */ @@ -457,8 +459,10 @@ void GranSubModNormalMDR::coeffs_to_local() void GranSubModNormalMDR::init() { if (!fix_mdr_flag) { - if (modify->get_fix_by_style("MDR").size() == 0) - modify->add_fix("MDR all GRANULAR/MDR"); + if (modify->get_fix_by_style("GRANULAR/MDR").size() == 0) { + id_fix = utils::strdup("MDR"); + modify->add_fix(fmt::format("{} all GRANULAR/MDR", id_fix)); + } fix_mdr_flag = 1; } diff --git a/src/GRANULAR/gran_sub_mod_normal.h b/src/GRANULAR/gran_sub_mod_normal.h index 53ce52978c..9741a24f4c 100644 --- a/src/GRANULAR/gran_sub_mod_normal.h +++ b/src/GRANULAR/gran_sub_mod_normal.h @@ -153,6 +153,8 @@ namespace Granular_NS { int index_dRdenominator, index_Acon0, index_Acon1, index_Atot, index_Atot_sum, index_ddelta_bar; int index_psi, index_sigmaxx, index_sigmayy, index_sigmazz, index_contacts, index_adhesive_length; int fix_mdr_flag; + + char *id_fix; }; } // namespace Granular_NS From 822f774fd0769d280e1ca467da821b34bc1a3bac Mon Sep 17 00:00:00 2001 From: jtclemm Date: Thu, 19 Dec 2024 11:50:57 -0700 Subject: [PATCH 17/74] Minor style clean ups --- src/GRANULAR/fix_wall_gran.h | 2 -- src/GRANULAR/fix_wall_gran_region.h | 14 +++++--------- src/GRANULAR/gran_sub_mod_normal.cpp | 1 - src/GRANULAR/gran_sub_mod_rolling.cpp | 2 +- src/GRANULAR/granular_model.h | 2 +- src/GRANULAR/pair_granular.cpp | 7 ------- src/GRANULAR/pair_granular.h | 2 +- 7 files changed, 8 insertions(+), 22 deletions(-) diff --git a/src/GRANULAR/fix_wall_gran.h b/src/GRANULAR/fix_wall_gran.h index 8964870b9f..85f3869ca9 100644 --- a/src/GRANULAR/fix_wall_gran.h +++ b/src/GRANULAR/fix_wall_gran.h @@ -86,8 +86,6 @@ class FixWallGran : public Fix { // store particle interactions int store; - - }; } // namespace LAMMPS_NS diff --git a/src/GRANULAR/fix_wall_gran_region.h b/src/GRANULAR/fix_wall_gran_region.h index 3f6fe453f0..2e455b316e 100644 --- a/src/GRANULAR/fix_wall_gran_region.h +++ b/src/GRANULAR/fix_wall_gran_region.h @@ -46,25 +46,21 @@ class FixWallGranRegion : public FixWallGran { class Region *region; void update_contacts(int, int); + + // shear history for multiple contacts per particle + int tmax; // max # of region walls one particle can touch int *ncontact; // # of shear contacts per particle int **walls; // which wall each contact is with double ***history_many; // history per particle per contact int *c2r; // contact to region mapping - + // c2r[i] = index of Ith contact in + // region-contact[] list of contacts private: int nregion; - - // shear history for multiple contacts per particle - - - // c2r[i] = index of Ith contact in - // region-contact[] list of contacts int motion_resetflag; // used by restart to indicate that region // vel info is to be reset - - }; } // namespace LAMMPS_NS diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index f08de89d42..0f32c74f9e 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -491,7 +491,6 @@ void GranSubModNormalMDR::init() /* ---------------------------------------------------------------------- */ double GranSubModNormalMDR::calculate_forces() - { // To understand the structure of the overall code it is important to consider // the following: diff --git a/src/GRANULAR/gran_sub_mod_rolling.cpp b/src/GRANULAR/gran_sub_mod_rolling.cpp index 109bbee65d..88647c3f45 100644 --- a/src/GRANULAR/gran_sub_mod_rolling.cpp +++ b/src/GRANULAR/gran_sub_mod_rolling.cpp @@ -46,7 +46,7 @@ GranSubModRollingNone::GranSubModRollingNone(GranularModel *gm, LAMMPS *lmp) : ------------------------------------------------------------------------- */ GranSubModRollingSDS::GranSubModRollingSDS(GranularModel *gm, LAMMPS *lmp) : - GranSubModRolling(gm, lmp), k{0.0}, mu{0.0}, gamma{0.0} + GranSubModRolling(gm, lmp) { num_coeffs = 3; size_history = 3; diff --git a/src/GRANULAR/granular_model.h b/src/GRANULAR/granular_model.h index 35364eb1a2..c514f736f7 100644 --- a/src/GRANULAR/granular_model.h +++ b/src/GRANULAR/granular_model.h @@ -74,7 +74,7 @@ class GranularModel : protected Pointers { int beyond_contact, limit_damping, history_update; ContactType contact_type; - // Particle indices + // Particle identifiers int i, j, itype, jtype; // History variables diff --git a/src/GRANULAR/pair_granular.cpp b/src/GRANULAR/pair_granular.cpp index fe0c75a2af..5cc9ddf2bc 100644 --- a/src/GRANULAR/pair_granular.cpp +++ b/src/GRANULAR/pair_granular.cpp @@ -708,8 +708,6 @@ double PairGranular::single(int i, int j, int itype, int jtype, class GranularModel* model = models_list[types_indices[itype][jtype]]; - - // Reset model and copy initial geometric data double **x = atom->x; double *radius = atom->radius; @@ -932,8 +930,3 @@ void PairGranular::prune_models() nmodels -= 1; } } - -size_t PairGranular::get_size_history() const -{ - return size_history; -} diff --git a/src/GRANULAR/pair_granular.h b/src/GRANULAR/pair_granular.h index 1454291cd8..c3f51a4a97 100644 --- a/src/GRANULAR/pair_granular.h +++ b/src/GRANULAR/pair_granular.h @@ -46,7 +46,7 @@ class PairGranular : public Pair { double memory_usage() override; double atom2cut(int) override; double radii2cut(double, double) override; - size_t get_size_history() const; + int get_size_history() const { return size_history; } // granular models class Granular_NS::GranularModel** models_list; From 8c6a1f01f50cf4ea3eadf96c617401157d8c97bd Mon Sep 17 00:00:00 2001 From: jtclemm Date: Fri, 20 Dec 2024 16:49:43 -0700 Subject: [PATCH 18/74] Misc cleanups to MDR normal submod --- src/GRANULAR/gran_sub_mod_normal.cpp | 57 ++++++++++------------------ src/GRANULAR/gran_sub_mod_normal.h | 4 +- 2 files changed, 24 insertions(+), 37 deletions(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 0f32c74f9e..09aea9f1b3 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -27,15 +27,14 @@ using namespace LAMMPS_NS; using namespace Granular_NS; - -using MathConst::MY_2PI; -using MathConst::MY_PI; +using namespace MathConst; static constexpr double PI27SQ = 266.47931882941264802866; // 27*PI**2 static constexpr double THREEROOT3 = 5.19615242270663202362; // 3*sqrt(3) static constexpr double SIXROOT6 = 14.69693845669906728801; // 6*sqrt(6) static constexpr double INVROOT6 = 0.40824829046386307274; // 1/sqrt(6) static constexpr double FOURTHIRDS = (4.0 / 3.0); // 4/3 +static constexpr double FIVETHIRDS = (5.0 / 3.0); // 5/3 static constexpr double JKRPREFIX = 1.2277228507842888; // cbrt(3*PI**2/16) static const char cite_mdr[] = @@ -412,7 +411,7 @@ GranSubModNormalMDR::GranSubModNormalMDR(GranularModel *gm, LAMMPS *lmp) : { if (lmp->citeme) lmp->citeme->add(cite_mdr); - num_coeffs = 6; // Young's Modulus, Poisson's ratio, yield stress, effective surface energy, psi_b, coefficent of restitution + num_coeffs = 6; contact_radius_flag = 1; size_history = 26; fix_mdr_flag = 0; @@ -420,7 +419,6 @@ GranSubModNormalMDR::GranSubModNormalMDR(GranularModel *gm, LAMMPS *lmp) : nondefault_history_transfer = 1; transfer_history_factor = new double[size_history]; - //transfer_history_factor[0] = +1; for (int i = 0; i < size_history; i++) { transfer_history_factor[i] = +1; } @@ -452,6 +450,10 @@ void GranSubModNormalMDR::coeffs_to_local() if (gamma < 0.0) error->all(FLERR, "Illegal MDR normal model, effective surface energy must be greater than or equal to 0"); if (psi_b < 0.0 || psi_b > 1.0) error->all(FLERR, "Illegal MDR normal model, psi_b must be between 0 and 1.0"); if (CoR < 0.0 || CoR > 1.0) error->all(FLERR, "Illegal MDR normal model, coefficent of restitution must be between 0 and 1.0"); + + G = E / (2.0 * (1.0 + nu)); // shear modulus + kappa = E / (3.0 * (1.0 - 2.0 * nu)); // bulk modulus + Eeff = E / (1.0 - pow(nu, 2.0)); // composite plane strain modulus } /* ---------------------------------------------------------------------- */ @@ -584,23 +586,12 @@ double GranSubModNormalMDR::calculate_forces() if (gm->delta >= *deltamax_offset) *deltamax_offset = gm->delta; deltamax = *deltamax_offset; + double overlap_limit = 0.75; for (int contactSide = 0; contactSide < 2; contactSide++) { - double * delta_offset; - double * deltao_offset; - double * delta_MDR_offset; - double * delta_BULK_offset; - double * deltamax_MDR_offset; - double * Yflag_offset; - double * deltaY_offset; - double * cA_offset; - double * aAdh_offset; - double * Ac_offset; - double * eps_bar_offset; - double * penalty_offset; - double * deltap_offset; - - double overlap_limit = 0.75; + double *delta_offset, *deltao_offset, *delta_MDR_offset, *delta_BULK_offset; + double *deltamax_MDR_offset, *Yflag_offset, *deltaY_offset, *cA_offset, *aAdh_offset; + double *Ac_offset, *eps_bar_offset, *penalty_offset, *deltap_offset; if (contactSide == 0) { if (gm->contact_type == PAIR) { @@ -620,12 +611,11 @@ double GranSubModNormalMDR::calculate_forces() i0 = gm->i; i1 = gm->j; - double delta_geo; - double delta_geo_alt; - double delta_geoOpt1 = deltamax*(deltamax - 2.0*R1)/(2.0*(deltamax - R0 - R1)); - double delta_geoOpt2 = deltamax*(deltamax - 2.0*R0)/(2.0*(deltamax - R0 - R1)); - (gm->radi < gm->radj) ? delta_geo = MAX(delta_geoOpt1,delta_geoOpt2) : delta_geo = MIN(delta_geoOpt1,delta_geoOpt2); - (gm->radi > gm->radj) ? delta_geo_alt = MAX(delta_geoOpt1,delta_geoOpt2) : delta_geo_alt = MIN(delta_geoOpt1,delta_geoOpt2); + double delta_geo, delta_geo_alt; + double delta_geoOpt1 = deltamax * (deltamax - 2.0 * R1) / (2.0 * (deltamax - R0 - R1)); + double delta_geoOpt2 = deltamax * (deltamax - 2.0 * R0) / (2.0 * (deltamax - R0 - R1)); + (gm->radi < gm->radj) ? delta_geo = MAX(delta_geoOpt1, delta_geoOpt2) : delta_geo = MIN(delta_geoOpt1, delta_geoOpt2); + (gm->radi > gm->radj) ? delta_geo_alt = MAX(delta_geoOpt1, delta_geoOpt2) : delta_geo_alt = MIN(delta_geoOpt1, delta_geoOpt2); if (delta_geo/gm->radi > overlap_limit) { delta_geo = gm->radi*overlap_limit; @@ -697,12 +687,7 @@ double GranSubModNormalMDR::calculate_forces() const int i = gm->i; const int j = gm->j; - // material and geometric property definitions - // E, nu, Y gamma , psi_b, and CoR are already defined. - const double G = E/(2.0*(1.0+nu)); // shear modulus - const double kappa = E/(3.0*(1.0-2.0*nu)); // bulk modulus - const double Eeff = E/(1.0-pow(nu,2.0)); // composite plane strain modulus - + // geometric property definitions const double Ro = Rinitial[i]; // initial radius const double R = gm->radi; // apparent radius @@ -787,11 +772,11 @@ double GranSubModNormalMDR::calculate_forces() } else { const double lmax = sqrt(2.0*MY_PI*aAdh*gamma/Eeff); g_aAdh = A/2 - A/B*sqrt(pow(B,2.0)/4 - pow(aAdh,2.0)); - const double acrit = (-((pow(B,2)*gamma*MY_PI)/(pow(A,2)*Eeff)) + (pow(2,0.3333333333333333)*pow(B,4)*pow(gamma,2)*pow(MY_PI,1.6666666666666667))/ + const double acrit = (-((pow(B,2)*gamma*MY_PI)/(pow(A,2)*Eeff)) + (pow(2,THIRD)*pow(B,4)*pow(gamma,2)*pow(MY_PI,FIVETHIRDS))/ (pow(A,2)*pow(Eeff,2)*pow((27*pow(A,4)*pow(B,4)*gamma)/Eeff - (2*pow(B,6)*pow(gamma,3)*pow(MY_PI,2))/pow(Eeff,3) + (3*sqrt(3)*sqrt(27*pow(A,8)*pow(B,8)*pow(Eeff,2)*pow(gamma,2) - - 4*pow(A,4)*pow(B,10)*pow(gamma,4)*pow(MY_PI,2)))/pow(Eeff,2),0.3333333333333333)) + (pow(MY_PI/2.,0.3333333333333333)*pow((27*pow(A,4)*pow(B,4)*gamma)/Eeff - + 4*pow(A,4)*pow(B,10)*pow(gamma,4)*pow(MY_PI,2)))/pow(Eeff,2),THIRD)) + (pow(MY_PI/2.,THIRD)*pow((27*pow(A,4)*pow(B,4)*gamma)/Eeff - (2*pow(B,6)*pow(gamma,3)*pow(MY_PI,2))/pow(Eeff,3) + (3*sqrt(3)*sqrt(27*pow(A,8)*pow(B,8)*pow(Eeff,2)*pow(gamma,2) - 4*pow(A,4)*pow(B,10)*pow(gamma,4)*pow(MY_PI,2)))/ - pow(Eeff,2),0.3333333333333333))/pow(A,2))/6; + pow(Eeff,2),THIRD))/pow(A,2))/6; if ( (deltae1D + lmax - g_aAdh) >= 0.0) { // case 2: tensile springs, but not exceeding critical length --> deltae + lmax - g(aAdhes) >= 0 const double deltaeAdh = g_aAdh; @@ -819,7 +804,7 @@ double GranSubModNormalMDR::calculate_forces() } dfda = -((aAdh_tmp*A)/(B*sqrt(-pow(aAdh_tmp,2.0) + pow(B,2.0)/4.0))) + (gamma*sqrt(MY_PI/2.0))/(Eeff*sqrt((aAdh_tmp*gamma)/Eeff)); aAdh_tmp = aAdh_tmp - fa/dfda; - fa2 = deltae1D + sqrt(2.0*MY_PI*aAdh_tmp*gamma/Eeff) - ( A/2 - A/B*sqrt(pow(B,2.0)/4 - pow(aAdh_tmp,2.0)) ); + fa2 = deltae1D + sqrt(2.0*MY_PI*aAdh_tmp*gamma/Eeff) - (A/2 - A/B*sqrt(pow(B,2.0)/4 - pow(aAdh_tmp,2.0))); if (abs(fa-fa2) < error2) { break; } diff --git a/src/GRANULAR/gran_sub_mod_normal.h b/src/GRANULAR/gran_sub_mod_normal.h index 9741a24f4c..855ae67965 100644 --- a/src/GRANULAR/gran_sub_mod_normal.h +++ b/src/GRANULAR/gran_sub_mod_normal.h @@ -147,7 +147,9 @@ namespace Granular_NS { double psi_b; protected: - double E, nu, Y, gamma, CoR, F; + double E, nu, Y, gamma, CoR; // specified coeffs + double G, kappa, Eeff; // derived coeffs + double F; int index_Ro, index_Vgeo, index_Velas, index_Vcaps, index_eps_bar, index_dRnumerator; int index_dRdenominator, index_Acon0, index_Acon1, index_Atot, index_Atot_sum, index_ddelta_bar; From af4a731ef209c9a01b076689f8a417e05da8e68b Mon Sep 17 00:00:00 2001 From: Sachith Dunatunga Date: Sat, 21 Dec 2024 11:16:01 -0800 Subject: [PATCH 19/74] Update variable.rst documentation --- doc/src/variable.rst | 67 +++++++++++++++++++++++--------------------- 1 file changed, 35 insertions(+), 32 deletions(-) diff --git a/doc/src/variable.rst b/doc/src/variable.rst index 1867532efa..8d83e090bd 100644 --- a/doc/src/variable.rst +++ b/doc/src/variable.rst @@ -56,7 +56,7 @@ Syntax random(x,y,z), normal(x,y,z), ceil(x), floor(x), round(x), ternary(x,y,z), ramp(x,y), stagger(x,y), logfreq(x,y,z), logfreq2(x,y,z), logfreq3(x,y,z), stride(x,y,z), stride2(x,y,z,a,b,c), - vdisplace(x,y), swiggle(x,y,z), cwiggle(x,y,z) + vdisplace(x,y), swiggle(x,y,z), cwiggle(x,y,z), sign(x) group functions = count(group), mass(group), charge(group), xcm(group,dim), vcm(group,dim), fcm(group,dim), bound(group,dir), gyration(group), ke(group), @@ -532,37 +532,37 @@ functions, special functions, feature functions, atom values, atom vectors, custom atom properties, compute references, fix references, and references to other variables. -+------------------------+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ -| Number | 0.2, 100, 1.0e20, -15.4, etc | -+------------------------+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ -| Constant | PI, version, on, off, true, false, yes, no | -+------------------------+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ -| Thermo keywords | vol, pe, ebond, etc | -+------------------------+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ -| Math operators | (), -x, x+y, x-y, x\*y, x/y, x\^y, x%y, x == y, x != y, x < y, x <= y, x > y, x >= y, x && y, x \|\| y, x \|\^ y, !x | -+------------------------+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ -| Math functions | sqrt(x), exp(x), ln(x), log(x), abs(x), sin(x), cos(x), tan(x), asin(x), acos(x), atan(x), atan2(y,x), random(x,y,z), normal(x,y,z), ceil(x), floor(x), round(x), ternary(x,y,z), ramp(x,y), stagger(x,y), logfreq(x,y,z), logfreq2(x,y,z), logfreq3(x,y,z), stride(x,y,z), stride2(x,y,z,a,b,c), vdisplace(x,y), swiggle(x,y,z), cwiggle(x,y,z) | -+------------------------+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ -| Group functions | count(ID), mass(ID), charge(ID), xcm(ID,dim), vcm(ID,dim), fcm(ID,dim), bound(ID,dir), gyration(ID), ke(ID), angmom(ID,dim), torque(ID,dim), inertia(ID,dimdim), omega(ID,dim) | -+------------------------+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ -| Region functions | count(ID,IDR), mass(ID,IDR), charge(ID,IDR), xcm(ID,dim,IDR), vcm(ID,dim,IDR), fcm(ID,dim,IDR), bound(ID,dir,IDR), gyration(ID,IDR), ke(ID,IDR), angmom(ID,dim,IDR), torque(ID,dim,IDR), inertia(ID,dimdim,IDR), omega(ID,dim,IDR) | -+------------------------+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ -| Special functions | sum(x), min(x), max(x), ave(x), trap(x), slope(x), sort(x), rsort(x), gmask(x), rmask(x), grmask(x,y), next(x), is_file(name), is_os(name), extract_setting(name), label2type(kind,label), is_typelabel(kind,label), is_timeout() | -+------------------------+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ -| Feature functions | is_available(category,feature), is_active(category,feature), is_defined(category,id) | -+------------------------+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ -| Atom values | id[i], mass[i], type[i], mol[i], x[i], y[i], z[i], vx[i], vy[i], vz[i], fx[i], fy[i], fz[i], q[i] | -+------------------------+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ -| Atom vectors | id, mass, type, mol, x, y, z, vx, vy, vz, fx, fy, fz, q | -+------------------------+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ -| Custom atom properties | i_name, d_name, i_name[i], d_name[i], i2_name[i], d2_name[i], i2_name[i][j], d_name[i][j] | -+------------------------+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ -| Compute references | c_ID, c_ID[i], c_ID[i][j], C_ID, C_ID[i] | -+------------------------+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ -| Fix references | f_ID, f_ID[i], f_ID[i][j], F_ID, F_ID[i] | -+------------------------+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ -| Other variables | v_name, v_name[i] | -+------------------------+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ ++------------------------+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ +| Number | 0.2, 100, 1.0e20, -15.4, etc | ++------------------------+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ +| Constant | PI, version, on, off, true, false, yes, no | ++------------------------+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ +| Thermo keywords | vol, pe, ebond, etc | ++------------------------+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ +| Math operators | (), -x, x+y, x-y, x\*y, x/y, x\^y, x%y, x == y, x != y, x < y, x <= y, x > y, x >= y, x && y, x \|\| y, x \|\^ y, !x | ++------------------------+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ +| Math functions | sqrt(x), exp(x), ln(x), log(x), abs(x), sin(x), cos(x), tan(x), asin(x), acos(x), atan(x), atan2(y,x), random(x,y,z), normal(x,y,z), ceil(x), floor(x), round(x), ternary(x,y,z), ramp(x,y), stagger(x,y), logfreq(x,y,z), logfreq2(x,y,z), logfreq3(x,y,z), stride(x,y,z), stride2(x,y,z,a,b,c), vdisplace(x,y), swiggle(x,y,z), cwiggle(x,y,z), sign(x) | ++------------------------+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ +| Group functions | count(ID), mass(ID), charge(ID), xcm(ID,dim), vcm(ID,dim), fcm(ID,dim), bound(ID,dir), gyration(ID), ke(ID), angmom(ID,dim), torque(ID,dim), inertia(ID,dimdim), omega(ID,dim) | ++------------------------+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ +| Region functions | count(ID,IDR), mass(ID,IDR), charge(ID,IDR), xcm(ID,dim,IDR), vcm(ID,dim,IDR), fcm(ID,dim,IDR), bound(ID,dir,IDR), gyration(ID,IDR), ke(ID,IDR), angmom(ID,dim,IDR), torque(ID,dim,IDR), inertia(ID,dimdim,IDR), omega(ID,dim,IDR) | ++------------------------+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ +| Special functions | sum(x), min(x), max(x), ave(x), trap(x), slope(x), sort(x), rsort(x), gmask(x), rmask(x), grmask(x,y), next(x), is_file(name), is_os(name), extract_setting(name), label2type(kind,label), is_typelabel(kind,label), is_timeout() | ++------------------------+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ +| Feature functions | is_available(category,feature), is_active(category,feature), is_defined(category,id) | ++------------------------+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ +| Atom values | id[i], mass[i], type[i], mol[i], x[i], y[i], z[i], vx[i], vy[i], vz[i], fx[i], fy[i], fz[i], q[i] | ++------------------------+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ +| Atom vectors | id, mass, type, mol, x, y, z, vx, vy, vz, fx, fy, fz, q | ++------------------------+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ +| Custom atom properties | i_name, d_name, i_name[i], d_name[i], i2_name[i], d2_name[i], i2_name[i][j], d_name[i][j] | ++------------------------+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ +| Compute references | c_ID, c_ID[i], c_ID[i][j], C_ID, C_ID[i] | ++------------------------+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ +| Fix references | f_ID, f_ID[i], f_ID[i][j], F_ID, F_ID[i] | ++------------------------+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ +| Other variables | v_name, v_name[i] | ++------------------------+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------+ Most of the formula elements produce a scalar value. Some produce a global or per-atom vector of values. Global vectors can be produced @@ -860,6 +860,9 @@ run, according to one of these formulas, where omega = 2 PI / period: where dt = the timestep size. +The sign(x) function returns 1.0 if the value is greater than or equal +to 0.0, and -1.0 otherwise. + The run begins on startstep. Startstep can span multiple runs, using the *start* keyword of the :doc:`run ` command. See the :doc:`run ` command for details of how to do this. Note that the From 6abbdfd740b461752b6f0fab5828451419aa6226 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Sun, 22 Dec 2024 08:00:15 -0700 Subject: [PATCH 20/74] minimize pair lookups, reducing indentation level, more misc clean ups --- src/GRANULAR/fix_granular_mdr.cpp | 338 ++++++++++++++------------- src/GRANULAR/fix_granular_mdr.h | 3 + src/GRANULAR/gran_sub_mod_normal.cpp | 8 +- 3 files changed, 180 insertions(+), 169 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index fbcda42af2..0a31719f90 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -47,6 +47,8 @@ using namespace Granular_NS; using namespace FixConst; using MathConst::MY_PI; +static constexpr double EPSILON = 1e-16; + enum {MEAN_SURF_DISP, RADIUS_UPDATE}; /* ---------------------------------------------------------------------- */ @@ -54,7 +56,7 @@ enum {MEAN_SURF_DISP, RADIUS_UPDATE}; FixGranularMDR::FixGranularMDR(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) { - comm_forward = 20; // value needs to match number of values you communicate + comm_forward = 20; create_attribute = 1; id_fix = nullptr; @@ -86,32 +88,54 @@ void FixGranularMDR::post_constructor() id_fix = utils::strdup("MDR_PARTICLE_HISTORY_VARIABLES"); modify->add_fix(fmt::format("{} all property/atom d_Ro d_Vcaps d_Vgeo d_Velas d_eps_bar d_dRnumerator d_dRdenominator d_Acon0 d_Acon1 d_Atot d_Atot_sum d_ddelta_bar d_psi d_psi_b d_history_setup_flag d_sigmaxx d_sigmayy d_sigmazz d_contacts d_adhesive_length ghost yes", id_fix)); - index_Ro = atom->find_custom("Ro",tmp1,tmp2); - index_Vcaps = atom->find_custom("Vcaps",tmp1,tmp2); - index_Vgeo = atom->find_custom("Vgeo",tmp1,tmp2); - index_Velas = atom->find_custom("Velas",tmp1,tmp2); - index_eps_bar = atom->find_custom("eps_bar",tmp1,tmp2); - index_dRnumerator = atom->find_custom("dRnumerator",tmp1,tmp2); - index_dRdenominator = atom->find_custom("dRdenominator",tmp1,tmp2); - index_Acon0 = atom->find_custom("Acon0",tmp1,tmp2); - index_Acon1 = atom->find_custom("Acon1",tmp1,tmp2); - index_Atot = atom->find_custom("Atot",tmp1,tmp2); - index_Atot_sum = atom->find_custom("Atot_sum",tmp1,tmp2); - index_ddelta_bar = atom->find_custom("ddelta_bar",tmp1,tmp2); - index_psi = atom->find_custom("psi",tmp1,tmp2); - index_psi_b = atom->find_custom("psi_b",tmp1,tmp2); - index_history_setup_flag = atom->find_custom("history_setup_flag",tmp1,tmp2); - index_sigmaxx = atom->find_custom("sigmaxx",tmp1,tmp2); - index_sigmayy = atom->find_custom("sigmayy",tmp1,tmp2); - index_sigmazz = atom->find_custom("sigmazz",tmp1,tmp2); - index_contacts = atom->find_custom("contacts",tmp1,tmp2); - index_adhesive_length = atom->find_custom("adhesive_length",tmp1,tmp2); + index_Ro = atom->find_custom("Ro", tmp1, tmp2); + index_Vcaps = atom->find_custom("Vcaps", tmp1, tmp2); + index_Vgeo = atom->find_custom("Vgeo", tmp1, tmp2); + index_Velas = atom->find_custom("Velas", tmp1, tmp2); + index_eps_bar = atom->find_custom("eps_bar", tmp1, tmp2); + index_dRnumerator = atom->find_custom("dRnumerator", tmp1, tmp2); + index_dRdenominator = atom->find_custom("dRdenominator", tmp1, tmp2); + index_Acon0 = atom->find_custom("Acon0", tmp1, tmp2); + index_Acon1 = atom->find_custom("Acon1", tmp1, tmp2); + index_Atot = atom->find_custom("Atot", tmp1, tmp2); + index_Atot_sum = atom->find_custom("Atot_sum", tmp1, tmp2); + index_ddelta_bar = atom->find_custom("ddelta_bar", tmp1, tmp2); + index_psi = atom->find_custom("psi", tmp1, tmp2); + index_psi_b = atom->find_custom("psi_b", tmp1, tmp2); + index_history_setup_flag = atom->find_custom("history_setup_flag", tmp1, tmp2); + index_sigmaxx = atom->find_custom("sigmaxx", tmp1, tmp2); + index_sigmayy = atom->find_custom("sigmayy", tmp1, tmp2); + index_sigmazz = atom->find_custom("sigmazz", tmp1, tmp2); + index_contacts = atom->find_custom("contacts", tmp1, tmp2); + index_adhesive_length = atom->find_custom("adhesive_length", tmp1, tmp2); } /* ---------------------------------------------------------------------- */ void FixGranularMDR::setup_pre_force(int /*vflag*/) { + pair = dynamic_cast(force->pair_match("granular", 1)); + if (pair == nullptr) + error->all(FLERR, "Must use pair granular with MDR model"); + + class GranularModel* model; + class GranularModel** models_list = pair->models_list; + class GranSubModNormalMDR* norm_model = nullptr; + for (int i = 0; i < pair->nmodels; i++) { + model = models_list[i]; + if (model->normal_model->name == "mdr") + norm_model = dynamic_cast(model->normal_model); + } + + if (norm_model == nullptr) + error->all(FLERR, "Must specify MDR normal model with pair granular"); + + fix_history = dynamic_cast(modify->get_fix_by_id("NEIGH_HISTORY_GRANULAR")); + + + // QUESTION: can psi_b be different in different models? + psi_b_coeff = norm_model->psi_b; + pre_force(0); } @@ -247,21 +271,22 @@ void FixGranularMDR::end_of_step() for (int i = 0; i < nlocal; i++) { const double R = radius[i]; - Atot[i] = 4.0*MY_PI*pow(R,2.0) + Atot_sum[i]; + Atot[i] = 4.0 * MY_PI * pow(R, 2.0) + Atot_sum[i]; - const double Vo = 4.0/3.0*MY_PI*pow(Ro[i],3.0); - const double Vgeoi = 4.0/3.0*MY_PI*pow(R,3.0) - Vcaps[i]; - Vgeo[i] = std::min(Vgeoi,Vo); + const double Vo = 4.0 / 3.0 * MY_PI * pow(Ro[i], 3.0); + const double Vgeoi = 4.0 / 3.0 * MY_PI * pow(R, 3.0) - Vcaps[i]; + Vgeo[i] = std::min(Vgeoi, Vo); const double Afree = Atot[i] - Acon1[i]; - psi[i] = Afree/Atot[i]; + psi[i] = Afree / Atot[i]; - const double dR = std::max(dRnumerator[i]/(dRdenominator[i] - 4.0*MY_PI*pow(R,2.0)),0.0); + const double dR = std::max(dRnumerator[i] / (dRdenominator[i] - 4.0 * MY_PI * pow(R, 2.0)), 0.0); if (psi_b[i] < psi[i]) { - if ((radius[i] + dR) < (1.5*Ro[i])) radius[i] += dR; + if ((radius[i] + dR) < (1.5 * Ro[i])) radius[i] += dR; } - Velas[i] = Vo*(1.0 + eps_bar[i]); + // QUESTION: does it make more sense to initialize these in pre_force? + Velas[i] = Vo * (1.0 + eps_bar[i]); Vcaps[i] = 0.0; eps_bar[i] = 0.0; dRnumerator[i] = 0.0; @@ -282,26 +307,26 @@ void FixGranularMDR::end_of_step() void FixGranularMDR::set_arrays(int i) { - atom->dvector[index_Ro][i] = 0.0; - atom->dvector[index_Vgeo][i] = 0.0; - atom->dvector[index_Velas][i] = 0.0; + // atom->dvector[index_Ro][i] = 0.0; + // atom->dvector[index_Vgeo][i] = 0.0; + // atom->dvector[index_Velas][i] = 0.0; atom->dvector[index_Vcaps][i] = 0.0; atom->dvector[index_eps_bar][i] = 0.0; atom->dvector[index_dRnumerator][i] = 0.0; atom->dvector[index_dRdenominator][i] = 0.0; atom->dvector[index_Acon0][i] = 0.0; atom->dvector[index_Acon1][i] = 0.0; - atom->dvector[index_Atot][i] = 0.0; + // atom->dvector[index_Atot][i] = 0.0; atom->dvector[index_Atot_sum][i] = 0.0; atom->dvector[index_ddelta_bar][i] = 0.0; - atom->dvector[index_psi][i] = 0.0; - atom->dvector[index_psi_b][i] = 0.0; - atom->dvector[index_sigmaxx][i] = 0.0; - atom->dvector[index_sigmayy][i] = 0.0; - atom->dvector[index_sigmazz][i] = 0.0; + // atom->dvector[index_psi][i] = 0.0; + // atom->dvector[index_psi_b][i] = 0.0; + // atom->dvector[index_sigmaxx][i] = 0.0; + // atom->dvector[index_sigmayy][i] = 0.0; + // atom->dvector[index_sigmazz][i] = 0.0; atom->dvector[index_history_setup_flag][i] = 0.0; - atom->dvector[index_contacts][i] = 0.0; - atom->dvector[index_adhesive_length][i] = 0.0; + // atom->dvector[index_contacts][i] = 0.0; + // atom->dvector[index_adhesive_length][i] = 0.0; } /* ---------------------------------------------------------------------- @@ -310,16 +335,6 @@ void FixGranularMDR::set_arrays(int i) void FixGranularMDR::radius_update() { - PairGranular * pair = dynamic_cast(force->pair_match("granular",1)); - class GranularModel* model; - class GranularModel** models_list = pair->models_list; - class GranSubModNormalMDR* norm_model = nullptr; - for (int i = 0; i < pair->nmodels; i++) { - model = models_list[i]; - if (model->normal_model->name == "mdr") norm_model = dynamic_cast(model->normal_model); - } - if (norm_model == nullptr) error->all(FLERR, "Did not find mdr model"); - double *radius = atom->radius; int nlocal = atom->nlocal; @@ -337,13 +352,13 @@ void FixGranularMDR::radius_update() double *history_setup_flag = atom->dvector[index_history_setup_flag]; for (int i = 0; i < nlocal; i++) { - if (history_setup_flag[i] < 1e-16) { + if (history_setup_flag[i] < EPSILON) { Ro[i] = radius[i]; - Vgeo[i] = 4.0/3.0*MY_PI*pow(Ro[i],3.0); - Velas[i] = 4.0/3.0*MY_PI*pow(Ro[i],3.0); - Atot[i] = 4.0*MY_PI*pow(Ro[i],2.0); + Vgeo[i] = 4.0 / 3.0 * MY_PI * pow(Ro[i], 3.0); + Velas[i] = 4.0 / 3.0 * MY_PI * pow(Ro[i], 3.0); + Atot[i] = 4.0 * MY_PI * pow(Ro[i], 2.0); psi[i] = 1.0; - psi_b[i] = norm_model->psi_b; + psi_b[i] = psi_b_coeff; history_setup_flag[i] = 1.0; } sigmaxx[i] = 0.0; @@ -360,23 +375,19 @@ void FixGranularMDR::radius_update() void FixGranularMDR::calculate_contact_penalty() { - FixNeighHistory * fix_history = dynamic_cast(modify->get_fix_by_id("NEIGH_HISTORY_GRANULAR")); - PairGranular * pair = dynamic_cast(force->pair_match("granular",1)); NeighList * list = pair->list; - const int size_history = pair->get_size_history(); + int i, j, k, lv1, ii, jj, inum, jnum; - int i,j,k,lv1,ii,jj,inum,jnum,itype,jtype,ktype; - - int *ilist,*jlist,*numneigh,**firstneigh; - int *touch,**firsttouch; - double *history_ij,*history_ik,*history_jk,*history_kj,*allhistory,*allhistory_j,*allhistory_k,**firsthistory; + int *ilist, *jlist, *numneigh, **firstneigh; + int *touch, **firsttouch; + double *history_ij, *history_ik, *history_jk, *history_kj; + double *allhistory, *allhistory_j, *allhistory_k, **firsthistory; bool touchflag = false; double **x = atom->x; - int *type = atom->type; double *radius = atom->radius; int nlocal = atom->nlocal; @@ -388,8 +399,8 @@ void FixGranularMDR::calculate_contact_penalty() firsthistory = fix_history->firstvalue; // contact penalty calculation - for (int ii = 0; ii < inum; ii++) { - const int i = ilist[ii]; + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; const double xtmp = x[i][0]; const double ytmp = x[i][1]; const double ztmp = x[i][2]; @@ -397,119 +408,120 @@ void FixGranularMDR::calculate_contact_penalty() double radi = radius[i]; jlist = firstneigh[i]; jnum = numneigh[i]; - for (int jj = 0; jj < jnum; jj++) { + for (jj = 0; jj < jnum; jj++) { j = jlist[jj]; j &= NEIGHMASK; - jtype = type[j]; + double radj = radius[j]; const double delx_ij = x[j][0] - xtmp; const double dely_ij = x[j][1] - ytmp; const double delz_ij = x[j][2] - ztmp; - const double rsq_ij = delx_ij*delx_ij + dely_ij*dely_ij + delz_ij*delz_ij; + const double rsq_ij = delx_ij * delx_ij + dely_ij * dely_ij + delz_ij * delz_ij; const double r_ij = sqrt(rsq_ij); - const double rinv_ij = 1.0/r_ij; + const double rinv_ij = 1.0 / r_ij; const double radsum_ij = radi + radj; const double deltan_ij = radsum_ij - r_ij; - if (deltan_ij >= 0.0) { - for (int kk = jj; kk < jnum; kk++) { - k = jlist[kk]; - k &= NEIGHMASK; - ktype = type[k]; - if (kk != jj) { - const double delx_ik = x[k][0] - xtmp; - const double dely_ik = x[k][1] - ytmp; - const double delz_ik = x[k][2] - ztmp; - const double rsq_ik = delx_ik*delx_ik + dely_ik*dely_ik + delz_ik*delz_ik; - const double r_ik = sqrt(rsq_ik); - const double rinv_ik = 1.0/r_ik; - const double radk = radius[k]; - const double radsum_ik = radi + radk; - const double deltan_ik = radsum_ik - r_ik; - const double delx_jk = x[k][0] - x[j][0]; - const double dely_jk = x[k][1] - x[j][1]; - const double delz_jk = x[k][2] - x[j][2]; - const double rsq_jk = delx_jk*delx_jk + dely_jk*dely_jk + delz_jk*delz_jk; - const double r_jk = sqrt(rsq_jk); - const double rinv_jk = 1.0/r_jk; - const double radsum_jk = radj + radk; - const double deltan_jk = radsum_jk - r_jk; - if (deltan_ik >= 0.0 && deltan_jk >= 0.0) { + if (deltan_ij < 0.0) continue; + for (int kk = jj; kk < jnum; kk++) { + k = jlist[kk]; + k &= NEIGHMASK; - // pull ij history - history_ij = &allhistory[size_history * jj]; - double * pij = &history_ij[22]; // penalty for contact i and j + if (kk == jj) continue; + const double delx_ik = x[k][0] - xtmp; + const double dely_ik = x[k][1] - ytmp; + const double delz_ik = x[k][2] - ztmp; + const double rsq_ik = delx_ik * delx_ik + dely_ik * dely_ik + delz_ik *delz_ik; + const double r_ik = sqrt(rsq_ik); + const double rinv_ik = 1.0 / r_ik; + const double radk = radius[k]; + const double radsum_ik = radi + radk; + const double deltan_ik = radsum_ik - r_ik; - // pull ik history - history_ik = &allhistory[size_history * kk]; - double * pik = &history_ik[22]; // penalty for contact i and k + if (deltan_ik < 0.0) continue; - // we don't know if who owns the contact ahead of time, k might be in j's neigbor list or vice versa, - // so we need to manually search to figure out the owner check if k is in the neighbor list of j - double * pjk = NULL; - int * const jklist = firstneigh[j]; - const int jknum = numneigh[j]; - for (int jk = 0; jk < jknum; jk++) { - const int kneigh = jklist[jk] & NEIGHMASK; - if (k == kneigh) { - allhistory_j = firsthistory[j]; - history_jk = &allhistory_j[size_history * jk]; - pjk = &history_jk[22]; // penalty for contact j and k - break; - } - } + const double delx_jk = x[k][0] - x[j][0]; + const double dely_jk = x[k][1] - x[j][1]; + const double delz_jk = x[k][2] - x[j][2]; + const double rsq_jk = delx_jk * delx_jk + dely_jk * dely_jk + delz_jk *delz_jk; + const double r_jk = sqrt(rsq_jk); + const double rinv_jk = 1.0 / r_jk; + const double radsum_jk = radj + radk; + const double deltan_jk = radsum_jk - r_jk; - // check if j is in the neighbor list of k - if (pjk == NULL) { - int * const kjlist = firstneigh[k]; - const int kjnum = numneigh[k]; - for (int kj = 0; kj < kjnum; kj++) { - const int jneigh = kjlist[kj] & NEIGHMASK; - if (j == jneigh) { - allhistory_k = firsthistory[k]; - history_kj = &allhistory_k[size_history * kj]; - pjk = &history_kj[22]; // penalty for contact j and k - break; - } - } - } + if (deltan_jk < 0.0) continue; - std::vector distances = {r_ij,r_ik,r_jk}; - auto maxElement = std::max_element(distances.begin(), distances.end()); - double maxValue = *maxElement; - int maxIndex = std::distance(distances.begin(), maxElement); - if (maxIndex == 0) { // the central particle is k - const double enx_ki = -delx_ik * rinv_ik; - const double eny_ki = -dely_ik * rinv_ik; - const double enz_ki = -delz_ik * rinv_ik; - const double enx_kj = -delx_jk * rinv_jk; - const double eny_kj = -dely_jk * rinv_jk; - const double enz_kj = -delz_jk * rinv_jk; - const double alpha = std::acos(enx_ki*enx_kj + eny_ki*eny_kj + enz_ki*enz_kj); - pij[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/MY_PI - 1.0/2.0))); - } else if (maxIndex == 1) { // the central particle is j - const double enx_ji = -delx_ij * rinv_ij; - const double eny_ji = -dely_ij * rinv_ij; - const double enz_ji = -delz_ij * rinv_ij; - const double enx_jk = delx_jk * rinv_jk; - const double eny_jk = dely_jk * rinv_jk; - const double enz_jk = delz_jk * rinv_jk; - const double alpha = std::acos(enx_ji*enx_jk + eny_ji*eny_jk + enz_ji*enz_jk); - pik[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/MY_PI - 1.0/2.0))); - } else { // the central particle is i - if (j < atom->nlocal || k < atom->nlocal) { - const double enx_ij = delx_ij * rinv_ij; - const double eny_ij = dely_ij * rinv_ij; - const double enz_ij = delz_ij * rinv_ij; - const double enx_ik = delx_ik * rinv_ik; - const double eny_ik = dely_ik * rinv_ik; - const double enz_ik = delz_ik * rinv_ik; - const double alpha = std::acos(enx_ij*enx_ik + eny_ij*eny_ik + enz_ij*enz_ik); - pjk[0] += 1.0/( 1.0 + std::exp(-50.0*(alpha/MY_PI - 1.0/2.0))); - } - } + // pull ij history + history_ij = &allhistory[size_history * jj]; + double * pij = &history_ij[22]; // penalty for contact i and j + + // pull ik history + history_ik = &allhistory[size_history * kk]; + double * pik = &history_ik[22]; // penalty for contact i and k + + // we don't know if who owns the contact ahead of time, k might be in j'sneigbor list or vice versa, + // so we need to manually search to figure out the owner check if k is inthe neighbor list of j + double * pjk = nullptr; + int * const jklist = firstneigh[j]; + const int jknum = numneigh[j]; + for (int jk = 0; jk < jknum; jk++) { + const int kneigh = jklist[jk] & NEIGHMASK; + if (k == kneigh) { + allhistory_j = firsthistory[j]; + history_jk = &allhistory_j[size_history * jk]; + pjk = &history_jk[22]; // penalty for contact j and k + break; + } + } + + // check if j is in the neighbor list of k + if (pjk == nullptr) { + int * const kjlist = firstneigh[k]; + const int kjnum = numneigh[k]; + for (int kj = 0; kj < kjnum; kj++) { + const int jneigh = kjlist[kj] & NEIGHMASK; + if (j == jneigh) { + allhistory_k = firsthistory[k]; + history_kj = &allhistory_k[size_history * kj]; + pjk = &history_kj[22]; // penalty for contact j and k + break; } } } + + std::vector distances = {r_ij, r_ik, r_jk}; + auto maxElement = std::max_element(distances.begin(), distances.end()); + double maxValue = *maxElement; + int maxIndex = std::distance(distances.begin(), maxElement); + if (maxIndex == 0) { // the central particle is k + const double enx_ki = -delx_ik * rinv_ik; + const double eny_ki = -dely_ik * rinv_ik; + const double enz_ki = -delz_ik * rinv_ik; + const double enx_kj = -delx_jk * rinv_jk; + const double eny_kj = -dely_jk * rinv_jk; + const double enz_kj = -delz_jk * rinv_jk; + const double alpha = std::acos(enx_ki * enx_kj + eny_ki * eny_kj + enz_ki * enz_kj); + pij[0] += 1.0 / (1.0 + std::exp(-50.0 * (alpha / MY_PI - 0.5))); + } else if (maxIndex == 1) { // the central particle is j + const double enx_ji = -delx_ij * rinv_ij; + const double eny_ji = -dely_ij * rinv_ij; + const double enz_ji = -delz_ij * rinv_ij; + const double enx_jk = delx_jk * rinv_jk; + const double eny_jk = dely_jk * rinv_jk; + const double enz_jk = delz_jk * rinv_jk; + const double alpha = std::acos(enx_ji * enx_jk + eny_ji * eny_jk + enz_ji * enz_jk); + pik[0] += 1.0 / (1.0 + std::exp(-50.0 * (alpha / MY_PI - 0.5))); + } else { // the central particle is i + if (j < atom->nlocal || k < atom->nlocal) { + const double enx_ij = delx_ij * rinv_ij; + const double eny_ij = dely_ij * rinv_ij; + const double enz_ij = delz_ij * rinv_ij; + const double enx_ik = delx_ik * rinv_ik; + const double eny_ik = dely_ik * rinv_ik; + const double enz_ik = delz_ik * rinv_ik; + const double alpha = std::acos(enx_ij * enx_ik + eny_ij * eny_ik + enz_ij * enz_ik); + pjk[0] += 1.0 / (1.0 + std::exp(-50.0 * (alpha / MY_PI - 0.5))); + } + } } } } @@ -522,8 +534,6 @@ void FixGranularMDR::calculate_contact_penalty() void FixGranularMDR::mean_surf_disp() { - FixNeighHistory * fix_history = dynamic_cast(modify->get_fix_by_id("NEIGH_HISTORY_GRANULAR")); - PairGranular * pair = dynamic_cast(force->pair_match("granular",1)); NeighList * list = pair->list; const int size_history = pair->get_size_history(); diff --git a/src/GRANULAR/fix_granular_mdr.h b/src/GRANULAR/fix_granular_mdr.h index 4261cbbd70..7dbc500499 100644 --- a/src/GRANULAR/fix_granular_mdr.h +++ b/src/GRANULAR/fix_granular_mdr.h @@ -41,6 +41,9 @@ class FixGranularMDR : public Fix { private: int comm_stage; char *id_fix; + double psi_b_coeff; + class PairGranular *pair; + class FixNeighHistory *fix_history; void radius_update(); void mean_surf_disp(); diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 09aea9f1b3..927afe637a 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -653,8 +653,7 @@ double GranSubModNormalMDR::calculate_forces() gm->radj = radi_true; } - double delta_geo; - double delta_geo_alt; + double delta_geo, delta_geo_alt; double delta_geoOpt1 = deltamax*(deltamax - 2.0*R1)/(2.0*(deltamax - R0 - R1)); double delta_geoOpt2 = deltamax*(deltamax - 2.0*R0)/(2.0*(deltamax - R0 - R1)); (gm->radi < gm->radj) ? delta_geo = MAX(delta_geoOpt1,delta_geoOpt2) : delta_geo = MIN(delta_geoOpt1,delta_geoOpt2); @@ -699,8 +698,7 @@ double GranSubModNormalMDR::calculate_forces() const double ddeltao = deltao - *deltao_offset; *deltao_offset = deltao; - double ddelta_MDR; - double ddelta_BULK; + double ddelta_MDR, ddelta_BULK; if ( psi[i] < psi_b ) { // if true, bulk response has triggered, split displacement increment between the MDR and BULK components ddelta_MDR = std::min(ddelta-ddelta_bar[i], delta-*delta_MDR_offset); ddelta_BULK = ddelta_bar[i]; @@ -760,7 +758,7 @@ double GranSubModNormalMDR::calculate_forces() double aAdh = *aAdh_offset; if (aAdh > a_fac*amax) aAdh = a_fac*amax; - if ( gamma > 0.0 ) { // adhesive contact + if ( gamma > 0.0 ) { // adhesive contact double g_aAdh; if (delta_MDR == deltamax_MDR || a_na >= aAdh ) { // case 1: no tensile springs, purely compressive contact From ecb0f9525b3783571b2c9c991ac26d2c7c85124f Mon Sep 17 00:00:00 2001 From: jtclemm Date: Sun, 22 Dec 2024 11:13:04 -0700 Subject: [PATCH 21/74] Clarifying contact penalty logic, minimizing use of std --- src/GRANULAR/fix_granular_mdr.cpp | 92 +++++++++++++++++-------------- src/GRANULAR/granular_model.cpp | 5 +- 2 files changed, 55 insertions(+), 42 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index 0a31719f90..ab99083344 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -38,10 +38,6 @@ #include "update.h" #include "variable.h" -#include -#include -#include - using namespace LAMMPS_NS; using namespace Granular_NS; using namespace FixConst; @@ -275,12 +271,12 @@ void FixGranularMDR::end_of_step() const double Vo = 4.0 / 3.0 * MY_PI * pow(Ro[i], 3.0); const double Vgeoi = 4.0 / 3.0 * MY_PI * pow(R, 3.0) - Vcaps[i]; - Vgeo[i] = std::min(Vgeoi, Vo); + Vgeo[i] = MIN(Vgeoi, Vo); const double Afree = Atot[i] - Acon1[i]; psi[i] = Afree / Atot[i]; - const double dR = std::max(dRnumerator[i] / (dRdenominator[i] - 4.0 * MY_PI * pow(R, 2.0)), 0.0); + const double dR = MAX(dRnumerator[i] / (dRdenominator[i] - 4.0 * MY_PI * pow(R, 2.0)), 0.0); if (psi_b[i] < psi[i]) { if ((radius[i] + dR) < (1.5 * Ro[i])) radius[i] += dR; } @@ -426,6 +422,7 @@ void FixGranularMDR::calculate_contact_penalty() k = jlist[kk]; k &= NEIGHMASK; + // QUESTION: why not start loop at jj+1? if (kk == jj) continue; const double delx_ik = x[k][0] - xtmp; const double dely_ik = x[k][1] - ytmp; @@ -458,41 +455,17 @@ void FixGranularMDR::calculate_contact_penalty() history_ik = &allhistory[size_history * kk]; double * pik = &history_ik[22]; // penalty for contact i and k - // we don't know if who owns the contact ahead of time, k might be in j'sneigbor list or vice versa, - // so we need to manually search to figure out the owner check if k is inthe neighbor list of j - double * pjk = nullptr; - int * const jklist = firstneigh[j]; - const int jknum = numneigh[j]; - for (int jk = 0; jk < jknum; jk++) { - const int kneigh = jklist[jk] & NEIGHMASK; - if (k == kneigh) { - allhistory_j = firsthistory[j]; - history_jk = &allhistory_j[size_history * jk]; - pjk = &history_jk[22]; // penalty for contact j and k - break; - } - } + // Find pair of atoms with the smallest overlap, atoms a & b, 3rd atom c is central + // if a & b are both local: + // calculate ab penalty and add to the one history entry + // if a is local & b is ghost: + // each processor has a-b in nlist and independently calculates + adds penalty + // if a & b are both ghosts: + // skip calculation since it's performed on other proc + // This process requires newon off, or nlist may not include ab, ac, & bc - // check if j is in the neighbor list of k - if (pjk == nullptr) { - int * const kjlist = firstneigh[k]; - const int kjnum = numneigh[k]; - for (int kj = 0; kj < kjnum; kj++) { - const int jneigh = kjlist[kj] & NEIGHMASK; - if (j == jneigh) { - allhistory_k = firsthistory[k]; - history_kj = &allhistory_k[size_history * kj]; - pjk = &history_kj[22]; // penalty for contact j and k - break; - } - } - } - - std::vector distances = {r_ij, r_ik, r_jk}; - auto maxElement = std::max_element(distances.begin(), distances.end()); - double maxValue = *maxElement; - int maxIndex = std::distance(distances.begin(), maxElement); - if (maxIndex == 0) { // the central particle is k + const double r_max = MAX(r_ij, MAX(r_ik, r_jk)); + if (r_ij == r_max) { // the central particle is k const double enx_ki = -delx_ik * rinv_ik; const double eny_ki = -dely_ik * rinv_ik; const double enz_ki = -delz_ik * rinv_ik; @@ -501,7 +474,7 @@ void FixGranularMDR::calculate_contact_penalty() const double enz_kj = -delz_jk * rinv_jk; const double alpha = std::acos(enx_ki * enx_kj + eny_ki * eny_kj + enz_ki * enz_kj); pij[0] += 1.0 / (1.0 + std::exp(-50.0 * (alpha / MY_PI - 0.5))); - } else if (maxIndex == 1) { // the central particle is j + } else if (r_ik == r_max) { // the central particle is j const double enx_ji = -delx_ij * rinv_ij; const double eny_ji = -dely_ij * rinv_ij; const double enz_ji = -delz_ij * rinv_ij; @@ -519,6 +492,43 @@ void FixGranularMDR::calculate_contact_penalty() const double eny_ik = dely_ik * rinv_ik; const double enz_ik = delz_ik * rinv_ik; const double alpha = std::acos(enx_ij * enx_ik + eny_ij * eny_ik + enz_ij * enz_ik); + + // don't know who owns the contact, k may be in j's nlist or vice versa + // need to search both to find owner + double * pjk = nullptr; + if (j < atom->nlocal) { + int * const jklist = firstneigh[j]; + const int jknum = numneigh[j]; + for (int jk = 0; jk < jknum; jk++) { + const int kneigh = jklist[jk] & NEIGHMASK; + if (k == kneigh) { + allhistory_j = firsthistory[j]; + history_jk = &allhistory_j[size_history * jk]; + pjk = &history_jk[22]; // penalty for contact j and k + break; + } + } + } + + // check if j is in the neighbor list of k + if (pjk == nullptr && k < atom->nlocal) { + int * const kjlist = firstneigh[k]; + const int kjnum = numneigh[k]; + for (int kj = 0; kj < kjnum; kj++) { + const int jneigh = kjlist[kj] & NEIGHMASK; + if (j == jneigh) { + allhistory_k = firsthistory[k]; + history_kj = &allhistory_k[size_history * kj]; + pjk = &history_kj[22]; // penalty for contact j and k + break; + } + } + } + + // QUESTION: is this ever supposed to happen? + if (pjk == nullptr) + error->one(FLERR, "MDR could not find atom pair in neighbor list"); + pjk[0] += 1.0 / (1.0 + std::exp(-50.0 * (alpha / MY_PI - 0.5))); } } diff --git a/src/GRANULAR/granular_model.cpp b/src/GRANULAR/granular_model.cpp index 546c7a3d4e..eac5c61940 100644 --- a/src/GRANULAR/granular_model.cpp +++ b/src/GRANULAR/granular_model.cpp @@ -244,7 +244,10 @@ void GranularModel::init() // Must have valid normal, damping, and tangential models if (normal_model->name == "none") error->all(FLERR, "Must specify normal granular model"); if (normal_model->name == "mdr") { - if (damping_model->name != "none") error->all(FLERR, "Damping model must be set to 'none' for the MDR contact model. Specify a coefficient of restitution CoR < 1 if normal damping is desired."); + if (damping_model->name != "none") + error->all(FLERR, "MDR require 'none' damping model. To damp, specify a coefficient of restitution < 1."); + if (force->newton) + error->all(FLERR, "MDR contact model requires Newton off"); } else { if (damping_model->name == "none") error->all(FLERR, "Must specify damping granular model"); } From 39efb67a7a7feedca05041ecd4726fd648e02850 Mon Sep 17 00:00:00 2001 From: William Zunker Date: Sun, 22 Dec 2024 17:43:38 -0500 Subject: [PATCH 22/74] removed 14 particle MPFEM and 20,000 tabeleting simulation --- examples/granular/in.avicelTableting20000 | 184 - .../granular/in.mpfem.triaxial14particles | 164 - examples/granular/spheres20000.data | 20011 ---------------- 3 files changed, 20359 deletions(-) delete mode 100644 examples/granular/in.avicelTableting20000 delete mode 100644 examples/granular/in.mpfem.triaxial14particles delete mode 100644 examples/granular/spheres20000.data diff --git a/examples/granular/in.avicelTableting20000 b/examples/granular/in.avicelTableting20000 deleted file mode 100644 index 68b58024a0..0000000000 --- a/examples/granular/in.avicelTableting20000 +++ /dev/null @@ -1,184 +0,0 @@ -############################### SIMULATION SETTINGS ################################################### - -atom_style sphere 1 -atom_modify map array -comm_modify vel yes -units si -newton off -neighbor 0.22e-3 bin -neigh_modify every 10 delay 2000 check no -timestep 0.3e-7 -processors 2 2 1 - -######################### SIMULATION BOUNDING BOX, INTEGRATION, AND, GRAVITY ########################### - -boundary f f f -read_data spheres20000.data - -######################################### ADD DIE AND ATOM PARAMETERIZATION ############################################## - -variable atomRadius equal 0.0961e-3*1.25 -variable atomDiameter equal 2*${atomRadius} -variable atomDensity equal 1560 -variable atomMassAvg equal ${atomDensity}*4.0/3.0*PI*${atomRadius}^3.0 -variable dieRadius equal 4e-3 -variable dieHeight equal 1e-2 - -########################### PARTICLE MATERIAL PROPERTIES AND FORCE MODEL ############################### - -pair_style granular -# mdr = E, nu, Y, gamma, psi_b, CoR -# linear_history = k_t, x_gamma,t, mu_s -variable YoungsModulus equal 5e9 -variable YieldStress equal 1.9e8 -variable PoissonsRatio equal 0.4 -variable SurfaceEnergy equal 450 -variable SurfaceEnergyWall equal 0.0 -variable CoR equal 0.5 -variable psi_b equal 0.5 -variable beta equal -ln(${CoR})/sqrt(ln(${CoR})^2+PI^2) -variable kt equal 2/7*${YoungsModulus}*${atomRadius} -variable kt_wall equal 2/7*${YoungsModulus}*${atomRadius} -variable xgammat equal 0.0 #${beta}*sqrt(${atomMassAvg}*${YoungsModulus}*${atomRadius}) -variable mu_s equal 0.7 -variable mu_s_wall equal 0.1 -variable mu_roll equal 0.6 -variable k_roll equal 2.25*${mu_roll}*${mu_roll}*${YoungsModulus}*${atomRadius} -variable gamma_roll equal 0.0 #${beta}*sqrt(${atomMassAvg}*${YoungsModulus}*${atomRadius}) - -pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} damping none tangential linear_history ${kt} ${xgammat} ${mu_s} rolling sds ${k_roll} ${gamma_roll} ${mu_roll} -#pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none -#pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_nohistory 0.0 0.0 damping none - -######################################### ADD DIE AND PUNCH WALLS ################################################ - -variable disp_upper equal 0.0 -variable disp_lower equal 0.0 -variable disp_xPlanePos equal 0.0 -variable disp_xPlaneNeg equal 0.0 - -variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} damping none tangential linear_history ${kt_wall} ${xgammat} ${mu_s_wall} rolling sds ${k_roll} ${gamma_roll} ${mu_roll}" -#variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none" -#variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} tangential linear_nohistory 0.0 0.0 damping none" - -variable dieHeight2 equal 2*${dieHeight} - -region lowerPunch plane 0 0 0 0 0 1 side in units box move NULL NULL v_disp_lower units box -region upperPunch plane 0 0 ${dieHeight} 0 0 -1 side in move NULL NULL v_disp_upper units box -region die cylinder z 0 0 ${dieRadius} 0 ${dieHeight2} side in units box -variable dieRadiusPlus equal ${dieRadius}*1.05 -variable dieRadiusPlusNeg equal -${dieRadiusPlus} -region xPlanePos plane ${dieRadiusPlus} 0 0 -1 0 0 side in units box move v_disp_xPlanePos NULL NULL units box -region xPlaneNeg plane ${dieRadiusPlusNeg} 0 0 1 0 0 side in units box move v_disp_xPlaneNeg NULL NULL units box - -fix lowerPunch all wall/gran/region ${wall_contact_string} region lowerPunch contacts -fix upperPunch all wall/gran/region ${wall_contact_string} region upperPunch contacts -fix die all wall/gran/region ${wall_contact_string} region die contacts -fix xPlanePos all wall/gran/region ${wall_contact_string} region xPlanePos contacts -fix xPlaneNeg all wall/gran/region ${wall_contact_string} region xPlaneNeg contacts - -compute avgPunchForce all reduce sum f_upperPunch[4] -variable avgPunchForce equal c_avgPunchForce -compute avgLowerPunchForce all reduce sum f_lowerPunch[4] -variable avgLowerPunchForce equal c_avgLowerPunchForce -compute fractureForce all reduce sum f_xPlanePos[2] -variable fractureForce equal c_fractureForce - -fix print1 all print 1 "${disp_upper} ${avgPunchForce} ${avgLowerPunchForce} ${fractureForce}" file upperPunchDispForce.csv screen no -fix printSTL all print 1 "${disp_upper} ${disp_lower}" file punch_disp_STL_generation.csv screen no - -##################################### INSERT PARTICLES #################################################### - -fix 1 all nve/sphere -fix grav all gravity 9.81 vector 0 0 -1 - -######################################## SCREEN OUTPUT #################################################### - -#variable ax atom fx/mass -#variable ay atom fy/mass -#variable az atom fz/mass -#variable aMag atom sqrt(v_ax*v_ax+v_ay*v_ay+v_az*v_az) -#variable force atom sqrt(fx^2+fy^2+fz^2) -#compute aMagAvg all reduce ave v_aMag -#variable forceToAccelRatio atom v_force/(mass*v_aMag) - -compute 1 all erotate/sphere -thermo_style custom dt step atoms ke vol v_disp_upper #c_aMagAvg -thermo 100 -thermo_modify lost ignore norm no - -##################################### SET UP DUMP OUTPUTS #################################################### - -compute ke all ke/atom -variable output_rate equal round(1e-4/dt) -#variable output_rate equal 10 - -#dumpĀ 1 all custom 1 uniaxialCompression id type f_plane_yz_neg[*] -#variable az_upperPunch atom f_upperPunch[7] -#variable afz_upperPunch atom f_upperPunch[4] -#fix log all print 1 "${delta} ${fx_neg}" file uniaxialCompression.csv title "del,fx_yz_neg" screen no - -run 0 - -compute sigmaxx all property/atom d_sigmaxx -compute sigmayy all property/atom d_sigmayy -compute sigmazz all property/atom d_sigmazz -compute Velas all property/atom d_Velas -compute adhesive_length all property/atom d_adhesive_length - -compute sigmaxx_ave all reduce ave c_sigmaxx -compute sigmayy_ave all reduce ave c_sigmayy -compute sigmazz_ave all reduce ave c_sigmazz -compute Velas_sum all reduce sum c_Velas -compute adhesive_length_ave all reduce ave c_adhesive_length - -variable sxx_ave equal c_sigmaxx_ave -variable syy_ave equal c_sigmayy_ave -variable szz_ave equal c_sigmazz_ave -variable Vparticles equal c_Velas_sum -variable adh_length_ave equal c_adhesive_length_ave - -fix log all print 1 "${sxx_ave} ${syy_ave} ${szz_ave} ${Vparticles} ${adh_length_ave}" file avgStresses.csv screen no -dump dumpParticles all custom ${output_rate} avicelTableting.dump id type mass diameter x y z vx vy vz fx fy fz c_ke c_sigmaxx c_sigmayy c_sigmazz #v_aMag v_force v_forceToAccelRatio -#dump dumpParticlesVTK all vtk ${output_rate} post/particles_*.vtk id x y z fx fy fz vx vy vz c_ke radius c_sigmaxx c_sigmayy c_sigmazz - -######################################### RUN SIMULATION ########################################## - -variable upper_punch_stroke equal 0.6905*${dieHeight} # 0.6733 -variable vel_upper equal 0.25 - -variable settling_steps equal round(0.02/dt) -variable compression_steps equal 2*round(${upper_punch_stroke}/${vel_upper}/dt) -variable ejection_steps equal ${compression_steps} -variable free_float_steps equal round(0.02/dt) -variable total_steps equal ${settling_steps}+${compression_steps}+${ejection_steps}+${free_float_steps} - -print "Total steps = ${total_steps}" - -##### SETTLING ##### - -run ${settling_steps} - -##### Compression & Release ##### - -variable punch_frequency equal PI/2/(dt*${compression_steps}/2) -variable disp_upper equal -${upper_punch_stroke}*sin(${punch_frequency}*elapsed*dt) -variable short_release equal round(${compression_steps}*1.0) -run ${short_release} # 189170 upto # - -##### EJECTION ##### - -variable punch_frequency equal PI/2/(dt*${ejection_steps}) -variable disp_lower equal ${dieHeight}*sin(${punch_frequency}*elapsed*dt) -variable disp_upper equal 0.9*v_disp_lower -run ${ejection_steps} - -##### FREE FLOAT ##### - -variable disp_lower equal ${dieHeight} -variable disp_upper equal ${dieHeight}*0.9 -variable max_disp equal ${dieRadius}*0.75 -#variable disp_xPlanePos equal -${max_disp}*elapsed/${free_float_steps} -#variable disp_xPlaneNeg equal -v_disp_xPlanePos -run ${free_float_steps} - diff --git a/examples/granular/in.mpfem.triaxial14particles b/examples/granular/in.mpfem.triaxial14particles deleted file mode 100644 index 13c7b2232b..0000000000 --- a/examples/granular/in.mpfem.triaxial14particles +++ /dev/null @@ -1,164 +0,0 @@ -############################### SIMULATION SETTINGS ################################################### - -atom_style sphere 1 -atom_modify map array -comm_modify vel yes -units si -newton off -neighbor 2 bin -neigh_modify delay 0 -timestep 1e-6 -#processors 1 2 1 - -######################### SIMULATION BOUNDING BOX, INTEGRATION, AND, GRAVITY ########################### - -boundary f f f -region box block -100 100 -100 100 -100 100 units box -create_box 2 box -fix integr all nve/sphere - -########################### PARTICLE MATERIAL PROPERTIES AND FORCE MODEL ############################### - -variable atomRadius equal 0.5 - -pair_style granular -# mdr = E, nu, Y, gamma, psi_b, CoR -# linear_history = k_t, x_gamma,t, mu_s -variable YoungsModulus equal 1e9 -variable PoissonsRatio equal 0.3 -variable YieldStress equal 50e6 -variable SurfaceEnergy equal 0.0 -variable psi_b equal 0.5 -variable CoR equal 0.5 -variable kt equal 2/7*${YoungsModulus}*${atomRadius} -variable xgammat equal 0.0 -variable mu_s equal 0.5 - -pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none - -######################################### ADD IN PLANES ################################################ - -variable boxWidth equal 3 -variable halfBoxWidth equal ${boxWidth}/2 - -variable plane_disp equal 0.0 -variable plane_disp_neg equal 0.0 - -region plane_yz_pos plane ${halfBoxWidth} 0 0 -1 0 0 side in move v_plane_disp_neg NULL NULL units box -region plane_yz_neg plane -${halfBoxWidth} 0 0 1 0 0 side in move v_plane_disp NULL NULL units box -region plane_xz_pos plane 0 ${halfBoxWidth} 0 0 -1 0 side in move NULL v_plane_disp_neg NULL units box -region plane_xz_neg plane 0 -${halfBoxWidth} 0 0 1 0 side in move NULL v_plane_disp NULL units box -region plane_xy_pos plane 0 0 ${halfBoxWidth} 0 0 -1 side in move NULL NULL v_plane_disp_neg units box -region plane_xy_neg plane 0 0 -${halfBoxWidth} 0 0 1 side in move NULL NULL v_plane_disp units box - -variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none" - -fix plane_yz_pos all wall/gran/region ${wall_contact_string} region plane_yz_pos contacts -fix plane_yz_neg all wall/gran/region ${wall_contact_string} region plane_yz_neg contacts -fix plane_xz_pos all wall/gran/region ${wall_contact_string} region plane_xz_pos contacts -fix plane_xz_neg all wall/gran/region ${wall_contact_string} region plane_xz_neg contacts -fix plane_xy_pos all wall/gran/region ${wall_contact_string} region plane_xy_pos contacts -fix plane_xy_neg all wall/gran/region ${wall_contact_string} region plane_xy_neg contacts - -compute plane_xy_neg_force all reduce sum f_plane_xy_neg[4] -variable plane_xy_neg_force equal c_plane_xy_neg_force - -compute plane_xz_neg_force all reduce sum f_plane_xz_neg[3] -variable plane_xz_neg_force equal c_plane_xz_neg_force - -compute plane_yz_neg_force all reduce sum f_plane_yz_neg[2] -variable plane_yz_neg_force equal c_plane_yz_neg_force - -fix print1 all print 1 "${plane_disp} ${plane_xy_neg_force} ${plane_xz_neg_force} ${plane_yz_neg_force}" file lammps_macro_force_disp.csv screen no - -##################################### INSERT PARTICLES #################################################### - -# PARTICLE PROPERTIES -variable d equal 1 -variable den equal 1000 - -create_atoms 1 single -0.1682 0.1113 0.1492 units box -group atomOne id 1 -set atom 1 diameter ${d} density ${den} - -create_atoms 1 single 0.6234 -0.5134 0.4198 units box -group atomTwo id 2 -set atom 2 diameter ${d} density ${den} - -create_atoms 1 single 0.8958 0.8304 0.1353 units box -group atomThree id 3 -set atom 3 diameter ${d} density ${den} - -create_atoms 1 single -0.1058 -0.9321 -0.2803 units box -group atomFour id 4 -set atom 4 diameter ${d} density ${den} - -create_atoms 1 single -0.7816 0.5089 -0.5358 units box -group atomFive id 5 -set atom 5 diameter ${d} density ${den} - -create_atoms 1 single 0.09169 -0.1675 -0.9413 units box -group atomSix id 6 -set atom 6 diameter ${d} density ${den} - -create_atoms 1 single -0.8324 -0.6242 -0.9531 units box -group atomSeven id 7 -set atom 7 diameter ${d} density ${den} - -create_atoms 1 single -0.8994 -0.6587 0.9025 units box -group atomEight id 8 -set atom 8 diameter ${d} density ${den} - -create_atoms 1 single -0.08605 0.8565 0.8629 units box -group atomNine id 9 -set atom 9 diameter ${d} density ${den} - -create_atoms 1 single 0.7989 0.8445 -0.9942 units box -group atomTen id 10 -set atom 10 diameter ${d} density ${den} - -create_atoms 1 single 0.9317 -0.8971 -0.8523 units box -group atomEleven id 11 -set atom 11 diameter ${d} density ${den} - -create_atoms 1 single -0.979 0.3867 0.7977 units box -group atomTwelve id 12 -set atom 12 diameter ${d} density ${den} - -create_atoms 1 single 0.9926 0.2609 0.9693 units box -group atomThirteen id 13 -set atom 13 diameter ${d} density ${den} - -create_atoms 1 single 0.9814 0.01161 -0.4335 units box -group atomFourteen id 14 -set atom 14 diameter ${d} density ${den} - -######################################## SCREEN OUTPUT #################################################### - -compute 1 all erotate/sphere -thermo_style custom dt step atoms ke c_1 vol -thermo 100 -thermo_modify lost ignore norm no - -##################################### DEFINE WALL MOVEMENT ################################################# - -variable disp_max equal 0.45 -variable ddisp equal 0.00001 -variable compression_steps equal round(${disp_max}/${ddisp}) -variable output_rate equal round(${compression_steps}/100) - -##################################### SET UP DUMP OUTPUTS #################################################### - -#dump dmp all vtk ${output_rate} post/triaxial14particles_*.vtk id type mass x y z vx vy vz fx fy fz radius -dump dumpParticles all custom ${output_rate} triaxial14particles.dump id type mass x y z vx vy vz fx fy fz radius - -#################################### COMPRESS THE PARTICLES ################################################## - -run 0 - -variable plane_disp equal ${ddisp}*elapsed -variable plane_disp_neg equal -${ddisp}*elapsed - -run ${compression_steps} - -#################################### UNCOMPRESS THE PARTICLES ################################################ diff --git a/examples/granular/spheres20000.data b/examples/granular/spheres20000.data deleted file mode 100644 index a1a7d6b456..0000000000 --- a/examples/granular/spheres20000.data +++ /dev/null @@ -1,20011 +0,0 @@ -#LAMMPS data file created by matlab. -20000 atoms - -1 atom types - --0.005000 0.005000 xlo xhi --0.005000 0.005000 ylo yhi --0.001000 0.020000 zlo zhi - -Atoms - -1 1 0.000249 1560.000000 0.000469 -0.000120 0.008380 -2 1 0.000260 1560.000000 -0.001811 0.000425 0.004090 -3 1 0.000225 1560.000000 -0.001371 0.000426 0.002952 -4 1 0.000252 1560.000000 0.000928 -0.000089 0.004118 -5 1 0.000210 1560.000000 0.000208 0.000384 0.000842 -6 1 0.000218 1560.000000 -0.002456 -0.000587 0.003834 -7 1 0.000201 1560.000000 -0.000278 0.003459 0.003445 -8 1 0.000231 1560.000000 -0.002123 0.003188 0.004799 -9 1 0.000268 1560.000000 -0.000338 -0.001557 0.007382 -10 1 0.000244 1560.000000 0.002537 0.002151 0.005999 -11 1 0.000264 1560.000000 -0.002812 0.001089 0.005793 -12 1 0.000270 1560.000000 0.000534 -0.001644 0.004376 -13 1 0.000202 1560.000000 -0.000821 -0.002210 0.000606 -14 1 0.000233 1560.000000 -0.003602 -0.000655 0.005498 -15 1 0.000200 1560.000000 -0.003513 0.000848 0.009759 -16 1 0.000213 1560.000000 -0.000957 0.002385 0.006657 -17 1 0.000258 1560.000000 -0.002657 -0.001653 0.002864 -18 1 0.000255 1560.000000 0.003288 0.000715 0.008901 -19 1 0.000249 1560.000000 -0.002116 0.001063 0.009030 -20 1 0.000196 1560.000000 -0.001865 -0.001067 0.008442 -21 1 0.000228 1560.000000 0.001349 0.002014 0.000518 -22 1 0.000209 1560.000000 0.003156 -0.000420 0.007538 -23 1 0.000259 1560.000000 0.003818 -0.000308 0.005761 -24 1 0.000218 1560.000000 -0.000163 -0.002505 0.002645 -25 1 0.000232 1560.000000 0.000135 0.000677 0.007933 -26 1 0.000214 1560.000000 -0.000812 0.002556 0.006276 -27 1 0.000196 1560.000000 -0.001579 -0.001167 0.003510 -28 1 0.000263 1560.000000 0.000309 -0.000739 0.008174 -29 1 0.000283 1560.000000 0.000429 -0.000200 0.006139 -30 1 0.000210 1560.000000 -0.001097 0.001375 0.002566 -31 1 0.000206 1560.000000 0.002158 0.002163 0.009702 -32 1 0.000211 1560.000000 0.001218 0.000035 0.008695 -33 1 0.000198 1560.000000 -0.002087 0.001121 0.005737 -34 1 0.000224 1560.000000 0.002160 -0.001821 0.004330 -35 1 0.000220 1560.000000 -0.000316 -0.000717 0.004389 -36 1 0.000199 1560.000000 0.001124 0.001672 0.005800 -37 1 0.000215 1560.000000 0.000292 -0.001358 0.004571 -38 1 0.000245 1560.000000 0.001525 -0.002513 0.001746 -39 1 0.000202 1560.000000 -0.002825 -0.000332 0.003862 -40 1 0.000286 1560.000000 -0.002224 0.002820 0.008412 -41 1 0.000247 1560.000000 0.001381 -0.003093 0.002687 -42 1 0.000195 1560.000000 -0.000589 -0.001284 0.009028 -43 1 0.000201 1560.000000 -0.000757 0.001986 0.003420 -44 1 0.000283 1560.000000 0.002027 0.001763 0.004546 -45 1 0.000227 1560.000000 -0.000848 -0.002204 0.006488 -46 1 0.000266 1560.000000 0.001283 0.002198 0.009445 -47 1 0.000234 1560.000000 0.000592 -0.002949 0.008638 -48 1 0.000232 1560.000000 0.000045 -0.000255 0.004406 -49 1 0.000229 1560.000000 0.000838 -0.000849 0.002000 -50 1 0.000209 1560.000000 -0.000921 0.000408 0.009360 -51 1 0.000260 1560.000000 -0.000209 0.000741 0.000915 -52 1 0.000222 1560.000000 -0.002147 0.001598 0.001554 -53 1 0.000233 1560.000000 -0.001177 -0.000281 0.003854 -54 1 0.000222 1560.000000 -0.003516 0.000410 0.002948 -55 1 0.000209 1560.000000 -0.000075 -0.001531 0.004811 -56 1 0.000225 1560.000000 0.000655 0.003467 0.008076 -57 1 0.000280 1560.000000 -0.001197 0.001083 0.000292 -58 1 0.000200 1560.000000 0.001068 0.001637 0.000349 -59 1 0.000194 1560.000000 0.002652 0.001467 0.004444 -60 1 0.000217 1560.000000 0.002179 -0.001172 0.000294 -61 1 0.000207 1560.000000 -0.000953 -0.000834 0.004460 -62 1 0.000207 1560.000000 -0.001480 -0.000410 0.003511 -63 1 0.000279 1560.000000 -0.001087 -0.000693 0.008258 -64 1 0.000256 1560.000000 0.000170 0.001783 0.000630 -65 1 0.000220 1560.000000 -0.000007 -0.000164 0.003013 -66 1 0.000284 1560.000000 0.002626 -0.001857 0.001733 -67 1 0.000206 1560.000000 -0.000654 -0.002228 0.008058 -68 1 0.000205 1560.000000 -0.000507 0.000866 0.004436 -69 1 0.000199 1560.000000 -0.000878 0.000565 0.005079 -70 1 0.000200 1560.000000 0.000351 -0.000964 0.001926 -71 1 0.000199 1560.000000 -0.001293 -0.000398 0.004203 -72 1 0.000257 1560.000000 -0.000866 0.001680 0.002213 -73 1 0.000211 1560.000000 0.000031 -0.000000 0.004846 -74 1 0.000240 1560.000000 -0.001303 -0.001095 0.006233 -75 1 0.000215 1560.000000 -0.000248 0.001446 0.009156 -76 1 0.000264 1560.000000 0.001143 -0.000973 0.004437 -77 1 0.000219 1560.000000 -0.003333 0.001897 0.006589 -78 1 0.000218 1560.000000 -0.002367 0.000960 0.001459 -79 1 0.000230 1560.000000 -0.002140 -0.001380 0.007698 -80 1 0.000251 1560.000000 0.000366 -0.000344 0.008242 -81 1 0.000247 1560.000000 0.000501 -0.000335 0.009322 -82 1 0.000215 1560.000000 0.002009 0.000298 0.005443 -83 1 0.000283 1560.000000 -0.002926 0.000927 0.009792 -84 1 0.000215 1560.000000 -0.000843 -0.000333 0.000979 -85 1 0.000223 1560.000000 0.001897 -0.001007 0.007430 -86 1 0.000248 1560.000000 -0.001685 -0.002868 0.007402 -87 1 0.000265 1560.000000 -0.002089 -0.001441 0.000652 -88 1 0.000202 1560.000000 0.001461 -0.000936 0.009070 -89 1 0.000192 1560.000000 -0.003141 0.001371 0.000662 -90 1 0.000216 1560.000000 -0.003227 0.001709 0.003457 -91 1 0.000250 1560.000000 -0.002180 -0.000936 0.005525 -92 1 0.000213 1560.000000 -0.000780 -0.000797 0.007704 -93 1 0.000202 1560.000000 0.000574 0.000317 0.006044 -94 1 0.000207 1560.000000 0.002259 -0.002661 0.001543 -95 1 0.000205 1560.000000 0.000869 -0.001213 0.004216 -96 1 0.000247 1560.000000 0.000054 0.000679 0.001068 -97 1 0.000268 1560.000000 -0.001566 -0.003158 0.002954 -98 1 0.000259 1560.000000 -0.001234 0.002509 0.002929 -99 1 0.000221 1560.000000 -0.000526 -0.000660 0.007294 -100 1 0.000210 1560.000000 -0.002108 -0.003035 0.003977 -101 1 0.000233 1560.000000 0.000094 0.000401 0.003069 -102 1 0.000251 1560.000000 -0.000292 0.002404 0.006452 -103 1 0.000229 1560.000000 0.000037 -0.000005 0.002751 -104 1 0.000264 1560.000000 0.002193 0.002674 0.006165 -105 1 0.000206 1560.000000 -0.000165 0.000792 0.000281 -106 1 0.000249 1560.000000 -0.001911 -0.000797 0.004484 -107 1 0.000261 1560.000000 -0.001997 -0.000334 0.002014 -108 1 0.000218 1560.000000 0.000117 -0.001736 0.006276 -109 1 0.000218 1560.000000 0.000964 -0.001048 0.001134 -110 1 0.000274 1560.000000 0.000020 0.000010 0.008701 -111 1 0.000251 1560.000000 0.000583 0.000402 0.000607 -112 1 0.000288 1560.000000 0.001098 -0.001839 0.004237 -113 1 0.000201 1560.000000 0.000345 0.000635 0.001170 -114 1 0.000267 1560.000000 -0.001105 0.000192 0.008679 -115 1 0.000201 1560.000000 -0.002871 0.000514 0.008607 -116 1 0.000204 1560.000000 0.000602 -0.000058 0.004148 -117 1 0.000194 1560.000000 0.002025 -0.001347 0.003345 -118 1 0.000234 1560.000000 0.000093 -0.000334 0.006551 -119 1 0.000246 1560.000000 0.000478 0.001163 0.002303 -120 1 0.000213 1560.000000 -0.001975 -0.000529 0.004929 -121 1 0.000263 1560.000000 0.000258 -0.001969 0.006239 -122 1 0.000211 1560.000000 -0.000042 -0.000463 0.006763 -123 1 0.000218 1560.000000 0.003023 0.002183 0.006863 -124 1 0.000213 1560.000000 0.001330 0.000804 0.005343 -125 1 0.000194 1560.000000 -0.000272 0.000276 0.005329 -126 1 0.000211 1560.000000 0.000369 -0.001142 0.006245 -127 1 0.000275 1560.000000 -0.000328 -0.001813 0.007764 -128 1 0.000211 1560.000000 0.000540 0.000784 0.009356 -129 1 0.000221 1560.000000 -0.002521 -0.001368 0.003344 -130 1 0.000243 1560.000000 -0.000235 0.002439 0.004689 -131 1 0.000257 1560.000000 -0.000475 -0.000602 0.001151 -132 1 0.000208 1560.000000 0.003506 -0.001601 0.006389 -133 1 0.000240 1560.000000 -0.001836 -0.001554 0.000985 -134 1 0.000210 1560.000000 0.001135 0.000943 0.006561 -135 1 0.000210 1560.000000 -0.000394 0.001912 0.004612 -136 1 0.000273 1560.000000 0.001081 -0.001085 0.005471 -137 1 0.000252 1560.000000 0.002278 0.000292 0.008512 -138 1 0.000194 1560.000000 0.001233 0.000558 0.000467 -139 1 0.000211 1560.000000 0.002251 -0.002320 0.000173 -140 1 0.000200 1560.000000 -0.001657 -0.000886 0.002597 -141 1 0.000213 1560.000000 -0.000978 -0.000002 0.004751 -142 1 0.000201 1560.000000 0.000007 0.000337 0.008507 -143 1 0.000254 1560.000000 -0.002294 0.000403 0.003150 -144 1 0.000213 1560.000000 0.001042 0.000621 0.006025 -145 1 0.000220 1560.000000 -0.003069 0.001304 0.007319 -146 1 0.000207 1560.000000 -0.002406 0.002623 0.008512 -147 1 0.000246 1560.000000 0.000039 -0.000056 0.008359 -148 1 0.000238 1560.000000 -0.000212 -0.001271 0.002909 -149 1 0.000251 1560.000000 -0.000951 -0.000765 0.005294 -150 1 0.000239 1560.000000 -0.000184 0.002581 0.007233 -151 1 0.000219 1560.000000 0.001427 -0.001462 0.000812 -152 1 0.000279 1560.000000 -0.002353 -0.001714 0.002577 -153 1 0.000196 1560.000000 -0.000512 -0.002367 0.009109 -154 1 0.000204 1560.000000 -0.000832 -0.001318 0.004055 -155 1 0.000281 1560.000000 0.001907 0.002278 0.002727 -156 1 0.000218 1560.000000 0.000500 0.000507 0.009389 -157 1 0.000279 1560.000000 0.000231 0.003009 0.001404 -158 1 0.000212 1560.000000 -0.000318 -0.001114 0.004604 -159 1 0.000258 1560.000000 0.001008 -0.001028 0.007888 -160 1 0.000240 1560.000000 0.000159 0.001563 0.005064 -161 1 0.000239 1560.000000 0.001533 0.001103 0.008321 -162 1 0.000260 1560.000000 -0.000488 0.001972 0.006126 -163 1 0.000252 1560.000000 -0.001053 -0.001779 0.005619 -164 1 0.000215 1560.000000 -0.000771 0.000929 0.002087 -165 1 0.000217 1560.000000 -0.000384 0.002539 0.002357 -166 1 0.000226 1560.000000 -0.000655 -0.000521 0.006932 -167 1 0.000196 1560.000000 0.000452 -0.000191 0.000871 -168 1 0.000213 1560.000000 -0.000270 0.001376 0.005861 -169 1 0.000214 1560.000000 0.001340 -0.002576 0.008470 -170 1 0.000271 1560.000000 0.000639 0.003224 0.004104 -171 1 0.000200 1560.000000 0.000007 0.000010 0.005310 -172 1 0.000209 1560.000000 -0.000034 -0.001014 0.005754 -173 1 0.000288 1560.000000 -0.001923 0.001375 0.001307 -174 1 0.000224 1560.000000 0.001230 -0.001701 0.005853 -175 1 0.000194 1560.000000 0.002927 0.000097 0.004369 -176 1 0.000195 1560.000000 0.003121 0.001721 0.002774 -177 1 0.000221 1560.000000 -0.000272 0.002133 0.009051 -178 1 0.000268 1560.000000 -0.000269 0.001097 0.009115 -179 1 0.000209 1560.000000 0.000118 -0.001775 0.005648 -180 1 0.000199 1560.000000 0.002225 -0.001841 0.007023 -181 1 0.000208 1560.000000 0.001881 0.002699 0.005026 -182 1 0.000253 1560.000000 -0.000038 -0.000253 0.009645 -183 1 0.000253 1560.000000 -0.000425 -0.000639 0.000796 -184 1 0.000277 1560.000000 -0.000545 0.001022 0.007959 -185 1 0.000225 1560.000000 -0.000770 -0.002720 0.004457 -186 1 0.000255 1560.000000 -0.000025 0.001350 0.000236 -187 1 0.000200 1560.000000 -0.000821 0.000768 0.001026 -188 1 0.000285 1560.000000 -0.000307 0.000115 0.009808 -189 1 0.000198 1560.000000 -0.002294 0.000298 0.001281 -190 1 0.000220 1560.000000 -0.001090 -0.001003 0.000978 -191 1 0.000246 1560.000000 0.000537 0.003705 0.005906 -192 1 0.000277 1560.000000 -0.001667 -0.001925 0.000235 -193 1 0.000251 1560.000000 -0.000627 0.000307 0.006225 -194 1 0.000279 1560.000000 0.001730 -0.000577 0.008220 -195 1 0.000213 1560.000000 -0.003133 0.000091 0.001891 -196 1 0.000256 1560.000000 -0.002840 0.001479 0.000989 -197 1 0.000258 1560.000000 -0.001875 0.002470 0.004126 -198 1 0.000245 1560.000000 -0.001057 0.003496 0.001572 -199 1 0.000214 1560.000000 0.000030 0.000688 0.002115 -200 1 0.000272 1560.000000 -0.000289 -0.000753 0.004764 -201 1 0.000269 1560.000000 -0.001776 0.003408 0.000971 -202 1 0.000226 1560.000000 0.000763 -0.000008 0.000760 -203 1 0.000221 1560.000000 0.000459 -0.001557 0.007870 -204 1 0.000198 1560.000000 0.000588 -0.001155 0.002077 -205 1 0.000193 1560.000000 -0.002014 0.001563 0.000490 -206 1 0.000237 1560.000000 -0.001360 -0.003562 0.008615 -207 1 0.000204 1560.000000 -0.000216 -0.003156 0.009075 -208 1 0.000215 1560.000000 -0.000758 0.001862 0.005924 -209 1 0.000269 1560.000000 -0.001979 0.003229 0.009020 -210 1 0.000260 1560.000000 0.000253 0.001661 0.001142 -211 1 0.000239 1560.000000 -0.000606 -0.001207 0.005281 -212 1 0.000215 1560.000000 0.002543 0.002061 0.001306 -213 1 0.000227 1560.000000 0.000329 -0.001157 0.002566 -214 1 0.000221 1560.000000 -0.003407 0.000645 0.009682 -215 1 0.000209 1560.000000 0.002106 0.000122 0.004737 -216 1 0.000273 1560.000000 -0.001438 -0.000803 0.001200 -217 1 0.000194 1560.000000 0.001382 -0.001687 0.004273 -218 1 0.000262 1560.000000 -0.003514 -0.001219 0.006249 -219 1 0.000281 1560.000000 0.000430 0.002503 0.001923 -220 1 0.000206 1560.000000 0.000932 0.000130 0.006431 -221 1 0.000267 1560.000000 -0.001525 0.001496 0.007740 -222 1 0.000269 1560.000000 0.000784 -0.000656 0.004351 -223 1 0.000202 1560.000000 -0.001642 -0.000005 0.009149 -224 1 0.000208 1560.000000 0.002769 0.000021 0.002063 -225 1 0.000210 1560.000000 -0.000337 0.001507 0.005194 -226 1 0.000200 1560.000000 -0.001084 0.001255 0.002069 -227 1 0.000199 1560.000000 0.001088 -0.002858 0.006694 -228 1 0.000207 1560.000000 -0.000317 0.002226 0.008669 -229 1 0.000199 1560.000000 0.001585 -0.001840 0.001720 -230 1 0.000240 1560.000000 -0.000044 0.001343 0.003140 -231 1 0.000245 1560.000000 0.000132 0.000126 0.004174 -232 1 0.000204 1560.000000 -0.000961 0.001684 0.006521 -233 1 0.000220 1560.000000 -0.000848 0.000382 0.004673 -234 1 0.000275 1560.000000 0.000896 -0.000783 0.007703 -235 1 0.000238 1560.000000 0.002389 0.001830 0.001126 -236 1 0.000264 1560.000000 -0.002387 0.002151 0.006864 -237 1 0.000253 1560.000000 0.002127 -0.001229 0.002479 -238 1 0.000207 1560.000000 0.000557 0.000267 0.000365 -239 1 0.000237 1560.000000 0.001089 0.000158 0.004714 -240 1 0.000258 1560.000000 0.002352 0.001182 0.008799 -241 1 0.000231 1560.000000 -0.001156 0.000269 0.002237 -242 1 0.000268 1560.000000 0.002280 -0.000867 0.003481 -243 1 0.000233 1560.000000 -0.001035 -0.003371 0.004884 -244 1 0.000202 1560.000000 0.001820 -0.002609 0.003003 -245 1 0.000222 1560.000000 0.000186 -0.000567 0.005062 -246 1 0.000272 1560.000000 0.000305 -0.000034 0.001804 -247 1 0.000247 1560.000000 -0.000659 0.001397 0.006732 -248 1 0.000196 1560.000000 -0.001709 0.002068 0.009398 -249 1 0.000239 1560.000000 0.000560 -0.000741 0.000344 -250 1 0.000198 1560.000000 0.000977 -0.001539 0.008061 -251 1 0.000204 1560.000000 0.000327 0.000008 0.004672 -252 1 0.000276 1560.000000 -0.000424 -0.002047 0.005116 -253 1 0.000205 1560.000000 -0.001524 0.001298 0.004969 -254 1 0.000198 1560.000000 0.002470 -0.001352 0.003942 -255 1 0.000255 1560.000000 -0.001336 -0.003034 0.004611 -256 1 0.000204 1560.000000 0.001270 -0.000582 0.003671 -257 1 0.000229 1560.000000 0.000817 0.000533 0.006858 -258 1 0.000214 1560.000000 0.000797 0.000577 0.001613 -259 1 0.000241 1560.000000 -0.001571 -0.000094 0.004459 -260 1 0.000264 1560.000000 0.000572 -0.000096 0.004627 -261 1 0.000246 1560.000000 -0.000210 -0.000032 0.001735 -262 1 0.000200 1560.000000 0.001364 -0.000397 0.006898 -263 1 0.000280 1560.000000 0.002868 0.001304 0.000507 -264 1 0.000239 1560.000000 0.001848 -0.000377 0.004486 -265 1 0.000216 1560.000000 -0.000124 0.000436 0.005904 -266 1 0.000207 1560.000000 -0.000018 0.000518 0.005562 -267 1 0.000195 1560.000000 -0.001105 0.001132 0.005937 -268 1 0.000215 1560.000000 0.001856 0.000254 0.007704 -269 1 0.000195 1560.000000 -0.000253 -0.002794 0.009019 -270 1 0.000246 1560.000000 -0.001030 0.000096 0.000959 -271 1 0.000272 1560.000000 0.001902 -0.000560 0.009484 -272 1 0.000253 1560.000000 -0.000731 -0.000205 0.003454 -273 1 0.000269 1560.000000 0.002908 -0.000934 0.004936 -274 1 0.000202 1560.000000 0.000846 -0.000599 0.001115 -275 1 0.000218 1560.000000 0.002967 -0.001434 0.005794 -276 1 0.000231 1560.000000 -0.002820 -0.000058 0.006038 -277 1 0.000262 1560.000000 -0.003074 0.000145 0.006819 -278 1 0.000260 1560.000000 0.003483 -0.000933 0.002575 -279 1 0.000230 1560.000000 0.001793 -0.002592 0.003823 -280 1 0.000231 1560.000000 -0.001145 -0.002099 0.000225 -281 1 0.000257 1560.000000 -0.003265 0.000257 0.007576 -282 1 0.000227 1560.000000 -0.001636 0.001083 0.008769 -283 1 0.000202 1560.000000 0.002974 -0.000784 0.008846 -284 1 0.000212 1560.000000 -0.002581 0.001257 0.007487 -285 1 0.000234 1560.000000 0.001346 0.000290 0.000613 -286 1 0.000275 1560.000000 -0.000891 -0.000920 0.002739 -287 1 0.000208 1560.000000 0.000983 -0.003357 0.005173 -288 1 0.000230 1560.000000 -0.003404 0.001634 0.000568 -289 1 0.000220 1560.000000 0.002107 -0.001778 0.005106 -290 1 0.000201 1560.000000 -0.000677 -0.001113 0.000882 -291 1 0.000196 1560.000000 0.000010 0.000006 0.009186 -292 1 0.000261 1560.000000 -0.000158 0.000089 0.005562 -293 1 0.000247 1560.000000 0.001587 -0.002354 0.003058 -294 1 0.000238 1560.000000 -0.001575 0.000382 0.005643 -295 1 0.000219 1560.000000 0.003762 -0.000528 0.005318 -296 1 0.000247 1560.000000 -0.003299 -0.000884 0.001741 -297 1 0.000247 1560.000000 0.001898 -0.000081 0.002720 -298 1 0.000203 1560.000000 -0.001252 0.001154 0.003674 -299 1 0.000211 1560.000000 -0.001337 0.002187 0.007398 -300 1 0.000223 1560.000000 -0.001777 0.002697 0.009161 -301 1 0.000207 1560.000000 -0.000221 -0.000322 0.001353 -302 1 0.000255 1560.000000 0.000245 0.000335 0.007342 -303 1 0.000226 1560.000000 0.000106 0.000440 0.002371 -304 1 0.000208 1560.000000 0.000142 -0.001388 0.004023 -305 1 0.000235 1560.000000 -0.001912 0.003308 0.002340 -306 1 0.000224 1560.000000 0.000690 -0.000702 0.009627 -307 1 0.000283 1560.000000 -0.001258 0.000364 0.009255 -308 1 0.000197 1560.000000 0.000944 -0.000798 0.005038 -309 1 0.000236 1560.000000 -0.001010 0.002174 0.006180 -310 1 0.000220 1560.000000 0.002619 -0.000637 0.005267 -311 1 0.000231 1560.000000 0.000700 -0.000606 0.008750 -312 1 0.000194 1560.000000 -0.001452 -0.001124 0.006867 -313 1 0.000237 1560.000000 -0.001090 0.002442 0.009122 -314 1 0.000285 1560.000000 0.001307 0.002709 0.007678 -315 1 0.000193 1560.000000 0.001830 0.001400 0.001897 -316 1 0.000271 1560.000000 -0.003790 -0.000033 0.002116 -317 1 0.000242 1560.000000 0.000731 -0.003370 0.008725 -318 1 0.000233 1560.000000 -0.000094 0.000007 0.000533 -319 1 0.000269 1560.000000 -0.000031 0.000242 0.002277 -320 1 0.000219 1560.000000 0.001476 -0.002500 0.000791 -321 1 0.000217 1560.000000 0.000206 0.002364 0.009321 -322 1 0.000281 1560.000000 -0.001864 0.001781 0.004907 -323 1 0.000255 1560.000000 -0.000172 -0.000507 0.007446 -324 1 0.000206 1560.000000 -0.002741 0.000897 0.005139 -325 1 0.000266 1560.000000 0.000277 0.002188 0.004751 -326 1 0.000234 1560.000000 -0.000749 0.000935 0.004024 -327 1 0.000249 1560.000000 -0.000270 -0.000961 0.002876 -328 1 0.000222 1560.000000 0.001256 0.001177 0.004148 -329 1 0.000263 1560.000000 -0.000618 0.002557 0.007612 -330 1 0.000239 1560.000000 0.000977 0.003160 0.000855 -331 1 0.000211 1560.000000 -0.000099 0.000053 0.006126 -332 1 0.000217 1560.000000 0.003143 -0.002020 0.007748 -333 1 0.000206 1560.000000 -0.003541 0.000836 0.005474 -334 1 0.000204 1560.000000 0.003654 0.000599 0.002317 -335 1 0.000229 1560.000000 -0.000033 0.000170 0.008123 -336 1 0.000279 1560.000000 0.001792 0.000238 0.004673 -337 1 0.000265 1560.000000 -0.000786 0.003405 0.004286 -338 1 0.000264 1560.000000 0.000491 -0.000580 0.006924 -339 1 0.000223 1560.000000 0.000677 -0.002068 0.004319 -340 1 0.000282 1560.000000 0.003094 -0.001733 0.005701 -341 1 0.000252 1560.000000 -0.003847 0.000040 0.001316 -342 1 0.000244 1560.000000 0.000238 0.000077 0.009351 -343 1 0.000277 1560.000000 -0.000686 0.001453 0.005967 -344 1 0.000235 1560.000000 -0.000600 -0.000782 0.008229 -345 1 0.000203 1560.000000 -0.001910 0.001805 0.008419 -346 1 0.000208 1560.000000 0.002102 0.002702 0.004056 -347 1 0.000227 1560.000000 -0.001236 0.000184 0.000346 -348 1 0.000231 1560.000000 0.002540 0.001017 0.007365 -349 1 0.000287 1560.000000 0.000015 0.000237 0.008929 -350 1 0.000285 1560.000000 0.002420 -0.000109 0.001133 -351 1 0.000268 1560.000000 -0.000184 0.001132 0.008478 -352 1 0.000193 1560.000000 -0.000468 0.001754 0.007542 -353 1 0.000201 1560.000000 -0.001372 -0.001212 0.000771 -354 1 0.000269 1560.000000 0.000210 -0.001531 0.003476 -355 1 0.000213 1560.000000 -0.000707 0.000560 0.000486 -356 1 0.000207 1560.000000 0.000391 -0.001862 0.007317 -357 1 0.000263 1560.000000 -0.003138 0.000609 0.002062 -358 1 0.000192 1560.000000 0.000222 -0.000679 0.003748 -359 1 0.000218 1560.000000 -0.000425 0.001368 0.002455 -360 1 0.000252 1560.000000 0.000335 0.000293 0.003701 -361 1 0.000207 1560.000000 -0.000519 0.000708 0.006305 -362 1 0.000200 1560.000000 0.000943 -0.001297 0.008185 -363 1 0.000201 1560.000000 -0.000634 0.000741 0.005401 -364 1 0.000196 1560.000000 0.000371 0.001359 0.009430 -365 1 0.000195 1560.000000 0.002323 -0.001384 0.002023 -366 1 0.000281 1560.000000 -0.002562 0.000266 0.008341 -367 1 0.000206 1560.000000 -0.000184 0.002023 0.004854 -368 1 0.000269 1560.000000 0.000897 0.000557 0.008875 -369 1 0.000266 1560.000000 0.000424 -0.002808 0.007782 -370 1 0.000238 1560.000000 0.001614 -0.000984 0.000728 -371 1 0.000212 1560.000000 0.000997 -0.002037 0.006249 -372 1 0.000243 1560.000000 -0.002333 -0.000796 0.004059 -373 1 0.000204 1560.000000 -0.000806 -0.000246 0.004816 -374 1 0.000207 1560.000000 0.001415 0.002158 0.006242 -375 1 0.000286 1560.000000 -0.003098 -0.001276 0.006569 -376 1 0.000195 1560.000000 0.001783 0.002926 0.001085 -377 1 0.000195 1560.000000 -0.001135 -0.000854 0.002803 -378 1 0.000277 1560.000000 0.000320 -0.001696 0.007592 -379 1 0.000273 1560.000000 0.000769 0.000044 0.009188 -380 1 0.000259 1560.000000 -0.000059 -0.000090 0.005811 -381 1 0.000194 1560.000000 0.000501 -0.002114 0.009000 -382 1 0.000265 1560.000000 0.000180 0.002356 0.005452 -383 1 0.000242 1560.000000 0.001319 -0.001681 0.006849 -384 1 0.000253 1560.000000 -0.001989 -0.001043 0.001848 -385 1 0.000197 1560.000000 -0.002005 -0.000476 0.001024 -386 1 0.000268 1560.000000 0.001367 0.001539 0.002991 -387 1 0.000203 1560.000000 0.000970 -0.000302 0.006423 -388 1 0.000238 1560.000000 -0.000720 0.000774 0.009765 -389 1 0.000219 1560.000000 -0.000383 -0.000494 0.000495 -390 1 0.000206 1560.000000 0.000771 -0.000774 0.006966 -391 1 0.000195 1560.000000 -0.001213 0.001444 0.008684 -392 1 0.000227 1560.000000 -0.000789 -0.003470 0.000537 -393 1 0.000236 1560.000000 0.000011 -0.000646 0.007948 -394 1 0.000210 1560.000000 -0.001028 0.000120 0.007499 -395 1 0.000275 1560.000000 0.000710 -0.000915 0.004603 -396 1 0.000218 1560.000000 -0.000024 -0.000196 0.000255 -397 1 0.000243 1560.000000 0.001641 -0.002707 0.004455 -398 1 0.000277 1560.000000 -0.001819 -0.000641 0.000575 -399 1 0.000231 1560.000000 -0.000231 -0.001152 0.002579 -400 1 0.000198 1560.000000 -0.001642 -0.000892 0.004934 -401 1 0.000285 1560.000000 -0.000471 0.002843 0.005252 -402 1 0.000210 1560.000000 -0.001137 -0.001177 0.004788 -403 1 0.000261 1560.000000 -0.000331 0.000022 0.009011 -404 1 0.000218 1560.000000 0.001058 -0.001376 0.004804 -405 1 0.000235 1560.000000 -0.001121 0.003463 0.007541 -406 1 0.000226 1560.000000 -0.003273 0.001410 0.006881 -407 1 0.000196 1560.000000 0.002791 0.001881 0.001274 -408 1 0.000195 1560.000000 -0.001721 -0.003144 0.001650 -409 1 0.000255 1560.000000 0.000831 0.000749 0.004569 -410 1 0.000213 1560.000000 -0.001713 0.003014 0.008727 -411 1 0.000198 1560.000000 0.001571 -0.002311 0.004639 -412 1 0.000276 1560.000000 -0.003638 0.000905 0.007480 -413 1 0.000252 1560.000000 -0.002796 -0.001706 0.009479 -414 1 0.000254 1560.000000 -0.001729 0.000826 0.008606 -415 1 0.000204 1560.000000 -0.002172 0.001393 0.005480 -416 1 0.000208 1560.000000 0.003035 0.001220 0.003680 -417 1 0.000254 1560.000000 0.002549 0.000846 0.000208 -418 1 0.000195 1560.000000 0.000684 -0.001549 0.004221 -419 1 0.000211 1560.000000 -0.001618 -0.000721 0.001654 -420 1 0.000255 1560.000000 0.002356 -0.003012 0.009718 -421 1 0.000193 1560.000000 0.000005 -0.000008 0.009735 -422 1 0.000210 1560.000000 0.000489 0.002339 0.000387 -423 1 0.000210 1560.000000 0.000403 0.001391 0.007620 -424 1 0.000225 1560.000000 -0.001690 -0.001883 0.007198 -425 1 0.000227 1560.000000 0.002476 0.000499 0.007516 -426 1 0.000232 1560.000000 0.000442 -0.003485 0.005109 -427 1 0.000286 1560.000000 -0.000986 0.003095 0.005335 -428 1 0.000239 1560.000000 -0.000065 -0.001327 0.007788 -429 1 0.000220 1560.000000 0.000178 0.000594 0.005286 -430 1 0.000258 1560.000000 -0.000369 -0.000308 0.005793 -431 1 0.000251 1560.000000 -0.001146 0.000813 0.006293 -432 1 0.000214 1560.000000 0.000599 -0.002518 0.008558 -433 1 0.000279 1560.000000 -0.002746 0.000723 0.001055 -434 1 0.000205 1560.000000 -0.000407 0.002145 0.007470 -435 1 0.000217 1560.000000 -0.003827 -0.000270 0.007075 -436 1 0.000207 1560.000000 -0.001181 0.000541 0.006485 -437 1 0.000259 1560.000000 0.003206 0.001081 0.006145 -438 1 0.000231 1560.000000 -0.000471 -0.002798 0.004448 -439 1 0.000277 1560.000000 -0.000507 -0.002217 0.006084 -440 1 0.000286 1560.000000 -0.002340 0.001236 0.008814 -441 1 0.000234 1560.000000 -0.001366 -0.003527 0.004339 -442 1 0.000250 1560.000000 -0.000552 -0.003364 0.007217 -443 1 0.000261 1560.000000 -0.001894 -0.002127 0.008078 -444 1 0.000236 1560.000000 -0.001190 -0.002507 0.002067 -445 1 0.000260 1560.000000 -0.003038 -0.000298 0.002887 -446 1 0.000273 1560.000000 0.000233 0.000149 0.007668 -447 1 0.000270 1560.000000 0.000598 0.000321 0.004709 -448 1 0.000211 1560.000000 0.000108 -0.000475 0.000725 -449 1 0.000247 1560.000000 0.002128 -0.002531 0.003239 -450 1 0.000193 1560.000000 -0.000046 0.002651 0.008848 -451 1 0.000225 1560.000000 -0.000053 -0.000949 0.003662 -452 1 0.000192 1560.000000 0.001293 -0.000154 0.005470 -453 1 0.000198 1560.000000 0.002423 -0.001390 0.005397 -454 1 0.000221 1560.000000 0.002190 -0.000255 0.001102 -455 1 0.000267 1560.000000 0.003415 -0.000380 0.003654 -456 1 0.000197 1560.000000 0.000791 0.002259 0.002197 -457 1 0.000235 1560.000000 0.001616 0.000399 0.004485 -458 1 0.000195 1560.000000 -0.001020 -0.000408 0.007876 -459 1 0.000210 1560.000000 0.002911 -0.001916 0.002578 -460 1 0.000201 1560.000000 -0.001544 0.003432 0.006655 -461 1 0.000245 1560.000000 0.001078 -0.001579 0.005050 -462 1 0.000282 1560.000000 -0.001336 0.003298 0.009267 -463 1 0.000219 1560.000000 0.000778 -0.002306 0.005528 -464 1 0.000219 1560.000000 -0.003417 0.001090 0.007688 -465 1 0.000197 1560.000000 0.002916 -0.002087 0.007559 -466 1 0.000232 1560.000000 0.000998 -0.000398 0.000747 -467 1 0.000228 1560.000000 0.002448 0.001411 0.002011 -468 1 0.000215 1560.000000 -0.002281 -0.002630 0.001012 -469 1 0.000241 1560.000000 0.003672 0.000842 0.003602 -470 1 0.000272 1560.000000 -0.002284 0.003050 0.006621 -471 1 0.000198 1560.000000 -0.000638 0.000615 0.002655 -472 1 0.000197 1560.000000 0.000847 -0.001274 0.009781 -473 1 0.000203 1560.000000 -0.000243 -0.001150 0.001106 -474 1 0.000198 1560.000000 0.000333 0.000772 0.005199 -475 1 0.000265 1560.000000 -0.001699 0.002517 0.008300 -476 1 0.000228 1560.000000 -0.000717 -0.001307 0.002947 -477 1 0.000195 1560.000000 0.002922 0.001124 0.002725 -478 1 0.000230 1560.000000 -0.000520 0.003348 0.009183 -479 1 0.000220 1560.000000 -0.001081 0.000275 0.002629 -480 1 0.000242 1560.000000 -0.002729 0.001006 0.008455 -481 1 0.000267 1560.000000 0.000218 0.002160 0.007347 -482 1 0.000238 1560.000000 -0.002355 0.001773 0.001426 -483 1 0.000205 1560.000000 0.001522 -0.000443 0.008238 -484 1 0.000207 1560.000000 0.002363 -0.000125 0.007765 -485 1 0.000206 1560.000000 0.000457 -0.003110 0.005735 -486 1 0.000268 1560.000000 -0.002227 0.001367 0.009315 -487 1 0.000253 1560.000000 -0.003060 0.000864 0.002594 -488 1 0.000230 1560.000000 0.000020 -0.000386 0.003854 -489 1 0.000284 1560.000000 -0.000053 0.000052 0.007770 -490 1 0.000225 1560.000000 0.000203 0.000853 0.001916 -491 1 0.000197 1560.000000 -0.001587 0.001505 0.001622 -492 1 0.000203 1560.000000 -0.000007 0.002403 0.000759 -493 1 0.000251 1560.000000 0.000036 -0.000308 0.008620 -494 1 0.000268 1560.000000 -0.000322 -0.000036 0.007655 -495 1 0.000283 1560.000000 0.001094 -0.001160 0.001391 -496 1 0.000203 1560.000000 0.000959 -0.000317 0.002008 -497 1 0.000258 1560.000000 -0.001355 0.001371 0.009431 -498 1 0.000220 1560.000000 0.003487 0.000816 0.005572 -499 1 0.000197 1560.000000 -0.000587 -0.000260 0.002530 -500 1 0.000204 1560.000000 0.000036 0.000510 0.001762 -501 1 0.000243 1560.000000 -0.000871 0.001604 0.003067 -502 1 0.000285 1560.000000 0.002001 -0.002258 0.002102 -503 1 0.000222 1560.000000 -0.000769 0.000819 0.007312 -504 1 0.000228 1560.000000 -0.001871 0.000426 0.001357 -505 1 0.000255 1560.000000 -0.000193 0.000910 0.003553 -506 1 0.000216 1560.000000 -0.000390 -0.000116 0.008812 -507 1 0.000208 1560.000000 -0.001403 -0.000940 0.000239 -508 1 0.000279 1560.000000 -0.001415 0.000032 0.003888 -509 1 0.000207 1560.000000 -0.002670 -0.000789 0.006988 -510 1 0.000243 1560.000000 -0.001197 0.002935 0.009408 -511 1 0.000215 1560.000000 0.002635 -0.001967 0.006242 -512 1 0.000224 1560.000000 -0.001727 -0.001120 0.002565 -513 1 0.000268 1560.000000 -0.002071 0.000418 0.002328 -514 1 0.000218 1560.000000 0.001071 -0.000383 0.002231 -515 1 0.000255 1560.000000 0.000334 -0.000777 0.007209 -516 1 0.000253 1560.000000 -0.001771 0.000027 0.007420 -517 1 0.000231 1560.000000 0.000135 -0.001019 0.000517 -518 1 0.000194 1560.000000 -0.003477 -0.000577 0.005987 -519 1 0.000286 1560.000000 -0.002530 -0.002238 0.004379 -520 1 0.000203 1560.000000 0.000738 -0.002383 0.005250 -521 1 0.000201 1560.000000 -0.000602 -0.003280 0.009673 -522 1 0.000277 1560.000000 -0.000632 -0.002190 0.004083 -523 1 0.000211 1560.000000 0.001797 -0.001035 0.007962 -524 1 0.000195 1560.000000 0.000766 0.003139 0.003704 -525 1 0.000207 1560.000000 0.000254 -0.000933 0.003260 -526 1 0.000214 1560.000000 0.000503 -0.002258 0.004703 -527 1 0.000214 1560.000000 0.000725 0.002098 0.007952 -528 1 0.000284 1560.000000 -0.000258 0.000624 0.007088 -529 1 0.000201 1560.000000 -0.000904 0.001589 0.005410 -530 1 0.000269 1560.000000 -0.000219 0.000875 0.006674 -531 1 0.000205 1560.000000 -0.001164 0.002566 0.008706 -532 1 0.000221 1560.000000 -0.003259 -0.000518 0.003346 -533 1 0.000283 1560.000000 -0.000105 0.000548 0.008101 -534 1 0.000256 1560.000000 -0.000435 -0.002772 0.006320 -535 1 0.000241 1560.000000 -0.001932 -0.002755 0.005232 -536 1 0.000198 1560.000000 -0.000550 -0.002873 0.000460 -537 1 0.000219 1560.000000 0.002044 -0.000536 0.000948 -538 1 0.000224 1560.000000 -0.003671 0.000620 0.006588 -539 1 0.000232 1560.000000 -0.000186 -0.002753 0.006712 -540 1 0.000282 1560.000000 0.002381 0.002467 0.003162 -541 1 0.000253 1560.000000 -0.002733 0.001346 0.000718 -542 1 0.000256 1560.000000 -0.001657 -0.001186 0.005595 -543 1 0.000245 1560.000000 0.002653 -0.000712 0.002329 -544 1 0.000274 1560.000000 -0.000578 -0.002285 0.004578 -545 1 0.000198 1560.000000 0.000167 0.000493 0.003533 -546 1 0.000211 1560.000000 0.000312 -0.000437 0.000317 -547 1 0.000212 1560.000000 0.000702 -0.002542 0.007634 -548 1 0.000193 1560.000000 0.000521 -0.000459 0.002500 -549 1 0.000264 1560.000000 -0.001813 0.000014 0.008047 -550 1 0.000206 1560.000000 -0.002396 0.000840 0.008450 -551 1 0.000196 1560.000000 -0.000496 -0.000188 0.001030 -552 1 0.000227 1560.000000 -0.000169 0.000351 0.002840 -553 1 0.000275 1560.000000 0.000096 -0.000973 0.005510 -554 1 0.000247 1560.000000 -0.001280 -0.000271 0.001142 -555 1 0.000193 1560.000000 0.002387 0.001234 0.007644 -556 1 0.000201 1560.000000 -0.001148 0.002096 0.009789 -557 1 0.000216 1560.000000 -0.000051 0.002353 0.000487 -558 1 0.000215 1560.000000 0.000134 -0.000060 0.003903 -559 1 0.000282 1560.000000 -0.000352 0.000450 0.007474 -560 1 0.000221 1560.000000 -0.000675 0.001413 0.009691 -561 1 0.000202 1560.000000 0.000206 -0.000357 0.002063 -562 1 0.000239 1560.000000 -0.000161 0.001401 0.002095 -563 1 0.000205 1560.000000 -0.000585 -0.003458 0.000195 -564 1 0.000248 1560.000000 -0.002794 0.000023 0.004810 -565 1 0.000197 1560.000000 -0.000275 -0.003157 0.002962 -566 1 0.000281 1560.000000 0.000109 0.000064 0.006792 -567 1 0.000198 1560.000000 0.000180 -0.000588 0.007566 -568 1 0.000237 1560.000000 -0.002915 0.000227 0.001155 -569 1 0.000227 1560.000000 0.000147 0.003523 0.000600 -570 1 0.000210 1560.000000 0.001909 -0.001803 0.007688 -571 1 0.000206 1560.000000 -0.001548 0.001526 0.006671 -572 1 0.000273 1560.000000 -0.001165 -0.001207 0.000192 -573 1 0.000198 1560.000000 -0.002971 -0.000439 0.003545 -574 1 0.000264 1560.000000 0.000470 -0.000178 0.003228 -575 1 0.000287 1560.000000 0.000168 -0.003069 0.007179 -576 1 0.000208 1560.000000 -0.000864 0.000521 0.007697 -577 1 0.000265 1560.000000 -0.001440 -0.000205 0.001540 -578 1 0.000266 1560.000000 -0.000219 -0.001004 0.000246 -579 1 0.000220 1560.000000 -0.000733 0.000371 0.000315 -580 1 0.000207 1560.000000 0.002571 0.000471 0.001094 -581 1 0.000264 1560.000000 -0.000107 -0.003601 0.008960 -582 1 0.000201 1560.000000 -0.002119 -0.000246 0.000581 -583 1 0.000258 1560.000000 -0.002077 0.001380 0.006097 -584 1 0.000271 1560.000000 0.000892 -0.002219 0.003464 -585 1 0.000235 1560.000000 -0.001338 -0.001006 0.001329 -586 1 0.000199 1560.000000 -0.001050 -0.000851 0.003369 -587 1 0.000250 1560.000000 0.000768 0.001005 0.009699 -588 1 0.000239 1560.000000 0.003101 0.000957 0.004454 -589 1 0.000272 1560.000000 0.000783 -0.000873 0.008727 -590 1 0.000263 1560.000000 -0.000957 -0.001132 0.006036 -591 1 0.000192 1560.000000 -0.002770 -0.001986 0.007187 -592 1 0.000209 1560.000000 0.000697 -0.003085 0.000969 -593 1 0.000204 1560.000000 -0.000179 -0.001994 0.009715 -594 1 0.000209 1560.000000 -0.000270 0.000500 0.009759 -595 1 0.000224 1560.000000 -0.001725 0.000026 0.002541 -596 1 0.000236 1560.000000 -0.000132 -0.003374 0.000716 -597 1 0.000264 1560.000000 -0.000371 0.001340 0.001716 -598 1 0.000209 1560.000000 -0.000873 -0.000942 0.008531 -599 1 0.000210 1560.000000 -0.000863 0.003259 0.003599 -600 1 0.000208 1560.000000 -0.001374 0.001831 0.005957 -601 1 0.000263 1560.000000 -0.000931 -0.000757 0.007361 -602 1 0.000270 1560.000000 -0.000831 0.000056 0.004072 -603 1 0.000205 1560.000000 0.000105 -0.001096 0.007460 -604 1 0.000225 1560.000000 -0.001486 0.002041 0.008821 -605 1 0.000215 1560.000000 0.000434 0.001313 0.004690 -606 1 0.000208 1560.000000 -0.001718 -0.002624 0.005172 -607 1 0.000259 1560.000000 -0.000735 -0.002587 0.009151 -608 1 0.000251 1560.000000 -0.001327 -0.001985 0.007851 -609 1 0.000206 1560.000000 -0.000825 -0.003202 0.001758 -610 1 0.000256 1560.000000 0.001927 0.001270 0.003696 -611 1 0.000227 1560.000000 0.000069 0.000336 0.003976 -612 1 0.000199 1560.000000 -0.000702 -0.000458 0.000428 -613 1 0.000258 1560.000000 -0.002284 -0.002008 0.004068 -614 1 0.000199 1560.000000 0.000328 0.003677 0.004646 -615 1 0.000250 1560.000000 -0.000306 0.000251 0.001954 -616 1 0.000246 1560.000000 -0.003051 -0.001942 0.007282 -617 1 0.000225 1560.000000 -0.001224 0.000343 0.004963 -618 1 0.000215 1560.000000 0.000375 0.000466 0.004538 -619 1 0.000246 1560.000000 0.002111 0.001390 0.005007 -620 1 0.000226 1560.000000 0.000611 -0.002188 0.007634 -621 1 0.000227 1560.000000 -0.002479 0.002280 0.003265 -622 1 0.000219 1560.000000 -0.001896 -0.000470 0.003141 -623 1 0.000240 1560.000000 0.000463 -0.001886 0.006836 -624 1 0.000207 1560.000000 0.000531 -0.001652 0.005953 -625 1 0.000221 1560.000000 0.000988 0.001057 0.007306 -626 1 0.000260 1560.000000 -0.001672 0.000619 0.002344 -627 1 0.000242 1560.000000 -0.000786 -0.001093 0.009789 -628 1 0.000250 1560.000000 0.002521 0.001581 0.006386 -629 1 0.000240 1560.000000 -0.000689 -0.000662 0.004647 -630 1 0.000201 1560.000000 -0.002893 -0.000085 0.007319 -631 1 0.000205 1560.000000 0.001755 -0.000446 0.009781 -632 1 0.000281 1560.000000 0.002548 0.000139 0.007135 -633 1 0.000197 1560.000000 -0.000830 -0.002859 0.002522 -634 1 0.000220 1560.000000 -0.000094 -0.000872 0.003897 -635 1 0.000215 1560.000000 0.003416 -0.000532 0.005897 -636 1 0.000206 1560.000000 -0.000469 0.001233 0.004674 -637 1 0.000222 1560.000000 -0.002301 -0.001285 0.003489 -638 1 0.000217 1560.000000 0.000327 -0.001328 0.002057 -639 1 0.000194 1560.000000 0.001744 0.002072 0.002528 -640 1 0.000200 1560.000000 -0.001362 0.002182 0.006835 -641 1 0.000235 1560.000000 -0.002408 -0.002984 0.009790 -642 1 0.000283 1560.000000 0.002500 -0.000221 0.006567 -643 1 0.000210 1560.000000 -0.000289 -0.000235 0.009736 -644 1 0.000197 1560.000000 -0.002200 -0.000330 0.008557 -645 1 0.000202 1560.000000 -0.000673 -0.002328 0.007352 -646 1 0.000265 1560.000000 0.000065 0.001722 0.008112 -647 1 0.000230 1560.000000 -0.002580 -0.000350 0.000195 -648 1 0.000194 1560.000000 -0.001391 0.000609 0.008967 -649 1 0.000196 1560.000000 -0.002121 0.000581 0.004207 -650 1 0.000196 1560.000000 0.000552 0.000584 0.007679 -651 1 0.000258 1560.000000 -0.003472 -0.001266 0.002972 -652 1 0.000202 1560.000000 -0.000868 0.000730 0.006134 -653 1 0.000283 1560.000000 0.003115 0.000321 0.000603 -654 1 0.000198 1560.000000 -0.000636 0.003238 0.001715 -655 1 0.000263 1560.000000 0.000086 -0.000958 0.001520 -656 1 0.000280 1560.000000 -0.000308 0.003013 0.005769 -657 1 0.000214 1560.000000 0.001641 -0.003142 0.001815 -658 1 0.000210 1560.000000 0.000154 -0.000348 0.006890 -659 1 0.000242 1560.000000 0.000388 -0.000748 0.000962 -660 1 0.000227 1560.000000 -0.001354 0.001351 0.000185 -661 1 0.000225 1560.000000 0.002433 0.002601 0.004239 -662 1 0.000194 1560.000000 -0.002517 -0.000311 0.001810 -663 1 0.000201 1560.000000 0.000009 0.003505 0.000284 -664 1 0.000243 1560.000000 -0.000460 0.000555 0.008105 -665 1 0.000268 1560.000000 -0.000929 -0.001481 0.006431 -666 1 0.000234 1560.000000 0.001164 0.002522 0.000691 -667 1 0.000216 1560.000000 -0.001103 -0.000472 0.000866 -668 1 0.000254 1560.000000 0.001087 0.003665 0.002945 -669 1 0.000263 1560.000000 0.001090 -0.001690 0.000957 -670 1 0.000195 1560.000000 0.001730 0.002855 0.009208 -671 1 0.000238 1560.000000 -0.002235 0.001544 0.007208 -672 1 0.000278 1560.000000 0.001996 0.001974 0.000660 -673 1 0.000262 1560.000000 -0.002386 -0.001362 0.000478 -674 1 0.000270 1560.000000 -0.001749 0.001499 0.005933 -675 1 0.000284 1560.000000 -0.000231 0.000272 0.006382 -676 1 0.000218 1560.000000 -0.002393 0.001414 0.003581 -677 1 0.000238 1560.000000 -0.002482 -0.000018 0.003468 -678 1 0.000219 1560.000000 0.000250 0.000150 0.003460 -679 1 0.000239 1560.000000 0.001151 0.000585 0.001804 -680 1 0.000202 1560.000000 0.000298 -0.000306 0.005216 -681 1 0.000224 1560.000000 0.001952 0.001197 0.004575 -682 1 0.000256 1560.000000 0.000662 -0.002498 0.000665 -683 1 0.000220 1560.000000 0.000226 0.000499 0.006561 -684 1 0.000206 1560.000000 -0.000079 0.000583 0.008655 -685 1 0.000224 1560.000000 0.000710 0.001742 0.008068 -686 1 0.000213 1560.000000 -0.000683 -0.000008 0.002645 -687 1 0.000238 1560.000000 0.001911 0.001038 0.009648 -688 1 0.000219 1560.000000 -0.000840 0.002494 0.007471 -689 1 0.000282 1560.000000 -0.001572 0.001083 0.002746 -690 1 0.000251 1560.000000 -0.002601 -0.000531 0.009640 -691 1 0.000218 1560.000000 0.001143 0.001942 0.004699 -692 1 0.000234 1560.000000 -0.002868 -0.000506 0.004553 -693 1 0.000192 1560.000000 0.000744 -0.000393 0.003464 -694 1 0.000254 1560.000000 0.000210 -0.003515 0.007021 -695 1 0.000248 1560.000000 -0.002743 -0.000713 0.006539 -696 1 0.000281 1560.000000 0.000754 0.001441 0.007882 -697 1 0.000230 1560.000000 0.002332 -0.000153 0.007549 -698 1 0.000285 1560.000000 -0.000436 -0.003654 0.003119 -699 1 0.000285 1560.000000 0.000126 -0.000802 0.006993 -700 1 0.000243 1560.000000 0.003563 0.001262 0.003975 -701 1 0.000195 1560.000000 0.000424 0.002975 0.003234 -702 1 0.000230 1560.000000 -0.001056 0.000051 0.001439 -703 1 0.000222 1560.000000 -0.000460 0.000985 0.003068 -704 1 0.000232 1560.000000 0.000114 0.000156 0.001523 -705 1 0.000205 1560.000000 -0.000812 -0.000171 0.004522 -706 1 0.000235 1560.000000 -0.001627 -0.002552 0.007718 -707 1 0.000237 1560.000000 0.001112 0.002470 0.008791 -708 1 0.000209 1560.000000 0.000437 -0.000966 0.008758 -709 1 0.000217 1560.000000 0.000695 -0.000044 0.002186 -710 1 0.000233 1560.000000 -0.000253 0.000060 0.008427 -711 1 0.000247 1560.000000 0.001164 0.002536 0.004395 -712 1 0.000244 1560.000000 0.001133 0.000574 0.009464 -713 1 0.000278 1560.000000 -0.000714 -0.001103 0.004980 -714 1 0.000207 1560.000000 0.001981 0.001843 0.006404 -715 1 0.000226 1560.000000 -0.001604 -0.000284 0.002437 -716 1 0.000283 1560.000000 -0.002368 -0.001397 0.005157 -717 1 0.000205 1560.000000 0.003176 0.000235 0.003811 -718 1 0.000226 1560.000000 -0.002505 0.000273 0.000362 -719 1 0.000237 1560.000000 0.003680 -0.000330 0.005410 -720 1 0.000250 1560.000000 -0.000262 0.000661 0.003972 -721 1 0.000213 1560.000000 0.002749 0.002291 0.003394 -722 1 0.000282 1560.000000 0.000740 0.000056 0.004866 -723 1 0.000211 1560.000000 -0.000834 -0.000971 0.009329 -724 1 0.000259 1560.000000 0.000399 -0.000188 0.001564 -725 1 0.000201 1560.000000 -0.000194 -0.000126 0.007312 -726 1 0.000284 1560.000000 -0.000374 0.001916 0.003962 -727 1 0.000195 1560.000000 -0.001476 -0.000238 0.000418 -728 1 0.000243 1560.000000 -0.002035 0.000058 0.008433 -729 1 0.000238 1560.000000 0.001227 0.002012 0.003671 -730 1 0.000219 1560.000000 -0.002459 0.002435 0.007110 -731 1 0.000215 1560.000000 0.001111 0.001537 0.006736 -732 1 0.000236 1560.000000 -0.000780 0.001814 0.005305 -733 1 0.000225 1560.000000 0.003183 0.001333 0.007695 -734 1 0.000200 1560.000000 -0.000791 -0.001050 0.005544 -735 1 0.000252 1560.000000 0.000522 -0.000587 0.002800 -736 1 0.000234 1560.000000 -0.001016 0.001087 0.009196 -737 1 0.000274 1560.000000 0.000479 0.001525 0.001012 -738 1 0.000242 1560.000000 -0.000877 -0.001060 0.004714 -739 1 0.000259 1560.000000 0.002762 0.001770 0.003939 -740 1 0.000255 1560.000000 -0.000184 -0.000937 0.004276 -741 1 0.000213 1560.000000 -0.000194 -0.001183 0.009467 -742 1 0.000223 1560.000000 -0.000512 -0.002282 0.007175 -743 1 0.000201 1560.000000 0.002072 -0.000882 0.007495 -744 1 0.000260 1560.000000 0.001324 -0.001993 0.003263 -745 1 0.000226 1560.000000 -0.000979 -0.000291 0.000604 -746 1 0.000215 1560.000000 -0.002899 0.000610 0.002808 -747 1 0.000249 1560.000000 0.000288 0.000805 0.006985 -748 1 0.000196 1560.000000 0.000323 -0.002344 0.002669 -749 1 0.000206 1560.000000 0.002182 -0.001727 0.007532 -750 1 0.000224 1560.000000 -0.000477 0.000490 0.009690 -751 1 0.000245 1560.000000 -0.003370 0.001435 0.005613 -752 1 0.000229 1560.000000 0.000726 0.003783 0.004338 -753 1 0.000243 1560.000000 -0.000066 0.000132 0.001218 -754 1 0.000272 1560.000000 -0.001824 0.000757 0.001318 -755 1 0.000278 1560.000000 -0.000432 0.001457 0.002996 -756 1 0.000246 1560.000000 -0.002811 -0.001654 0.005219 -757 1 0.000195 1560.000000 0.002740 0.002609 0.007441 -758 1 0.000219 1560.000000 0.003512 0.000907 0.001781 -759 1 0.000278 1560.000000 0.002842 -0.002583 0.008331 -760 1 0.000218 1560.000000 0.003128 -0.001124 0.008940 -761 1 0.000218 1560.000000 -0.000419 0.000294 0.009097 -762 1 0.000202 1560.000000 -0.001361 -0.001514 0.000666 -763 1 0.000249 1560.000000 -0.002295 0.000726 0.009747 -764 1 0.000245 1560.000000 0.001423 0.000753 0.002932 -765 1 0.000226 1560.000000 0.003468 0.001153 0.003208 -766 1 0.000200 1560.000000 -0.001401 -0.001117 0.000378 -767 1 0.000253 1560.000000 -0.000085 -0.001242 0.002302 -768 1 0.000227 1560.000000 -0.000123 0.000086 0.002045 -769 1 0.000197 1560.000000 0.000066 0.000792 0.007549 -770 1 0.000219 1560.000000 -0.003181 0.000353 0.004580 -771 1 0.000237 1560.000000 0.000584 -0.001715 0.002799 -772 1 0.000221 1560.000000 0.000213 -0.000186 0.003521 -773 1 0.000226 1560.000000 -0.000845 -0.000584 0.002504 -774 1 0.000209 1560.000000 -0.000267 -0.000158 0.003347 -775 1 0.000241 1560.000000 0.003113 0.001916 0.001779 -776 1 0.000248 1560.000000 0.000738 -0.000668 0.001705 -777 1 0.000218 1560.000000 -0.001770 -0.000633 0.008259 -778 1 0.000232 1560.000000 -0.000144 0.000233 0.009204 -779 1 0.000216 1560.000000 -0.000270 0.001157 0.006688 -780 1 0.000208 1560.000000 -0.000099 0.000519 0.003336 -781 1 0.000230 1560.000000 0.001578 -0.002757 0.004219 -782 1 0.000227 1560.000000 0.000146 -0.001952 0.003493 -783 1 0.000229 1560.000000 0.001906 0.003190 0.006981 -784 1 0.000206 1560.000000 0.000960 -0.000606 0.002354 -785 1 0.000209 1560.000000 0.001031 0.002786 0.002782 -786 1 0.000270 1560.000000 -0.001604 0.000170 0.001736 -787 1 0.000249 1560.000000 -0.002043 -0.002788 0.008219 -788 1 0.000203 1560.000000 0.000280 -0.002336 0.005463 -789 1 0.000271 1560.000000 0.000123 0.000529 0.001461 -790 1 0.000259 1560.000000 -0.000504 -0.000930 0.004220 -791 1 0.000195 1560.000000 0.002713 0.000639 0.007759 -792 1 0.000268 1560.000000 0.001938 -0.000281 0.005118 -793 1 0.000197 1560.000000 -0.002691 0.001245 0.006874 -794 1 0.000235 1560.000000 -0.002950 0.002388 0.009049 -795 1 0.000194 1560.000000 -0.000999 -0.000766 0.001153 -796 1 0.000197 1560.000000 0.000215 0.000980 0.000290 -797 1 0.000205 1560.000000 -0.001302 -0.003458 0.003723 -798 1 0.000193 1560.000000 -0.000329 0.000416 0.003035 -799 1 0.000201 1560.000000 0.000011 -0.000016 0.001398 -800 1 0.000203 1560.000000 0.001520 0.000877 0.001105 -801 1 0.000276 1560.000000 -0.000844 0.000109 0.006845 -802 1 0.000279 1560.000000 -0.003024 0.001733 0.007558 -803 1 0.000214 1560.000000 -0.000449 -0.001811 0.003272 -804 1 0.000278 1560.000000 -0.002489 -0.000640 0.005549 -805 1 0.000241 1560.000000 -0.002903 -0.002448 0.008743 -806 1 0.000202 1560.000000 -0.003031 -0.002124 0.003900 -807 1 0.000243 1560.000000 0.000737 0.003082 0.006416 -808 1 0.000225 1560.000000 0.000185 0.003317 0.005389 -809 1 0.000261 1560.000000 -0.001367 -0.002170 0.009162 -810 1 0.000277 1560.000000 0.003288 -0.000734 0.000709 -811 1 0.000193 1560.000000 0.001329 -0.001244 0.003495 -812 1 0.000198 1560.000000 0.000472 0.000615 0.001465 -813 1 0.000244 1560.000000 0.003260 0.001507 0.002850 -814 1 0.000196 1560.000000 0.001942 -0.001881 0.000542 -815 1 0.000209 1560.000000 0.001691 0.003204 0.003740 -816 1 0.000245 1560.000000 -0.003106 0.000743 0.007132 -817 1 0.000226 1560.000000 0.001675 -0.000870 0.005146 -818 1 0.000193 1560.000000 -0.001249 -0.001747 0.001899 -819 1 0.000248 1560.000000 0.001835 0.001348 0.008878 -820 1 0.000209 1560.000000 0.002592 -0.002628 0.001133 -821 1 0.000259 1560.000000 0.000410 -0.002038 0.003111 -822 1 0.000253 1560.000000 0.003341 -0.000951 0.006051 -823 1 0.000201 1560.000000 -0.001301 -0.003393 0.000208 -824 1 0.000193 1560.000000 -0.001105 -0.002341 0.001622 -825 1 0.000256 1560.000000 0.002585 -0.000915 0.000209 -826 1 0.000271 1560.000000 -0.000896 0.002207 0.005010 -827 1 0.000220 1560.000000 0.000594 0.000506 0.006798 -828 1 0.000246 1560.000000 0.000467 0.001135 0.000207 -829 1 0.000283 1560.000000 -0.000475 -0.002443 0.002076 -830 1 0.000214 1560.000000 -0.002200 -0.000053 0.005351 -831 1 0.000281 1560.000000 0.000507 -0.000525 0.004153 -832 1 0.000193 1560.000000 -0.000502 0.001227 0.005968 -833 1 0.000211 1560.000000 -0.001820 -0.000847 0.004216 -834 1 0.000214 1560.000000 0.000964 -0.002224 0.001566 -835 1 0.000217 1560.000000 0.001145 -0.002043 0.008723 -836 1 0.000200 1560.000000 -0.000662 -0.002150 0.003352 -837 1 0.000202 1560.000000 0.000400 -0.003566 0.001123 -838 1 0.000221 1560.000000 -0.000009 0.000417 0.007195 -839 1 0.000220 1560.000000 -0.000249 0.000283 0.006078 -840 1 0.000224 1560.000000 -0.002904 0.001148 0.000561 -841 1 0.000263 1560.000000 0.002116 0.001309 0.008069 -842 1 0.000271 1560.000000 -0.000414 -0.000243 0.007056 -843 1 0.000211 1560.000000 0.003230 -0.002097 0.007065 -844 1 0.000269 1560.000000 0.001496 -0.001554 0.001920 -845 1 0.000246 1560.000000 0.000506 0.002853 0.002500 -846 1 0.000208 1560.000000 -0.000378 -0.003500 0.008422 -847 1 0.000195 1560.000000 0.002092 0.002254 0.007027 -848 1 0.000225 1560.000000 0.000162 0.000036 0.003074 -849 1 0.000198 1560.000000 -0.000539 0.001753 0.005479 -850 1 0.000199 1560.000000 -0.003602 0.000489 0.007819 -851 1 0.000240 1560.000000 -0.000108 0.000831 0.008302 -852 1 0.000202 1560.000000 -0.000571 -0.000305 0.004990 -853 1 0.000268 1560.000000 -0.003349 -0.000548 0.004174 -854 1 0.000203 1560.000000 0.000089 -0.000196 0.004168 -855 1 0.000254 1560.000000 -0.002275 -0.002650 0.007825 -856 1 0.000197 1560.000000 0.000388 0.001222 0.008897 -857 1 0.000199 1560.000000 -0.001810 -0.001544 0.002795 -858 1 0.000209 1560.000000 -0.001789 0.002884 0.003844 -859 1 0.000225 1560.000000 -0.001651 0.000816 0.002917 -860 1 0.000225 1560.000000 0.000361 -0.000432 0.009677 -861 1 0.000250 1560.000000 -0.002249 -0.001108 0.004808 -862 1 0.000206 1560.000000 0.001515 0.001133 0.000763 -863 1 0.000284 1560.000000 0.001004 -0.000050 0.000252 -864 1 0.000251 1560.000000 -0.000765 -0.003550 0.003456 -865 1 0.000254 1560.000000 0.000163 -0.000350 0.001334 -866 1 0.000210 1560.000000 -0.000760 0.001335 0.000643 -867 1 0.000251 1560.000000 -0.003639 -0.001069 0.005518 -868 1 0.000273 1560.000000 -0.001340 -0.002590 0.009659 -869 1 0.000232 1560.000000 0.002297 -0.001925 0.004653 -870 1 0.000229 1560.000000 0.002712 -0.000828 0.008441 -871 1 0.000241 1560.000000 0.000501 0.000148 0.000686 -872 1 0.000196 1560.000000 0.001763 0.000719 0.003322 -873 1 0.000250 1560.000000 0.000260 0.003340 0.002186 -874 1 0.000233 1560.000000 -0.002910 0.000176 0.000687 -875 1 0.000194 1560.000000 -0.001767 0.000009 0.003978 -876 1 0.000198 1560.000000 0.000562 0.000706 0.002235 -877 1 0.000223 1560.000000 0.002897 -0.000634 0.006065 -878 1 0.000203 1560.000000 0.002569 -0.001354 0.007303 -879 1 0.000209 1560.000000 0.000147 0.000897 0.007168 -880 1 0.000249 1560.000000 0.000614 0.001874 0.005592 -881 1 0.000262 1560.000000 0.001403 0.000727 0.006648 -882 1 0.000242 1560.000000 -0.000638 -0.001813 0.002148 -883 1 0.000275 1560.000000 -0.001939 0.000250 0.007233 -884 1 0.000262 1560.000000 0.002962 -0.000173 0.005043 -885 1 0.000195 1560.000000 -0.002117 -0.000060 0.006631 -886 1 0.000194 1560.000000 0.001087 -0.000359 0.005108 -887 1 0.000237 1560.000000 -0.001856 0.000651 0.002997 -888 1 0.000233 1560.000000 0.000548 0.003741 0.007746 -889 1 0.000203 1560.000000 0.000368 -0.001686 0.000963 -890 1 0.000203 1560.000000 0.002319 -0.001140 0.006250 -891 1 0.000200 1560.000000 0.000834 -0.001600 0.003964 -892 1 0.000197 1560.000000 -0.001175 -0.001127 0.007038 -893 1 0.000201 1560.000000 0.002549 0.001726 0.008410 -894 1 0.000196 1560.000000 0.003411 0.000097 0.007456 -895 1 0.000196 1560.000000 -0.001787 -0.001986 0.007398 -896 1 0.000203 1560.000000 0.001942 0.000366 0.002207 -897 1 0.000288 1560.000000 0.001674 -0.001760 0.000228 -898 1 0.000196 1560.000000 0.001076 -0.000826 0.000682 -899 1 0.000222 1560.000000 -0.000424 0.000144 0.003584 -900 1 0.000244 1560.000000 0.001004 0.001795 0.006322 -901 1 0.000228 1560.000000 0.000201 0.001114 0.001384 -902 1 0.000210 1560.000000 0.001587 -0.000193 0.007821 -903 1 0.000237 1560.000000 0.002069 0.001485 0.008671 -904 1 0.000212 1560.000000 0.001909 0.000068 0.008235 -905 1 0.000240 1560.000000 -0.001664 -0.000731 0.005628 -906 1 0.000220 1560.000000 0.000367 -0.002068 0.002861 -907 1 0.000211 1560.000000 -0.001103 -0.001481 0.009687 -908 1 0.000201 1560.000000 0.000109 -0.000847 0.000839 -909 1 0.000243 1560.000000 -0.001521 -0.001399 0.001314 -910 1 0.000199 1560.000000 0.000450 -0.000260 0.006610 -911 1 0.000201 1560.000000 0.003056 -0.000466 0.004350 -912 1 0.000205 1560.000000 -0.000921 0.001102 0.004616 -913 1 0.000231 1560.000000 0.000829 0.000383 0.004556 -914 1 0.000226 1560.000000 -0.000507 0.000166 0.002727 -915 1 0.000214 1560.000000 0.001543 0.000945 0.008143 -916 1 0.000218 1560.000000 0.000065 -0.000181 0.000556 -917 1 0.000238 1560.000000 0.000049 -0.002568 0.007307 -918 1 0.000233 1560.000000 0.002040 -0.002563 0.006423 -919 1 0.000285 1560.000000 0.001090 -0.000721 0.003103 -920 1 0.000204 1560.000000 -0.000050 0.000204 0.007023 -921 1 0.000237 1560.000000 0.002236 0.000777 0.001394 -922 1 0.000218 1560.000000 -0.002932 -0.001816 0.006523 -923 1 0.000211 1560.000000 0.001212 -0.000049 0.008172 -924 1 0.000237 1560.000000 0.000272 0.001638 0.001839 -925 1 0.000287 1560.000000 -0.003293 0.000257 0.008478 -926 1 0.000204 1560.000000 0.000725 0.000289 0.001651 -927 1 0.000253 1560.000000 0.001989 -0.001772 0.006042 -928 1 0.000248 1560.000000 0.002770 -0.000648 0.002738 -929 1 0.000238 1560.000000 0.002939 -0.002438 0.005345 -930 1 0.000194 1560.000000 0.000301 0.000082 0.008843 -931 1 0.000208 1560.000000 -0.000461 0.002345 0.001006 -932 1 0.000249 1560.000000 0.000787 0.001273 0.003275 -933 1 0.000194 1560.000000 -0.000979 -0.001486 0.003379 -934 1 0.000286 1560.000000 -0.001242 -0.001195 0.005883 -935 1 0.000198 1560.000000 0.000189 -0.001364 0.008563 -936 1 0.000211 1560.000000 -0.001865 -0.002020 0.001695 -937 1 0.000218 1560.000000 -0.003423 0.000433 0.007104 -938 1 0.000217 1560.000000 -0.001505 0.002885 0.002379 -939 1 0.000214 1560.000000 0.000349 0.000655 0.006341 -940 1 0.000261 1560.000000 0.001692 -0.003076 0.006084 -941 1 0.000266 1560.000000 0.001303 0.000721 0.009000 -942 1 0.000273 1560.000000 0.001875 0.002083 0.002277 -943 1 0.000285 1560.000000 0.001421 0.002843 0.001960 -944 1 0.000224 1560.000000 -0.000139 0.001773 0.009674 -945 1 0.000198 1560.000000 -0.001905 -0.003078 0.000132 -946 1 0.000279 1560.000000 0.002017 0.000609 0.001647 -947 1 0.000263 1560.000000 -0.000590 -0.001603 0.008645 -948 1 0.000207 1560.000000 0.000343 -0.000072 0.000163 -949 1 0.000279 1560.000000 -0.003243 -0.000975 0.004238 -950 1 0.000268 1560.000000 -0.000275 -0.000912 0.001243 -951 1 0.000213 1560.000000 -0.000081 -0.000076 0.003453 -952 1 0.000197 1560.000000 0.000779 -0.000195 0.003700 -953 1 0.000222 1560.000000 0.002846 0.001423 0.001606 -954 1 0.000209 1560.000000 0.000361 0.000908 0.006601 -955 1 0.000238 1560.000000 -0.001037 -0.003615 0.009501 -956 1 0.000230 1560.000000 0.000066 0.002609 0.003702 -957 1 0.000271 1560.000000 -0.003452 -0.000708 0.004889 -958 1 0.000283 1560.000000 -0.001279 -0.000462 0.007513 -959 1 0.000221 1560.000000 -0.000081 0.000133 0.007316 -960 1 0.000267 1560.000000 -0.000802 0.003059 0.006708 -961 1 0.000197 1560.000000 -0.001635 -0.001334 0.007525 -962 1 0.000195 1560.000000 0.002657 0.000935 0.007894 -963 1 0.000224 1560.000000 -0.000934 -0.001683 0.002009 -964 1 0.000206 1560.000000 0.001203 -0.003137 0.004865 -965 1 0.000288 1560.000000 -0.000483 0.000711 0.009396 -966 1 0.000217 1560.000000 -0.001818 0.000156 0.000866 -967 1 0.000259 1560.000000 -0.002030 0.002364 0.008705 -968 1 0.000271 1560.000000 0.000768 0.002015 0.000432 -969 1 0.000235 1560.000000 0.000584 0.001037 0.007780 -970 1 0.000253 1560.000000 -0.001718 -0.001058 0.005915 -971 1 0.000193 1560.000000 -0.000396 0.002132 0.003778 -972 1 0.000273 1560.000000 0.000034 -0.001146 0.004560 -973 1 0.000209 1560.000000 0.003352 0.000094 0.003839 -974 1 0.000270 1560.000000 -0.000352 -0.002637 0.001125 -975 1 0.000200 1560.000000 -0.000186 -0.000517 0.004247 -976 1 0.000204 1560.000000 -0.000206 0.000817 0.003068 -977 1 0.000252 1560.000000 -0.001095 -0.001788 0.003754 -978 1 0.000267 1560.000000 0.003590 0.000419 0.007908 -979 1 0.000217 1560.000000 -0.000340 0.002399 0.001588 -980 1 0.000233 1560.000000 0.000192 0.000628 0.003353 -981 1 0.000236 1560.000000 -0.002637 -0.001475 0.004329 -982 1 0.000265 1560.000000 -0.000286 -0.003206 0.007662 -983 1 0.000205 1560.000000 0.001047 0.000052 0.006903 -984 1 0.000210 1560.000000 0.000462 0.000701 0.006027 -985 1 0.000202 1560.000000 0.002313 -0.001927 0.003654 -986 1 0.000201 1560.000000 -0.003216 -0.000856 0.007122 -987 1 0.000239 1560.000000 -0.002657 0.001316 0.004451 -988 1 0.000251 1560.000000 0.003211 -0.000413 0.003047 -989 1 0.000235 1560.000000 -0.001632 -0.001906 0.004734 -990 1 0.000221 1560.000000 -0.002529 0.000027 0.006478 -991 1 0.000249 1560.000000 -0.001311 -0.000704 0.009624 -992 1 0.000271 1560.000000 0.002007 0.000086 0.009625 -993 1 0.000209 1560.000000 -0.000263 -0.002496 0.008369 -994 1 0.000196 1560.000000 -0.001014 -0.003118 0.001692 -995 1 0.000212 1560.000000 0.000974 0.002437 0.007894 -996 1 0.000259 1560.000000 0.000962 0.000917 0.005275 -997 1 0.000240 1560.000000 0.002940 -0.000447 0.002052 -998 1 0.000231 1560.000000 0.001332 0.002667 0.006377 -999 1 0.000208 1560.000000 0.000815 -0.002135 0.003730 -1000 1 0.000279 1560.000000 0.000125 -0.003837 0.004754 -1001 1 0.000235 1560.000000 -0.000054 0.001877 0.002816 -1002 1 0.000260 1560.000000 0.000632 0.002912 0.008436 -1003 1 0.000205 1560.000000 0.001948 0.000792 0.008315 -1004 1 0.000241 1560.000000 0.002996 0.000132 0.008586 -1005 1 0.000201 1560.000000 -0.001375 0.000940 0.006571 -1006 1 0.000257 1560.000000 -0.001862 -0.001786 0.000717 -1007 1 0.000204 1560.000000 -0.000473 0.002976 0.005031 -1008 1 0.000200 1560.000000 0.000668 -0.002347 0.007467 -1009 1 0.000270 1560.000000 0.000025 -0.000138 0.002190 -1010 1 0.000242 1560.000000 0.001449 0.001381 0.007564 -1011 1 0.000220 1560.000000 0.002642 -0.002427 0.008731 -1012 1 0.000270 1560.000000 -0.001335 -0.003188 0.006551 -1013 1 0.000194 1560.000000 -0.001259 0.002050 0.004390 -1014 1 0.000241 1560.000000 0.001175 -0.003143 0.005573 -1015 1 0.000271 1560.000000 -0.001968 -0.001317 0.006883 -1016 1 0.000228 1560.000000 0.003037 -0.001822 0.001804 -1017 1 0.000260 1560.000000 0.002061 -0.002066 0.005962 -1018 1 0.000218 1560.000000 -0.001321 -0.001610 0.006989 -1019 1 0.000271 1560.000000 0.000988 -0.001353 0.007338 -1020 1 0.000280 1560.000000 -0.001776 0.001674 0.003622 -1021 1 0.000211 1560.000000 -0.000556 -0.002119 0.009391 -1022 1 0.000242 1560.000000 0.000532 -0.000417 0.008790 -1023 1 0.000225 1560.000000 -0.001612 0.001762 0.002614 -1024 1 0.000207 1560.000000 -0.002319 -0.000950 0.001276 -1025 1 0.000271 1560.000000 0.000928 0.000351 0.001389 -1026 1 0.000211 1560.000000 -0.000048 -0.000069 0.000943 -1027 1 0.000199 1560.000000 0.002651 0.001636 0.000388 -1028 1 0.000250 1560.000000 0.002522 -0.000199 0.002045 -1029 1 0.000240 1560.000000 0.002786 0.000985 0.001629 -1030 1 0.000215 1560.000000 -0.002198 0.001146 0.001608 -1031 1 0.000205 1560.000000 -0.002768 -0.001699 0.006737 -1032 1 0.000246 1560.000000 0.000977 0.000545 0.005444 -1033 1 0.000196 1560.000000 0.001383 0.000702 0.007716 -1034 1 0.000197 1560.000000 0.000103 0.000034 0.005982 -1035 1 0.000204 1560.000000 -0.000317 0.000636 0.007790 -1036 1 0.000278 1560.000000 -0.000158 -0.000075 0.006370 -1037 1 0.000258 1560.000000 0.002061 0.001116 0.003262 -1038 1 0.000195 1560.000000 0.000307 0.000981 0.002198 -1039 1 0.000226 1560.000000 0.000098 0.003324 0.005660 -1040 1 0.000237 1560.000000 0.000205 -0.001283 0.003707 -1041 1 0.000246 1560.000000 0.000637 -0.001492 0.001195 -1042 1 0.000219 1560.000000 0.000977 -0.001883 0.003267 -1043 1 0.000232 1560.000000 -0.001100 0.000105 0.005242 -1044 1 0.000214 1560.000000 -0.001013 0.001842 0.002554 -1045 1 0.000249 1560.000000 -0.001160 0.000632 0.004217 -1046 1 0.000221 1560.000000 0.001455 0.002252 0.004753 -1047 1 0.000245 1560.000000 -0.002042 -0.000664 0.009064 -1048 1 0.000229 1560.000000 0.000829 -0.000401 0.005327 -1049 1 0.000195 1560.000000 -0.000227 -0.000489 0.001145 -1050 1 0.000198 1560.000000 -0.002271 -0.002468 0.002553 -1051 1 0.000253 1560.000000 0.000152 0.000766 0.006559 -1052 1 0.000210 1560.000000 -0.000284 0.002971 0.009599 -1053 1 0.000248 1560.000000 -0.002391 -0.001429 0.009632 -1054 1 0.000279 1560.000000 -0.000798 -0.001282 0.007304 -1055 1 0.000222 1560.000000 -0.000999 0.000290 0.004405 -1056 1 0.000196 1560.000000 0.000309 -0.000324 0.001018 -1057 1 0.000196 1560.000000 -0.000666 -0.000090 0.007343 -1058 1 0.000214 1560.000000 0.000924 -0.002846 0.002102 -1059 1 0.000212 1560.000000 0.000157 0.000908 0.004710 -1060 1 0.000213 1560.000000 0.001365 -0.002862 0.003947 -1061 1 0.000200 1560.000000 0.003687 0.000119 0.003181 -1062 1 0.000266 1560.000000 0.000676 -0.000040 0.008590 -1063 1 0.000221 1560.000000 -0.000419 0.000132 0.005143 -1064 1 0.000194 1560.000000 -0.002081 0.001368 0.007971 -1065 1 0.000239 1560.000000 0.003150 0.001376 0.001944 -1066 1 0.000226 1560.000000 0.000983 -0.001601 0.006763 -1067 1 0.000279 1560.000000 0.002763 -0.001095 0.006728 -1068 1 0.000219 1560.000000 -0.001006 -0.001408 0.002421 -1069 1 0.000270 1560.000000 0.001128 -0.001999 0.008478 -1070 1 0.000217 1560.000000 0.000040 -0.002829 0.002018 -1071 1 0.000196 1560.000000 -0.001251 -0.000592 0.000105 -1072 1 0.000277 1560.000000 0.001478 0.002094 0.005985 -1073 1 0.000283 1560.000000 0.000614 0.003436 0.009260 -1074 1 0.000254 1560.000000 -0.001072 0.001037 0.001942 -1075 1 0.000250 1560.000000 0.000879 -0.001616 0.007398 -1076 1 0.000217 1560.000000 0.000158 0.002581 0.005669 -1077 1 0.000250 1560.000000 -0.000029 -0.002452 0.003151 -1078 1 0.000203 1560.000000 0.000320 -0.003418 0.007613 -1079 1 0.000254 1560.000000 -0.000338 -0.003042 0.008506 -1080 1 0.000207 1560.000000 0.001339 0.000401 0.001959 -1081 1 0.000239 1560.000000 -0.000338 0.001407 0.008585 -1082 1 0.000221 1560.000000 -0.001526 0.001043 0.002400 -1083 1 0.000201 1560.000000 -0.002505 0.000601 0.002631 -1084 1 0.000216 1560.000000 -0.000630 -0.000861 0.008582 -1085 1 0.000193 1560.000000 -0.000315 0.000885 0.009350 -1086 1 0.000200 1560.000000 0.000486 0.002339 0.001226 -1087 1 0.000231 1560.000000 -0.002423 0.000521 0.005087 -1088 1 0.000216 1560.000000 -0.001673 -0.001448 0.006731 -1089 1 0.000198 1560.000000 -0.000183 0.000138 0.004004 -1090 1 0.000286 1560.000000 -0.002418 0.000056 0.006787 -1091 1 0.000231 1560.000000 -0.002048 0.001403 0.001897 -1092 1 0.000207 1560.000000 -0.001305 -0.001647 0.005354 -1093 1 0.000192 1560.000000 0.000003 0.001434 0.009687 -1094 1 0.000230 1560.000000 0.000011 -0.000375 0.009216 -1095 1 0.000229 1560.000000 0.000265 0.001297 0.007118 -1096 1 0.000260 1560.000000 -0.002403 0.001231 0.002540 -1097 1 0.000219 1560.000000 -0.000316 0.002217 0.003281 -1098 1 0.000211 1560.000000 0.001667 -0.001173 0.002266 -1099 1 0.000261 1560.000000 -0.000044 0.000533 0.009289 -1100 1 0.000262 1560.000000 -0.000403 -0.002642 0.005072 -1101 1 0.000213 1560.000000 0.000088 0.000587 0.005838 -1102 1 0.000227 1560.000000 -0.000261 -0.000116 0.001021 -1103 1 0.000240 1560.000000 -0.001418 -0.002490 0.005861 -1104 1 0.000194 1560.000000 0.000479 0.000072 0.008691 -1105 1 0.000216 1560.000000 -0.001562 0.003247 0.004982 -1106 1 0.000267 1560.000000 0.000687 -0.001363 0.005082 -1107 1 0.000285 1560.000000 0.000514 0.000393 0.001984 -1108 1 0.000285 1560.000000 0.000440 -0.000772 0.009411 -1109 1 0.000261 1560.000000 0.000624 -0.000302 0.007146 -1110 1 0.000222 1560.000000 -0.001215 0.002844 0.001072 -1111 1 0.000224 1560.000000 0.000080 -0.001046 0.006915 -1112 1 0.000206 1560.000000 0.000344 0.001289 0.009083 -1113 1 0.000208 1560.000000 0.002033 0.002673 0.003005 -1114 1 0.000243 1560.000000 -0.001094 0.002567 0.002224 -1115 1 0.000260 1560.000000 0.000742 0.000088 0.006602 -1116 1 0.000195 1560.000000 0.000344 -0.000614 0.005416 -1117 1 0.000209 1560.000000 -0.000101 0.001264 0.008153 -1118 1 0.000219 1560.000000 0.000042 0.000188 0.000397 -1119 1 0.000218 1560.000000 -0.003067 -0.002165 0.008970 -1120 1 0.000275 1560.000000 -0.001973 0.001163 0.004777 -1121 1 0.000227 1560.000000 0.000425 0.001335 0.008208 -1122 1 0.000246 1560.000000 0.000531 0.000872 0.006176 -1123 1 0.000275 1560.000000 0.003157 0.000856 0.006371 -1124 1 0.000213 1560.000000 0.002569 -0.001016 0.007473 -1125 1 0.000213 1560.000000 0.000063 -0.002014 0.008591 -1126 1 0.000213 1560.000000 0.002743 0.000007 0.003796 -1127 1 0.000213 1560.000000 0.000715 0.002500 0.002908 -1128 1 0.000200 1560.000000 -0.000413 0.001207 0.005403 -1129 1 0.000270 1560.000000 -0.000391 0.000559 0.003420 -1130 1 0.000276 1560.000000 -0.000317 -0.000824 0.002375 -1131 1 0.000200 1560.000000 -0.002981 -0.002002 0.004061 -1132 1 0.000282 1560.000000 -0.003256 0.000630 0.000497 -1133 1 0.000223 1560.000000 -0.000082 -0.000470 0.005502 -1134 1 0.000263 1560.000000 0.003516 0.000550 0.002860 -1135 1 0.000232 1560.000000 0.001054 -0.000285 0.002585 -1136 1 0.000197 1560.000000 -0.000086 -0.001385 0.003856 -1137 1 0.000238 1560.000000 0.002496 0.000451 0.002246 -1138 1 0.000271 1560.000000 0.000291 -0.001439 0.000241 -1139 1 0.000238 1560.000000 -0.002131 -0.002741 0.001509 -1140 1 0.000204 1560.000000 0.000249 0.003040 0.004003 -1141 1 0.000212 1560.000000 -0.000043 0.000599 0.003896 -1142 1 0.000235 1560.000000 0.000137 -0.003455 0.003740 -1143 1 0.000233 1560.000000 0.002430 0.000204 0.006245 -1144 1 0.000199 1560.000000 -0.002834 0.000953 0.007925 -1145 1 0.000216 1560.000000 -0.002756 0.000701 0.002266 -1146 1 0.000203 1560.000000 0.002235 0.003102 0.003116 -1147 1 0.000249 1560.000000 0.001471 0.002766 0.000251 -1148 1 0.000222 1560.000000 0.001629 0.001973 0.004640 -1149 1 0.000256 1560.000000 -0.000648 0.002142 0.004055 -1150 1 0.000207 1560.000000 0.000094 0.002988 0.002316 -1151 1 0.000209 1560.000000 0.000894 -0.000634 0.009275 -1152 1 0.000223 1560.000000 -0.000318 -0.002002 0.006009 -1153 1 0.000279 1560.000000 0.002114 -0.000746 0.008621 -1154 1 0.000254 1560.000000 0.000180 -0.000273 0.009417 -1155 1 0.000221 1560.000000 -0.000006 -0.001894 0.002570 -1156 1 0.000275 1560.000000 0.000130 0.001705 0.008923 -1157 1 0.000236 1560.000000 -0.000261 -0.001499 0.003116 -1158 1 0.000278 1560.000000 -0.000128 0.000520 0.002541 -1159 1 0.000230 1560.000000 -0.001160 0.000104 0.009007 -1160 1 0.000204 1560.000000 -0.002040 -0.000037 0.001474 -1161 1 0.000197 1560.000000 0.000640 -0.000272 0.000525 -1162 1 0.000238 1560.000000 0.000390 0.002909 0.002974 -1163 1 0.000208 1560.000000 -0.001803 -0.001255 0.000389 -1164 1 0.000274 1560.000000 0.001346 0.000325 0.006660 -1165 1 0.000205 1560.000000 -0.001282 -0.003265 0.004066 -1166 1 0.000208 1560.000000 0.001107 -0.001134 0.008599 -1167 1 0.000200 1560.000000 -0.000371 -0.002582 0.002413 -1168 1 0.000197 1560.000000 -0.001229 -0.000550 0.001078 -1169 1 0.000206 1560.000000 -0.001426 -0.000035 0.003518 -1170 1 0.000203 1560.000000 0.002171 -0.000663 0.007912 -1171 1 0.000263 1560.000000 0.003201 0.000459 0.001055 -1172 1 0.000237 1560.000000 -0.001660 -0.001119 0.001130 -1173 1 0.000253 1560.000000 -0.000877 0.000935 0.000187 -1174 1 0.000222 1560.000000 0.001794 0.000713 0.007781 -1175 1 0.000255 1560.000000 -0.000177 0.002820 0.002062 -1176 1 0.000217 1560.000000 -0.000194 0.000672 0.005782 -1177 1 0.000208 1560.000000 -0.000235 -0.000141 0.000794 -1178 1 0.000193 1560.000000 -0.002663 -0.000924 0.007467 -1179 1 0.000261 1560.000000 0.001920 0.000260 0.004277 -1180 1 0.000284 1560.000000 0.003651 0.001221 0.003396 -1181 1 0.000265 1560.000000 0.001600 -0.002052 0.004654 -1182 1 0.000229 1560.000000 -0.000408 -0.000881 0.007678 -1183 1 0.000287 1560.000000 -0.001437 -0.000433 0.009566 -1184 1 0.000212 1560.000000 0.000874 -0.000102 0.005119 -1185 1 0.000203 1560.000000 0.001701 -0.001272 0.000792 -1186 1 0.000195 1560.000000 0.000006 -0.000105 0.001625 -1187 1 0.000216 1560.000000 -0.000052 0.000285 0.003438 -1188 1 0.000264 1560.000000 0.003077 -0.000586 0.004812 -1189 1 0.000238 1560.000000 0.000874 0.002429 0.001343 -1190 1 0.000199 1560.000000 -0.000437 -0.000955 0.006609 -1191 1 0.000199 1560.000000 -0.000405 -0.001749 0.001549 -1192 1 0.000270 1560.000000 -0.002218 0.000483 0.009470 -1193 1 0.000240 1560.000000 -0.002985 0.000311 0.007864 -1194 1 0.000197 1560.000000 -0.000534 -0.000259 0.003945 -1195 1 0.000239 1560.000000 -0.000173 0.001291 0.005402 -1196 1 0.000223 1560.000000 0.001602 -0.001213 0.004469 -1197 1 0.000210 1560.000000 0.002364 -0.002025 0.003136 -1198 1 0.000231 1560.000000 -0.001573 0.002150 0.000677 -1199 1 0.000249 1560.000000 -0.001526 0.000620 0.001616 -1200 1 0.000243 1560.000000 0.000925 0.001087 0.001492 -1201 1 0.000194 1560.000000 0.002900 0.001446 0.006904 -1202 1 0.000237 1560.000000 0.001143 0.001397 0.000437 -1203 1 0.000250 1560.000000 0.001981 -0.000901 0.005704 -1204 1 0.000197 1560.000000 0.000553 -0.001556 0.002478 -1205 1 0.000197 1560.000000 0.000709 0.001467 0.000903 -1206 1 0.000242 1560.000000 0.001309 -0.000539 0.003969 -1207 1 0.000200 1560.000000 -0.000001 -0.000569 0.001625 -1208 1 0.000235 1560.000000 -0.000130 0.002011 0.003985 -1209 1 0.000212 1560.000000 0.000209 0.000105 0.005013 -1210 1 0.000201 1560.000000 0.000879 -0.001308 0.006370 -1211 1 0.000237 1560.000000 -0.000548 -0.000288 0.006569 -1212 1 0.000205 1560.000000 -0.000000 -0.000504 0.009011 -1213 1 0.000229 1560.000000 0.000429 0.000417 0.006990 -1214 1 0.000261 1560.000000 0.001336 0.000230 0.003849 -1215 1 0.000260 1560.000000 -0.002965 -0.001411 0.002721 -1216 1 0.000246 1560.000000 -0.000243 -0.001042 0.000824 -1217 1 0.000223 1560.000000 -0.000331 -0.001378 0.008981 -1218 1 0.000287 1560.000000 0.002866 0.001233 0.007768 -1219 1 0.000264 1560.000000 0.001362 0.000984 0.002709 -1220 1 0.000206 1560.000000 0.001431 0.001696 0.006915 -1221 1 0.000268 1560.000000 0.003496 -0.000231 0.006119 -1222 1 0.000263 1560.000000 -0.002253 0.002847 0.000747 -1223 1 0.000236 1560.000000 -0.001511 0.002611 0.000194 -1224 1 0.000200 1560.000000 -0.003330 0.000928 0.002241 -1225 1 0.000214 1560.000000 -0.000014 0.002168 0.003818 -1226 1 0.000273 1560.000000 -0.001559 -0.000881 0.007982 -1227 1 0.000205 1560.000000 -0.000305 -0.001743 0.004048 -1228 1 0.000273 1560.000000 0.000987 -0.000079 0.007314 -1229 1 0.000206 1560.000000 0.000316 0.000285 0.008592 -1230 1 0.000217 1560.000000 -0.000053 -0.000189 0.007993 -1231 1 0.000257 1560.000000 -0.000857 0.003066 0.002249 -1232 1 0.000200 1560.000000 -0.002571 0.001058 0.004784 -1233 1 0.000276 1560.000000 -0.000285 0.000330 0.000340 -1234 1 0.000269 1560.000000 0.002213 -0.000288 0.006527 -1235 1 0.000245 1560.000000 -0.001832 0.000997 0.005012 -1236 1 0.000240 1560.000000 0.000660 0.002615 0.004223 -1237 1 0.000240 1560.000000 -0.000037 0.001047 0.007270 -1238 1 0.000199 1560.000000 -0.003158 0.000394 0.002809 -1239 1 0.000264 1560.000000 -0.000430 -0.000253 0.001584 -1240 1 0.000203 1560.000000 0.000755 -0.000601 0.003305 -1241 1 0.000248 1560.000000 -0.001953 -0.002696 0.003999 -1242 1 0.000283 1560.000000 -0.003182 -0.001090 0.001202 -1243 1 0.000242 1560.000000 0.001317 0.001165 0.007893 -1244 1 0.000240 1560.000000 -0.000625 -0.000058 0.008416 -1245 1 0.000209 1560.000000 -0.000613 0.003678 0.007179 -1246 1 0.000281 1560.000000 -0.000337 -0.000153 0.002088 -1247 1 0.000221 1560.000000 -0.001510 -0.000259 0.002849 -1248 1 0.000210 1560.000000 0.001052 0.000918 0.006160 -1249 1 0.000271 1560.000000 -0.002591 0.000008 0.009017 -1250 1 0.000213 1560.000000 -0.000056 -0.000528 0.002654 -1251 1 0.000249 1560.000000 -0.000564 0.000694 0.003201 -1252 1 0.000202 1560.000000 -0.002437 0.000474 0.008383 -1253 1 0.000288 1560.000000 0.001484 -0.002622 0.004974 -1254 1 0.000234 1560.000000 -0.001199 -0.000229 0.009120 -1255 1 0.000235 1560.000000 0.002714 -0.001389 0.001830 -1256 1 0.000213 1560.000000 -0.001265 0.002999 0.006027 -1257 1 0.000276 1560.000000 -0.003059 0.002091 0.002524 -1258 1 0.000284 1560.000000 0.003083 0.001312 0.001024 -1259 1 0.000220 1560.000000 0.003435 -0.000849 0.008997 -1260 1 0.000199 1560.000000 -0.000708 -0.000023 0.004330 -1261 1 0.000230 1560.000000 -0.003084 -0.002017 0.009588 -1262 1 0.000197 1560.000000 0.000722 -0.001694 0.005289 -1263 1 0.000243 1560.000000 0.001389 0.003569 0.007576 -1264 1 0.000254 1560.000000 0.000125 -0.000720 0.002075 -1265 1 0.000216 1560.000000 -0.000268 -0.000245 0.006688 -1266 1 0.000263 1560.000000 0.000968 -0.003726 0.008763 -1267 1 0.000194 1560.000000 -0.001232 0.000966 0.007503 -1268 1 0.000264 1560.000000 0.003269 -0.001197 0.001022 -1269 1 0.000192 1560.000000 0.001619 -0.000949 0.004580 -1270 1 0.000227 1560.000000 0.002079 -0.002174 0.000357 -1271 1 0.000252 1560.000000 0.002023 -0.000461 0.008969 -1272 1 0.000223 1560.000000 -0.002565 -0.000776 0.008917 -1273 1 0.000199 1560.000000 0.000404 -0.000180 0.005662 -1274 1 0.000217 1560.000000 -0.001623 0.000536 0.003490 -1275 1 0.000206 1560.000000 0.000159 -0.002764 0.003474 -1276 1 0.000235 1560.000000 0.002629 0.000298 0.001594 -1277 1 0.000208 1560.000000 0.000658 0.000232 0.003897 -1278 1 0.000259 1560.000000 0.000848 -0.000037 0.005972 -1279 1 0.000233 1560.000000 -0.000769 0.001688 0.002862 -1280 1 0.000287 1560.000000 0.000796 -0.000055 0.002933 -1281 1 0.000251 1560.000000 0.000281 0.001343 0.001584 -1282 1 0.000193 1560.000000 -0.000208 0.001061 0.003226 -1283 1 0.000282 1560.000000 0.001334 -0.002047 0.007121 -1284 1 0.000235 1560.000000 0.000359 -0.000215 0.002572 -1285 1 0.000230 1560.000000 0.000377 -0.001215 0.008866 -1286 1 0.000259 1560.000000 -0.003236 0.001890 0.005366 -1287 1 0.000256 1560.000000 -0.000203 0.000618 0.001258 -1288 1 0.000225 1560.000000 -0.002610 0.002559 0.002466 -1289 1 0.000279 1560.000000 0.001917 0.001983 0.005636 -1290 1 0.000205 1560.000000 0.001684 0.001879 0.005101 -1291 1 0.000199 1560.000000 -0.000042 -0.001195 0.004012 -1292 1 0.000252 1560.000000 -0.003696 -0.000908 0.002140 -1293 1 0.000255 1560.000000 0.001763 0.000762 0.001711 -1294 1 0.000244 1560.000000 0.003214 0.000057 0.007846 -1295 1 0.000226 1560.000000 0.000019 -0.003508 0.001852 -1296 1 0.000208 1560.000000 -0.002233 0.001632 0.003017 -1297 1 0.000199 1560.000000 0.000124 -0.000771 0.006283 -1298 1 0.000239 1560.000000 -0.003108 -0.002090 0.006347 -1299 1 0.000260 1560.000000 -0.003324 -0.000320 0.001801 -1300 1 0.000229 1560.000000 -0.001072 0.000104 0.003013 -1301 1 0.000199 1560.000000 -0.000855 0.001564 0.000159 -1302 1 0.000231 1560.000000 -0.001629 -0.003193 0.001992 -1303 1 0.000215 1560.000000 -0.000144 0.000382 0.000657 -1304 1 0.000207 1560.000000 0.000451 -0.000957 0.002985 -1305 1 0.000270 1560.000000 0.002581 -0.002439 0.001489 -1306 1 0.000209 1560.000000 0.000284 0.000594 0.004733 -1307 1 0.000198 1560.000000 0.002631 -0.002182 0.009056 -1308 1 0.000280 1560.000000 0.000089 0.002567 0.001875 -1309 1 0.000263 1560.000000 -0.002187 0.002474 0.002455 -1310 1 0.000230 1560.000000 0.000376 0.003308 0.001745 -1311 1 0.000252 1560.000000 -0.002564 -0.000508 0.004820 -1312 1 0.000252 1560.000000 0.000105 -0.001687 0.004917 -1313 1 0.000251 1560.000000 0.000375 0.003095 0.004576 -1314 1 0.000274 1560.000000 0.001273 0.002283 0.008502 -1315 1 0.000240 1560.000000 -0.000543 0.000236 0.002060 -1316 1 0.000205 1560.000000 -0.002664 0.002582 0.008402 -1317 1 0.000254 1560.000000 0.001774 0.000548 0.004938 -1318 1 0.000252 1560.000000 -0.001390 -0.003173 0.008149 -1319 1 0.000212 1560.000000 -0.002782 0.002250 0.006782 -1320 1 0.000194 1560.000000 -0.000332 -0.001363 0.001291 -1321 1 0.000211 1560.000000 -0.002976 -0.000645 0.004136 -1322 1 0.000195 1560.000000 0.001332 -0.002176 0.009535 -1323 1 0.000237 1560.000000 -0.000826 0.001090 0.007445 -1324 1 0.000192 1560.000000 0.001828 -0.000202 0.003016 -1325 1 0.000207 1560.000000 -0.000777 -0.000576 0.000789 -1326 1 0.000253 1560.000000 -0.001702 0.003116 0.005967 -1327 1 0.000219 1560.000000 -0.001608 0.001555 0.008806 -1328 1 0.000198 1560.000000 -0.002329 -0.002594 0.005781 -1329 1 0.000241 1560.000000 -0.003057 -0.000558 0.008419 -1330 1 0.000240 1560.000000 0.000842 0.001870 0.005344 -1331 1 0.000213 1560.000000 0.000708 -0.002135 0.005932 -1332 1 0.000217 1560.000000 -0.001583 -0.000676 0.002040 -1333 1 0.000281 1560.000000 -0.001414 -0.002229 0.007179 -1334 1 0.000233 1560.000000 -0.002860 0.000562 0.001353 -1335 1 0.000260 1560.000000 0.003323 0.000310 0.000260 -1336 1 0.000286 1560.000000 0.000733 0.000078 0.008061 -1337 1 0.000282 1560.000000 -0.001879 0.003335 0.004626 -1338 1 0.000211 1560.000000 0.000546 -0.001521 0.004710 -1339 1 0.000201 1560.000000 -0.003154 -0.000699 0.009631 -1340 1 0.000253 1560.000000 -0.000121 -0.000077 0.004341 -1341 1 0.000248 1560.000000 0.000862 -0.000850 0.005577 -1342 1 0.000265 1560.000000 0.000904 0.000315 0.009124 -1343 1 0.000206 1560.000000 -0.002755 -0.002228 0.009004 -1344 1 0.000217 1560.000000 0.000679 0.001523 0.002468 -1345 1 0.000214 1560.000000 -0.003242 -0.001282 0.000797 -1346 1 0.000259 1560.000000 -0.003653 -0.000897 0.004188 -1347 1 0.000197 1560.000000 -0.002044 -0.002591 0.007807 -1348 1 0.000230 1560.000000 0.000910 0.000170 0.001835 -1349 1 0.000207 1560.000000 -0.000593 -0.000682 0.005767 -1350 1 0.000199 1560.000000 -0.001855 -0.001593 0.006704 -1351 1 0.000211 1560.000000 0.001309 -0.002968 0.003352 -1352 1 0.000221 1560.000000 0.001004 0.002415 0.000285 -1353 1 0.000208 1560.000000 0.001771 0.001498 0.006196 -1354 1 0.000205 1560.000000 0.001389 0.003298 0.004191 -1355 1 0.000194 1560.000000 0.000787 -0.001015 0.003701 -1356 1 0.000224 1560.000000 0.003009 -0.000091 0.001594 -1357 1 0.000209 1560.000000 -0.000501 -0.000311 0.005494 -1358 1 0.000243 1560.000000 -0.002237 -0.003121 0.000731 -1359 1 0.000270 1560.000000 -0.002946 0.002408 0.003881 -1360 1 0.000194 1560.000000 -0.000466 0.000755 0.006532 -1361 1 0.000252 1560.000000 -0.000431 0.002137 0.003488 -1362 1 0.000285 1560.000000 0.002461 -0.000643 0.003216 -1363 1 0.000260 1560.000000 0.001250 -0.000093 0.009234 -1364 1 0.000200 1560.000000 0.001341 0.001360 0.006053 -1365 1 0.000204 1560.000000 -0.001295 0.003415 0.006163 -1366 1 0.000246 1560.000000 -0.000675 -0.000946 0.003123 -1367 1 0.000214 1560.000000 -0.000340 0.001731 0.003697 -1368 1 0.000207 1560.000000 -0.001955 -0.003116 0.002990 -1369 1 0.000260 1560.000000 0.000385 -0.000129 0.009112 -1370 1 0.000211 1560.000000 0.001828 -0.001955 0.001685 -1371 1 0.000205 1560.000000 -0.000625 0.000737 0.002265 -1372 1 0.000255 1560.000000 -0.002983 0.000710 0.008326 -1373 1 0.000233 1560.000000 -0.000357 -0.001433 0.002751 -1374 1 0.000214 1560.000000 -0.001322 0.000376 0.001432 -1375 1 0.000213 1560.000000 0.000850 -0.001498 0.002146 -1376 1 0.000285 1560.000000 -0.000989 0.002357 0.009558 -1377 1 0.000279 1560.000000 -0.001135 -0.001331 0.006883 -1378 1 0.000209 1560.000000 -0.003032 -0.001597 0.000617 -1379 1 0.000207 1560.000000 0.000571 0.001909 0.000692 -1380 1 0.000207 1560.000000 -0.000710 0.000864 0.008595 -1381 1 0.000212 1560.000000 0.001987 -0.003013 0.005407 -1382 1 0.000209 1560.000000 0.002208 0.000240 0.004504 -1383 1 0.000227 1560.000000 -0.002759 0.000128 0.003122 -1384 1 0.000200 1560.000000 0.000405 0.000882 0.001834 -1385 1 0.000242 1560.000000 0.000350 0.002280 0.003152 -1386 1 0.000254 1560.000000 0.000253 -0.000483 0.007872 -1387 1 0.000268 1560.000000 0.000908 0.002159 0.004060 -1388 1 0.000220 1560.000000 0.001092 -0.000385 0.009705 -1389 1 0.000196 1560.000000 0.000847 0.001203 0.003539 -1390 1 0.000193 1560.000000 0.001363 -0.000861 0.006120 -1391 1 0.000233 1560.000000 0.001475 -0.000742 0.006726 -1392 1 0.000204 1560.000000 -0.002131 -0.002052 0.001481 -1393 1 0.000229 1560.000000 -0.002540 0.001255 0.005103 -1394 1 0.000270 1560.000000 0.000518 0.002432 0.009710 -1395 1 0.000266 1560.000000 -0.002590 0.002167 0.004930 -1396 1 0.000268 1560.000000 0.002224 -0.001163 0.003292 -1397 1 0.000201 1560.000000 -0.000342 0.003783 0.001075 -1398 1 0.000212 1560.000000 -0.000860 0.001038 0.004262 -1399 1 0.000252 1560.000000 0.000704 -0.002318 0.001856 -1400 1 0.000264 1560.000000 -0.001132 -0.002467 0.003629 -1401 1 0.000197 1560.000000 -0.000613 -0.000139 0.002335 -1402 1 0.000285 1560.000000 -0.000077 -0.000979 0.007239 -1403 1 0.000226 1560.000000 -0.000177 -0.001659 0.002367 -1404 1 0.000248 1560.000000 -0.000265 0.002508 0.004064 -1405 1 0.000279 1560.000000 0.000694 0.002971 0.009185 -1406 1 0.000238 1560.000000 -0.001207 0.000559 0.007079 -1407 1 0.000239 1560.000000 0.001206 0.000918 0.007612 -1408 1 0.000235 1560.000000 0.003461 0.001691 0.002054 -1409 1 0.000198 1560.000000 0.002761 -0.000382 0.000396 -1410 1 0.000255 1560.000000 0.002152 -0.002437 0.009154 -1411 1 0.000201 1560.000000 0.001519 -0.002945 0.005873 -1412 1 0.000255 1560.000000 0.001254 0.000869 0.001976 -1413 1 0.000248 1560.000000 -0.000257 0.000028 0.009482 -1414 1 0.000215 1560.000000 0.000594 0.000550 0.001797 -1415 1 0.000199 1560.000000 0.002196 -0.001210 0.001837 -1416 1 0.000209 1560.000000 -0.000930 0.001930 0.009136 -1417 1 0.000222 1560.000000 0.000926 -0.001845 0.008478 -1418 1 0.000217 1560.000000 -0.001221 -0.001429 0.001162 -1419 1 0.000211 1560.000000 0.002431 -0.000145 0.008739 -1420 1 0.000209 1560.000000 0.002004 -0.002427 0.001319 -1421 1 0.000266 1560.000000 -0.000450 -0.003189 0.003661 -1422 1 0.000204 1560.000000 0.001306 0.000401 0.005467 -1423 1 0.000213 1560.000000 -0.001821 -0.000910 0.003974 -1424 1 0.000274 1560.000000 0.001862 -0.002382 0.001672 -1425 1 0.000222 1560.000000 -0.002429 0.000960 0.001002 -1426 1 0.000203 1560.000000 0.000479 -0.000037 0.004388 -1427 1 0.000282 1560.000000 0.000427 -0.000018 0.009568 -1428 1 0.000221 1560.000000 -0.000605 0.000382 0.003217 -1429 1 0.000227 1560.000000 -0.000098 -0.000101 0.003913 -1430 1 0.000243 1560.000000 0.002699 0.000053 0.002682 -1431 1 0.000197 1560.000000 -0.000159 -0.001162 0.008567 -1432 1 0.000203 1560.000000 0.000004 -0.000324 0.008226 -1433 1 0.000201 1560.000000 0.001088 -0.001406 0.002745 -1434 1 0.000222 1560.000000 -0.001226 0.001628 0.006716 -1435 1 0.000213 1560.000000 0.002087 0.002572 0.008045 -1436 1 0.000279 1560.000000 -0.001217 0.000381 0.007919 -1437 1 0.000263 1560.000000 -0.001028 0.002239 0.005830 -1438 1 0.000224 1560.000000 -0.002022 -0.001206 0.009564 -1439 1 0.000211 1560.000000 -0.002935 0.001217 0.002865 -1440 1 0.000219 1560.000000 0.001936 -0.000989 0.008291 -1441 1 0.000279 1560.000000 -0.000058 0.001863 0.004648 -1442 1 0.000204 1560.000000 0.001925 -0.002871 0.003598 -1443 1 0.000193 1560.000000 -0.000448 0.001332 0.005010 -1444 1 0.000214 1560.000000 0.000131 0.000169 0.003806 -1445 1 0.000243 1560.000000 -0.000326 -0.000598 0.008681 -1446 1 0.000216 1560.000000 0.001531 -0.002179 0.002102 -1447 1 0.000197 1560.000000 0.000046 0.000537 0.007631 -1448 1 0.000269 1560.000000 -0.000208 -0.001447 0.001799 -1449 1 0.000260 1560.000000 0.002116 0.000119 0.007139 -1450 1 0.000223 1560.000000 -0.003164 0.002129 0.008966 -1451 1 0.000200 1560.000000 -0.001386 0.001769 0.002095 -1452 1 0.000249 1560.000000 -0.000648 -0.000179 0.003180 -1453 1 0.000263 1560.000000 0.003684 -0.000705 0.007802 -1454 1 0.000228 1560.000000 0.002810 -0.001752 0.004001 -1455 1 0.000225 1560.000000 0.001171 0.000585 0.008623 -1456 1 0.000199 1560.000000 -0.003175 0.001369 0.005843 -1457 1 0.000261 1560.000000 0.001347 -0.000177 0.002471 -1458 1 0.000224 1560.000000 0.000987 0.000812 0.005546 -1459 1 0.000251 1560.000000 0.002988 -0.000398 0.009301 -1460 1 0.000213 1560.000000 0.000695 0.000848 0.005597 -1461 1 0.000212 1560.000000 -0.001416 -0.003538 0.001241 -1462 1 0.000210 1560.000000 0.000383 0.001667 0.000542 -1463 1 0.000202 1560.000000 0.000591 0.000423 0.005861 -1464 1 0.000198 1560.000000 0.000351 0.001513 0.004460 -1465 1 0.000251 1560.000000 -0.002140 -0.002460 0.003713 -1466 1 0.000235 1560.000000 -0.001407 0.000675 0.000228 -1467 1 0.000216 1560.000000 0.002255 -0.000121 0.001477 -1468 1 0.000229 1560.000000 0.000551 0.001300 0.001996 -1469 1 0.000205 1560.000000 0.002526 -0.001238 0.008458 -1470 1 0.000252 1560.000000 -0.001158 0.002075 0.000653 -1471 1 0.000242 1560.000000 0.001129 0.003128 0.003283 -1472 1 0.000263 1560.000000 -0.000088 -0.000345 0.006207 -1473 1 0.000198 1560.000000 -0.000411 0.000864 0.001032 -1474 1 0.000222 1560.000000 0.001516 0.002324 0.005835 -1475 1 0.000260 1560.000000 0.000391 -0.000461 0.003399 -1476 1 0.000284 1560.000000 0.001627 0.000733 0.002356 -1477 1 0.000215 1560.000000 0.000343 -0.002229 0.008112 -1478 1 0.000247 1560.000000 -0.000732 -0.001847 0.002885 -1479 1 0.000245 1560.000000 -0.003382 0.000494 0.005713 -1480 1 0.000230 1560.000000 -0.001562 -0.001180 0.007208 -1481 1 0.000225 1560.000000 -0.000156 0.000161 0.004224 -1482 1 0.000236 1560.000000 -0.002835 -0.001808 0.004705 -1483 1 0.000193 1560.000000 -0.002310 -0.001196 0.007541 -1484 1 0.000218 1560.000000 -0.002307 0.002218 0.004429 -1485 1 0.000207 1560.000000 -0.002465 -0.002143 0.001108 -1486 1 0.000226 1560.000000 0.000868 0.000341 0.002552 -1487 1 0.000274 1560.000000 -0.002896 -0.001367 0.004993 -1488 1 0.000215 1560.000000 -0.002065 0.001614 0.001328 -1489 1 0.000250 1560.000000 -0.000275 -0.000604 0.001340 -1490 1 0.000226 1560.000000 0.003350 -0.000367 0.002459 -1491 1 0.000257 1560.000000 0.003503 0.000372 0.005908 -1492 1 0.000198 1560.000000 -0.002106 -0.002911 0.002122 -1493 1 0.000240 1560.000000 -0.001225 -0.000316 0.001389 -1494 1 0.000242 1560.000000 -0.000254 0.000139 0.001059 -1495 1 0.000197 1560.000000 0.002072 -0.002128 0.001332 -1496 1 0.000270 1560.000000 0.000740 -0.002112 0.005042 -1497 1 0.000258 1560.000000 -0.002297 0.001246 0.009678 -1498 1 0.000260 1560.000000 -0.001639 -0.002723 0.006469 -1499 1 0.000243 1560.000000 -0.003614 -0.000261 0.004967 -1500 1 0.000219 1560.000000 0.000862 0.001398 0.002457 -1501 1 0.000200 1560.000000 0.002763 -0.002159 0.004925 -1502 1 0.000220 1560.000000 0.000759 -0.000884 0.002818 -1503 1 0.000287 1560.000000 -0.000961 -0.002955 0.008697 -1504 1 0.000273 1560.000000 -0.003370 0.001287 0.008879 -1505 1 0.000278 1560.000000 0.001136 0.000620 0.004934 -1506 1 0.000206 1560.000000 -0.001248 0.000534 0.000106 -1507 1 0.000197 1560.000000 0.001326 -0.000166 0.000945 -1508 1 0.000266 1560.000000 -0.000087 -0.000311 0.007197 -1509 1 0.000233 1560.000000 0.001134 0.000289 0.008709 -1510 1 0.000221 1560.000000 -0.000241 0.000188 0.008731 -1511 1 0.000199 1560.000000 -0.000535 -0.002030 0.001583 -1512 1 0.000210 1560.000000 0.000557 -0.003454 0.004270 -1513 1 0.000251 1560.000000 -0.001691 0.000028 0.005379 -1514 1 0.000284 1560.000000 0.003095 -0.002076 0.006493 -1515 1 0.000231 1560.000000 -0.001994 0.002288 0.007173 -1516 1 0.000243 1560.000000 -0.003295 0.001484 0.002017 -1517 1 0.000245 1560.000000 0.002134 0.001125 0.009388 -1518 1 0.000270 1560.000000 -0.003495 -0.000155 0.000545 -1519 1 0.000281 1560.000000 -0.003554 0.000907 0.006012 -1520 1 0.000205 1560.000000 0.002417 0.001952 0.002729 -1521 1 0.000218 1560.000000 -0.002582 0.002287 0.006273 -1522 1 0.000286 1560.000000 0.001757 -0.002816 0.001206 -1523 1 0.000195 1560.000000 0.000002 -0.002380 0.008131 -1524 1 0.000204 1560.000000 0.002213 0.003049 0.003802 -1525 1 0.000210 1560.000000 0.001685 0.002669 0.007614 -1526 1 0.000250 1560.000000 -0.002950 0.001653 0.006761 -1527 1 0.000201 1560.000000 -0.001289 0.001602 0.000919 -1528 1 0.000270 1560.000000 -0.000249 -0.002539 0.004480 -1529 1 0.000251 1560.000000 0.002074 -0.001007 0.004210 -1530 1 0.000236 1560.000000 -0.002691 -0.001240 0.004400 -1531 1 0.000195 1560.000000 -0.002328 -0.000064 0.007766 -1532 1 0.000196 1560.000000 -0.000950 0.001698 0.000795 -1533 1 0.000223 1560.000000 -0.000687 -0.000648 0.005453 -1534 1 0.000276 1560.000000 -0.001410 0.001923 0.006567 -1535 1 0.000275 1560.000000 -0.000627 0.003665 0.001567 -1536 1 0.000199 1560.000000 0.002681 -0.000484 0.006420 -1537 1 0.000205 1560.000000 0.002226 0.000075 0.003067 -1538 1 0.000209 1560.000000 -0.001634 -0.000256 0.002183 -1539 1 0.000203 1560.000000 -0.001592 0.002119 0.001551 -1540 1 0.000254 1560.000000 0.002055 0.001437 0.003024 -1541 1 0.000205 1560.000000 0.000415 0.002629 0.008189 -1542 1 0.000224 1560.000000 0.001374 0.001061 0.001777 -1543 1 0.000213 1560.000000 -0.002082 0.002099 0.003062 -1544 1 0.000253 1560.000000 -0.001850 0.001474 0.002862 -1545 1 0.000285 1560.000000 0.001211 0.002093 0.007194 -1546 1 0.000200 1560.000000 0.000197 -0.002208 0.005273 -1547 1 0.000194 1560.000000 -0.000885 0.001167 0.005460 -1548 1 0.000219 1560.000000 -0.001289 0.002439 0.004679 -1549 1 0.000273 1560.000000 0.002578 0.001040 0.006239 -1550 1 0.000204 1560.000000 -0.000232 0.001761 0.009102 -1551 1 0.000245 1560.000000 -0.001998 0.003113 0.006112 -1552 1 0.000200 1560.000000 -0.000247 -0.000801 0.008314 -1553 1 0.000210 1560.000000 0.001242 -0.003079 0.007130 -1554 1 0.000216 1560.000000 -0.001608 0.001533 0.002719 -1555 1 0.000208 1560.000000 -0.003274 0.001702 0.002200 -1556 1 0.000287 1560.000000 0.000492 0.001051 0.005284 -1557 1 0.000267 1560.000000 -0.001291 -0.002533 0.005584 -1558 1 0.000226 1560.000000 -0.001193 0.000604 0.009800 -1559 1 0.000213 1560.000000 -0.001429 -0.000230 0.008909 -1560 1 0.000232 1560.000000 0.002755 0.001858 0.003298 -1561 1 0.000247 1560.000000 0.000057 0.001439 0.008557 -1562 1 0.000288 1560.000000 0.002568 0.001480 0.001583 -1563 1 0.000242 1560.000000 0.001075 0.002053 0.005827 -1564 1 0.000198 1560.000000 0.000664 0.000515 0.009188 -1565 1 0.000194 1560.000000 -0.000678 0.002331 0.001885 -1566 1 0.000226 1560.000000 0.001490 -0.002033 0.006543 -1567 1 0.000278 1560.000000 0.000151 0.002983 0.001104 -1568 1 0.000228 1560.000000 -0.001414 0.001652 0.002645 -1569 1 0.000267 1560.000000 0.002031 -0.000019 0.002401 -1570 1 0.000202 1560.000000 0.002630 -0.002676 0.003827 -1571 1 0.000262 1560.000000 -0.001642 -0.001002 0.006401 -1572 1 0.000274 1560.000000 0.002227 0.002149 0.006505 -1573 1 0.000214 1560.000000 0.002404 0.000432 0.000845 -1574 1 0.000247 1560.000000 0.000116 -0.000398 0.003503 -1575 1 0.000280 1560.000000 -0.000344 -0.001208 0.004360 -1576 1 0.000207 1560.000000 -0.001901 0.001249 0.009579 -1577 1 0.000262 1560.000000 0.001352 -0.002241 0.004597 -1578 1 0.000222 1560.000000 -0.003232 0.001756 0.007919 -1579 1 0.000280 1560.000000 0.000172 -0.001421 0.007014 -1580 1 0.000232 1560.000000 -0.003610 -0.000412 0.002070 -1581 1 0.000215 1560.000000 -0.000003 -0.001362 0.002571 -1582 1 0.000219 1560.000000 -0.000306 -0.000052 0.000263 -1583 1 0.000211 1560.000000 0.003042 -0.001449 0.006800 -1584 1 0.000224 1560.000000 -0.003412 -0.000574 0.008902 -1585 1 0.000202 1560.000000 -0.000907 -0.001551 0.006720 -1586 1 0.000226 1560.000000 0.001573 0.000547 0.006799 -1587 1 0.000215 1560.000000 0.003679 -0.000398 0.004898 -1588 1 0.000197 1560.000000 -0.001643 0.001102 0.005936 -1589 1 0.000209 1560.000000 -0.000916 -0.003139 0.007023 -1590 1 0.000199 1560.000000 0.000142 -0.000514 0.007322 -1591 1 0.000218 1560.000000 0.001242 0.000814 0.002417 -1592 1 0.000235 1560.000000 -0.001841 -0.000654 0.001453 -1593 1 0.000280 1560.000000 0.003523 -0.000242 0.006778 -1594 1 0.000249 1560.000000 -0.001944 0.000811 0.006919 -1595 1 0.000213 1560.000000 0.000315 -0.002688 0.007465 -1596 1 0.000212 1560.000000 0.001667 0.000601 0.008661 -1597 1 0.000284 1560.000000 -0.001388 0.001442 0.000524 -1598 1 0.000201 1560.000000 -0.000635 0.001129 0.001795 -1599 1 0.000210 1560.000000 -0.000106 0.001496 0.004546 -1600 1 0.000269 1560.000000 -0.001190 -0.001211 0.001956 -1601 1 0.000245 1560.000000 0.001133 -0.001711 0.001699 -1602 1 0.000286 1560.000000 -0.002078 -0.000522 0.002448 -1603 1 0.000217 1560.000000 0.002752 0.001711 0.004891 -1604 1 0.000210 1560.000000 -0.000003 0.003838 0.004533 -1605 1 0.000204 1560.000000 -0.000117 -0.000426 0.000224 -1606 1 0.000233 1560.000000 0.000241 0.000258 0.004847 -1607 1 0.000211 1560.000000 0.001682 0.000647 0.002895 -1608 1 0.000196 1560.000000 -0.002034 -0.000760 0.009482 -1609 1 0.000251 1560.000000 -0.000245 0.003276 0.008813 -1610 1 0.000216 1560.000000 -0.000292 -0.000383 0.002657 -1611 1 0.000202 1560.000000 0.000094 0.000524 0.008325 -1612 1 0.000199 1560.000000 0.000320 -0.000741 0.005652 -1613 1 0.000278 1560.000000 -0.001058 -0.000913 0.008898 -1614 1 0.000255 1560.000000 -0.001095 -0.000377 0.001850 -1615 1 0.000220 1560.000000 0.000530 -0.001402 0.001868 -1616 1 0.000194 1560.000000 -0.000946 0.002398 0.003256 -1617 1 0.000200 1560.000000 0.001937 0.000844 0.000785 -1618 1 0.000253 1560.000000 -0.000364 -0.000105 0.005133 -1619 1 0.000197 1560.000000 0.001885 0.001786 0.000898 -1620 1 0.000222 1560.000000 -0.001897 -0.003236 0.006183 -1621 1 0.000204 1560.000000 -0.002957 -0.000095 0.009545 -1622 1 0.000268 1560.000000 0.000528 0.000750 0.009691 -1623 1 0.000238 1560.000000 0.002687 -0.000026 0.003062 -1624 1 0.000212 1560.000000 0.002422 -0.001749 0.004381 -1625 1 0.000225 1560.000000 -0.002502 -0.001469 0.006727 -1626 1 0.000207 1560.000000 -0.000675 0.001893 0.007078 -1627 1 0.000277 1560.000000 -0.001055 -0.001835 0.001067 -1628 1 0.000217 1560.000000 0.000368 -0.000452 0.001436 -1629 1 0.000222 1560.000000 0.000722 -0.000981 0.004153 -1630 1 0.000268 1560.000000 0.003272 0.000181 0.005972 -1631 1 0.000219 1560.000000 0.002286 -0.000094 0.002301 -1632 1 0.000208 1560.000000 -0.000759 0.000119 0.007489 -1633 1 0.000220 1560.000000 -0.002942 -0.000592 0.006721 -1634 1 0.000284 1560.000000 -0.000715 0.000354 0.004184 -1635 1 0.000205 1560.000000 -0.000867 0.002603 0.000955 -1636 1 0.000192 1560.000000 -0.002059 0.001804 0.004102 -1637 1 0.000212 1560.000000 0.001858 0.001986 0.007106 -1638 1 0.000238 1560.000000 0.000125 -0.000972 0.005950 -1639 1 0.000219 1560.000000 -0.000085 0.001133 0.001428 -1640 1 0.000262 1560.000000 -0.001116 -0.002835 0.003608 -1641 1 0.000230 1560.000000 -0.000928 -0.002693 0.001696 -1642 1 0.000208 1560.000000 -0.000010 -0.000788 0.009089 -1643 1 0.000271 1560.000000 -0.001046 0.001383 0.002307 -1644 1 0.000198 1560.000000 -0.002524 -0.001404 0.009227 -1645 1 0.000210 1560.000000 0.001783 -0.000870 0.004750 -1646 1 0.000280 1560.000000 -0.002981 -0.000806 0.008753 -1647 1 0.000236 1560.000000 0.000032 -0.002326 0.002224 -1648 1 0.000217 1560.000000 0.001496 -0.003101 0.002256 -1649 1 0.000225 1560.000000 -0.001217 -0.000172 0.005941 -1650 1 0.000201 1560.000000 0.000205 -0.003687 0.005717 -1651 1 0.000211 1560.000000 -0.000803 -0.000811 0.001306 -1652 1 0.000196 1560.000000 0.000975 0.001639 0.001895 -1653 1 0.000232 1560.000000 -0.001957 0.001976 0.007269 -1654 1 0.000280 1560.000000 -0.001333 0.001640 0.001242 -1655 1 0.000256 1560.000000 0.002966 -0.001731 0.008088 -1656 1 0.000282 1560.000000 0.002652 0.000813 0.004999 -1657 1 0.000249 1560.000000 -0.001453 -0.000063 0.006666 -1658 1 0.000218 1560.000000 0.000602 0.002261 0.008859 -1659 1 0.000211 1560.000000 -0.001683 0.001869 0.001088 -1660 1 0.000223 1560.000000 -0.000357 0.001988 0.000245 -1661 1 0.000201 1560.000000 -0.000315 -0.000342 0.004636 -1662 1 0.000230 1560.000000 -0.000557 0.000658 0.005065 -1663 1 0.000207 1560.000000 -0.000543 -0.000662 0.008647 -1664 1 0.000196 1560.000000 -0.001028 0.003347 0.006099 -1665 1 0.000245 1560.000000 0.001476 0.000059 0.004562 -1666 1 0.000258 1560.000000 0.000331 0.002817 0.007958 -1667 1 0.000221 1560.000000 0.000323 -0.000356 0.002752 -1668 1 0.000249 1560.000000 -0.001642 -0.000391 0.002655 -1669 1 0.000225 1560.000000 0.001898 -0.000203 0.002130 -1670 1 0.000204 1560.000000 0.000601 -0.000271 0.009761 -1671 1 0.000212 1560.000000 -0.000905 -0.001918 0.001501 -1672 1 0.000199 1560.000000 -0.001860 0.003059 0.005768 -1673 1 0.000249 1560.000000 0.001623 -0.000193 0.001845 -1674 1 0.000230 1560.000000 0.001866 0.000857 0.005082 -1675 1 0.000237 1560.000000 0.001602 0.002916 0.005680 -1676 1 0.000240 1560.000000 0.001132 0.002669 0.005505 -1677 1 0.000225 1560.000000 -0.001091 -0.000094 0.004457 -1678 1 0.000236 1560.000000 0.000759 0.002772 0.001086 -1679 1 0.000199 1560.000000 -0.000418 -0.002333 0.001277 -1680 1 0.000236 1560.000000 0.003248 -0.001939 0.007394 -1681 1 0.000196 1560.000000 0.000304 -0.001337 0.002838 -1682 1 0.000214 1560.000000 -0.000760 0.002111 0.001472 -1683 1 0.000244 1560.000000 -0.000225 0.001093 0.005678 -1684 1 0.000213 1560.000000 -0.001130 -0.002551 0.002701 -1685 1 0.000217 1560.000000 -0.001478 -0.001688 0.008309 -1686 1 0.000219 1560.000000 -0.000614 -0.000011 0.003381 -1687 1 0.000235 1560.000000 -0.002678 0.001922 0.004328 -1688 1 0.000233 1560.000000 0.001635 0.001081 0.002702 -1689 1 0.000193 1560.000000 0.001032 -0.002214 0.000819 -1690 1 0.000268 1560.000000 -0.000096 0.001309 0.006249 -1691 1 0.000198 1560.000000 0.002119 -0.001905 0.001903 -1692 1 0.000219 1560.000000 -0.001446 -0.000140 0.007093 -1693 1 0.000241 1560.000000 -0.000699 0.002814 0.009347 -1694 1 0.000261 1560.000000 -0.001293 -0.001122 0.007682 -1695 1 0.000209 1560.000000 -0.001042 -0.000012 0.002458 -1696 1 0.000211 1560.000000 -0.000242 -0.003094 0.004461 -1697 1 0.000228 1560.000000 -0.001767 -0.000241 0.001636 -1698 1 0.000198 1560.000000 0.001284 0.003009 0.007865 -1699 1 0.000206 1560.000000 -0.000263 0.000116 0.007951 -1700 1 0.000218 1560.000000 -0.001514 0.001384 0.007325 -1701 1 0.000206 1560.000000 0.000563 -0.002973 0.004647 -1702 1 0.000244 1560.000000 -0.001800 -0.003309 0.002358 -1703 1 0.000197 1560.000000 0.001875 0.003169 0.000133 -1704 1 0.000221 1560.000000 0.000038 -0.000809 0.003308 -1705 1 0.000256 1560.000000 0.000372 0.002241 0.006259 -1706 1 0.000198 1560.000000 0.001424 0.001820 0.009685 -1707 1 0.000256 1560.000000 -0.000460 -0.000028 0.004068 -1708 1 0.000251 1560.000000 -0.000391 0.003791 0.002113 -1709 1 0.000255 1560.000000 -0.001867 -0.002147 0.005646 -1710 1 0.000245 1560.000000 -0.000986 -0.000607 0.006644 -1711 1 0.000208 1560.000000 -0.001981 0.001125 0.002972 -1712 1 0.000192 1560.000000 0.001848 -0.002445 0.009744 -1713 1 0.000206 1560.000000 0.001033 -0.001593 0.004389 -1714 1 0.000235 1560.000000 0.001950 -0.002579 0.004552 -1715 1 0.000266 1560.000000 -0.001730 -0.000052 0.008773 -1716 1 0.000233 1560.000000 -0.000960 -0.000453 0.005810 -1717 1 0.000231 1560.000000 -0.000793 -0.000472 0.002283 -1718 1 0.000210 1560.000000 0.001825 -0.001193 0.001078 -1719 1 0.000246 1560.000000 -0.001000 0.000644 0.005730 -1720 1 0.000202 1560.000000 0.001314 -0.001250 0.004481 -1721 1 0.000197 1560.000000 0.002303 0.000668 0.003281 -1722 1 0.000253 1560.000000 -0.001503 0.000638 0.009729 -1723 1 0.000279 1560.000000 -0.000941 0.002000 0.007457 -1724 1 0.000199 1560.000000 -0.000945 0.003174 0.009302 -1725 1 0.000238 1560.000000 0.000839 -0.000588 0.007461 -1726 1 0.000199 1560.000000 0.002360 0.002881 0.005851 -1727 1 0.000243 1560.000000 0.002418 0.000593 0.009247 -1728 1 0.000243 1560.000000 -0.001073 -0.001088 0.006803 -1729 1 0.000225 1560.000000 -0.001026 0.001657 0.005858 -1730 1 0.000277 1560.000000 0.000265 0.001677 0.007728 -1731 1 0.000209 1560.000000 0.000182 -0.001342 0.005630 -1732 1 0.000276 1560.000000 0.002862 -0.001489 0.002907 -1733 1 0.000206 1560.000000 0.000500 -0.001791 0.009702 -1734 1 0.000248 1560.000000 0.001004 -0.001500 0.008292 -1735 1 0.000255 1560.000000 -0.000716 0.001798 0.004042 -1736 1 0.000196 1560.000000 0.000922 -0.002553 0.005206 -1737 1 0.000212 1560.000000 0.000676 -0.001901 0.000789 -1738 1 0.000193 1560.000000 0.001785 -0.000525 0.001814 -1739 1 0.000237 1560.000000 0.002555 -0.001502 0.001595 -1740 1 0.000217 1560.000000 0.000563 0.001617 0.009585 -1741 1 0.000193 1560.000000 0.002822 0.000516 0.009090 -1742 1 0.000206 1560.000000 -0.001431 -0.000623 0.006721 -1743 1 0.000195 1560.000000 0.002333 0.002212 0.008926 -1744 1 0.000251 1560.000000 0.000057 -0.000316 0.002404 -1745 1 0.000280 1560.000000 0.001238 -0.002594 0.003831 -1746 1 0.000199 1560.000000 -0.000511 -0.000032 0.008164 -1747 1 0.000213 1560.000000 0.000588 0.000915 0.009016 -1748 1 0.000243 1560.000000 -0.000760 -0.001171 0.001907 -1749 1 0.000245 1560.000000 0.003134 -0.002149 0.005287 -1750 1 0.000261 1560.000000 -0.002530 0.001887 0.003694 -1751 1 0.000223 1560.000000 -0.000381 -0.002910 0.009654 -1752 1 0.000279 1560.000000 -0.000794 -0.001427 0.001215 -1753 1 0.000254 1560.000000 -0.001654 0.000341 0.007609 -1754 1 0.000201 1560.000000 -0.000071 0.000442 0.004258 -1755 1 0.000228 1560.000000 -0.000514 0.002966 0.008489 -1756 1 0.000252 1560.000000 -0.000569 0.003511 0.006457 -1757 1 0.000248 1560.000000 -0.000743 -0.001524 0.004911 -1758 1 0.000197 1560.000000 0.000219 -0.000805 0.004406 -1759 1 0.000238 1560.000000 -0.001759 0.000917 0.002320 -1760 1 0.000207 1560.000000 0.001345 0.003068 0.001572 -1761 1 0.000194 1560.000000 0.000203 -0.000144 0.009674 -1762 1 0.000247 1560.000000 -0.000179 -0.000486 0.008496 -1763 1 0.000221 1560.000000 0.000368 0.000155 0.008339 -1764 1 0.000281 1560.000000 0.000747 0.002257 0.004791 -1765 1 0.000196 1560.000000 -0.001273 -0.000604 0.007943 -1766 1 0.000280 1560.000000 -0.002534 0.002283 0.000359 -1767 1 0.000282 1560.000000 -0.002909 -0.002247 0.001624 -1768 1 0.000204 1560.000000 0.002089 -0.002422 0.005225 -1769 1 0.000206 1560.000000 0.001407 0.003229 0.003776 -1770 1 0.000285 1560.000000 0.001984 -0.000892 0.005167 -1771 1 0.000237 1560.000000 -0.001830 -0.000557 0.003493 -1772 1 0.000202 1560.000000 -0.003352 0.001184 0.008480 -1773 1 0.000237 1560.000000 0.001600 -0.003160 0.001211 -1774 1 0.000266 1560.000000 0.002823 -0.000411 0.002531 -1775 1 0.000241 1560.000000 0.001270 -0.000999 0.008301 -1776 1 0.000223 1560.000000 -0.000010 0.002783 0.007145 -1777 1 0.000213 1560.000000 0.002506 0.000828 0.002811 -1778 1 0.000198 1560.000000 0.000923 0.003536 0.001981 -1779 1 0.000221 1560.000000 0.001525 0.002717 0.006184 -1780 1 0.000273 1560.000000 0.002601 0.001998 0.002277 -1781 1 0.000198 1560.000000 0.001944 0.003076 0.004476 -1782 1 0.000196 1560.000000 -0.002020 0.000419 0.004390 -1783 1 0.000283 1560.000000 0.003129 0.000479 0.009408 -1784 1 0.000255 1560.000000 0.000021 -0.000255 0.007707 -1785 1 0.000205 1560.000000 -0.000399 -0.000424 0.003706 -1786 1 0.000200 1560.000000 -0.003136 -0.001952 0.002072 -1787 1 0.000208 1560.000000 0.000290 0.001444 0.002143 -1788 1 0.000210 1560.000000 -0.001795 0.001802 0.001641 -1789 1 0.000217 1560.000000 0.001168 -0.002971 0.007500 -1790 1 0.000201 1560.000000 0.000005 0.000012 0.009492 -1791 1 0.000206 1560.000000 0.000534 0.000050 0.005915 -1792 1 0.000243 1560.000000 0.001981 0.000457 0.005739 -1793 1 0.000272 1560.000000 0.002424 0.002016 0.000143 -1794 1 0.000223 1560.000000 0.002881 -0.002537 0.001947 -1795 1 0.000211 1560.000000 -0.000801 -0.001166 0.007635 -1796 1 0.000260 1560.000000 0.002155 -0.000277 0.000209 -1797 1 0.000212 1560.000000 0.000037 0.001808 0.004993 -1798 1 0.000263 1560.000000 0.000003 -0.003296 0.006966 -1799 1 0.000251 1560.000000 -0.001914 0.003299 0.004116 -1800 1 0.000288 1560.000000 -0.000699 0.000693 0.001948 -1801 1 0.000219 1560.000000 0.001403 0.001554 0.004206 -1802 1 0.000220 1560.000000 0.000962 -0.000588 0.002654 -1803 1 0.000231 1560.000000 0.000643 0.002178 0.002043 -1804 1 0.000195 1560.000000 0.002485 -0.002509 0.001966 -1805 1 0.000203 1560.000000 0.000938 -0.001819 0.007681 -1806 1 0.000193 1560.000000 -0.001927 0.001031 0.009513 -1807 1 0.000220 1560.000000 0.002447 -0.001504 0.007169 -1808 1 0.000237 1560.000000 0.000319 0.003082 0.009237 -1809 1 0.000209 1560.000000 -0.003442 -0.000332 0.005391 -1810 1 0.000200 1560.000000 -0.000846 -0.001148 0.008679 -1811 1 0.000246 1560.000000 0.001951 0.002005 0.008343 -1812 1 0.000240 1560.000000 -0.000073 0.000244 0.004586 -1813 1 0.000205 1560.000000 -0.001385 0.000938 0.005770 -1814 1 0.000217 1560.000000 -0.000366 0.000116 0.006737 -1815 1 0.000251 1560.000000 -0.000217 0.000805 0.001520 -1816 1 0.000259 1560.000000 0.000155 0.000398 0.004439 -1817 1 0.000260 1560.000000 0.000142 0.000471 0.008780 -1818 1 0.000269 1560.000000 -0.001678 -0.000175 0.005862 -1819 1 0.000192 1560.000000 0.001828 -0.000846 0.004237 -1820 1 0.000198 1560.000000 -0.001014 0.001754 0.000282 -1821 1 0.000199 1560.000000 0.002010 -0.000260 0.004057 -1822 1 0.000239 1560.000000 0.002909 0.000243 0.009085 -1823 1 0.000249 1560.000000 -0.000878 0.002501 0.008608 -1824 1 0.000212 1560.000000 0.001430 -0.003457 0.004021 -1825 1 0.000198 1560.000000 -0.001991 -0.000698 0.008013 -1826 1 0.000199 1560.000000 0.000920 -0.000110 0.002397 -1827 1 0.000226 1560.000000 -0.000593 -0.000058 0.006496 -1828 1 0.000266 1560.000000 0.001001 -0.002289 0.003026 -1829 1 0.000224 1560.000000 -0.001151 -0.000551 0.003460 -1830 1 0.000230 1560.000000 0.000445 0.000323 0.009747 -1831 1 0.000213 1560.000000 0.002047 0.000729 0.009374 -1832 1 0.000196 1560.000000 0.000639 0.000881 0.003301 -1833 1 0.000221 1560.000000 -0.000558 -0.002068 0.007909 -1834 1 0.000203 1560.000000 0.000380 0.000367 0.007710 -1835 1 0.000200 1560.000000 0.000906 0.001760 0.009090 -1836 1 0.000255 1560.000000 0.001726 0.002566 0.004520 -1837 1 0.000193 1560.000000 -0.000124 -0.000265 0.000561 -1838 1 0.000212 1560.000000 0.001039 -0.002947 0.002313 -1839 1 0.000193 1560.000000 -0.000765 0.000182 0.001924 -1840 1 0.000213 1560.000000 0.001917 0.000775 0.008743 -1841 1 0.000243 1560.000000 0.002772 -0.002182 0.002470 -1842 1 0.000222 1560.000000 0.001824 0.000774 0.005961 -1843 1 0.000209 1560.000000 -0.001526 0.001600 0.009049 -1844 1 0.000236 1560.000000 -0.000553 0.003127 0.002285 -1845 1 0.000250 1560.000000 0.001528 0.001139 0.002085 -1846 1 0.000258 1560.000000 -0.000938 -0.000053 0.009166 -1847 1 0.000213 1560.000000 -0.000196 -0.001216 0.008165 -1848 1 0.000267 1560.000000 -0.000586 0.000124 0.005336 -1849 1 0.000209 1560.000000 0.001635 -0.003052 0.007770 -1850 1 0.000204 1560.000000 0.003129 -0.000105 0.003668 -1851 1 0.000220 1560.000000 0.000028 -0.000164 0.001921 -1852 1 0.000219 1560.000000 0.002253 -0.002090 0.009216 -1853 1 0.000199 1560.000000 0.002851 0.002558 0.001646 -1854 1 0.000279 1560.000000 -0.003383 0.000622 0.006652 -1855 1 0.000197 1560.000000 0.000782 -0.001764 0.001715 -1856 1 0.000225 1560.000000 0.002422 0.002205 0.005315 -1857 1 0.000225 1560.000000 -0.000161 0.002459 0.005178 -1858 1 0.000235 1560.000000 -0.001981 -0.001167 0.006282 -1859 1 0.000206 1560.000000 -0.001461 0.001548 0.004351 -1860 1 0.000221 1560.000000 0.002194 -0.000132 0.009304 -1861 1 0.000193 1560.000000 -0.000793 -0.003329 0.001557 -1862 1 0.000232 1560.000000 -0.001438 -0.002902 0.007177 -1863 1 0.000254 1560.000000 0.001671 0.002455 0.002730 -1864 1 0.000210 1560.000000 -0.000028 0.003598 0.005278 -1865 1 0.000205 1560.000000 -0.000366 0.000510 0.004294 -1866 1 0.000256 1560.000000 0.001708 0.000302 0.008022 -1867 1 0.000207 1560.000000 0.003051 0.002085 0.003333 -1868 1 0.000215 1560.000000 -0.000166 -0.002878 0.002141 -1869 1 0.000221 1560.000000 0.000545 0.002591 0.007375 -1870 1 0.000215 1560.000000 -0.000840 -0.001867 0.008597 -1871 1 0.000218 1560.000000 -0.000779 -0.000714 0.003895 -1872 1 0.000195 1560.000000 -0.002052 0.000813 0.001189 -1873 1 0.000280 1560.000000 -0.001331 0.000522 0.006838 -1874 1 0.000203 1560.000000 0.000650 0.000739 0.007008 -1875 1 0.000214 1560.000000 -0.000301 -0.000642 0.003972 -1876 1 0.000246 1560.000000 0.003223 0.000107 0.004305 -1877 1 0.000211 1560.000000 0.002667 0.002222 0.009648 -1878 1 0.000278 1560.000000 -0.001351 -0.002653 0.005329 -1879 1 0.000222 1560.000000 -0.003689 0.000997 0.004635 -1880 1 0.000210 1560.000000 -0.003129 0.002140 0.005373 -1881 1 0.000231 1560.000000 -0.001750 0.000125 0.001948 -1882 1 0.000217 1560.000000 0.001087 0.002322 0.000601 -1883 1 0.000284 1560.000000 0.002397 -0.000274 0.000476 -1884 1 0.000253 1560.000000 0.000085 -0.001497 0.004406 -1885 1 0.000262 1560.000000 -0.003726 -0.000991 0.004792 -1886 1 0.000261 1560.000000 0.001960 0.000872 0.005772 -1887 1 0.000264 1560.000000 0.001199 -0.002000 0.004024 -1888 1 0.000214 1560.000000 -0.000335 0.002833 0.006473 -1889 1 0.000206 1560.000000 -0.001619 0.003109 0.005672 -1890 1 0.000203 1560.000000 -0.001359 -0.000717 0.001517 -1891 1 0.000275 1560.000000 0.001479 0.001325 0.001807 -1892 1 0.000246 1560.000000 0.000056 0.002628 0.007520 -1893 1 0.000278 1560.000000 -0.001333 -0.002544 0.001004 -1894 1 0.000200 1560.000000 -0.000618 -0.003621 0.003685 -1895 1 0.000220 1560.000000 0.001222 -0.003236 0.002232 -1896 1 0.000193 1560.000000 -0.000422 -0.000537 0.008918 -1897 1 0.000220 1560.000000 0.000084 0.001448 0.007739 -1898 1 0.000225 1560.000000 -0.000718 0.000870 0.002974 -1899 1 0.000249 1560.000000 0.000714 0.001137 0.002436 -1900 1 0.000205 1560.000000 -0.002555 -0.000539 0.005873 -1901 1 0.000197 1560.000000 -0.001673 0.002478 0.002657 -1902 1 0.000282 1560.000000 -0.000050 -0.001815 0.004417 -1903 1 0.000243 1560.000000 0.000087 0.003027 0.006796 -1904 1 0.000218 1560.000000 -0.000226 0.000845 0.008010 -1905 1 0.000212 1560.000000 0.000170 -0.003780 0.009162 -1906 1 0.000244 1560.000000 -0.001003 -0.000986 0.000422 -1907 1 0.000271 1560.000000 0.001224 0.002925 0.009159 -1908 1 0.000228 1560.000000 0.000075 0.000109 0.000716 -1909 1 0.000200 1560.000000 0.001930 0.003190 0.000529 -1910 1 0.000246 1560.000000 -0.003764 0.000012 0.000848 -1911 1 0.000198 1560.000000 0.000462 -0.000036 0.001087 -1912 1 0.000213 1560.000000 -0.002459 0.001925 0.000207 -1913 1 0.000236 1560.000000 0.001886 -0.000082 0.008834 -1914 1 0.000253 1560.000000 0.000875 0.000756 0.007694 -1915 1 0.000288 1560.000000 0.002536 0.000052 0.009161 -1916 1 0.000201 1560.000000 -0.001367 0.000062 0.002149 -1917 1 0.000270 1560.000000 -0.000084 0.003222 0.000908 -1918 1 0.000261 1560.000000 -0.000102 0.001267 0.002408 -1919 1 0.000226 1560.000000 0.001376 0.002593 0.003738 -1920 1 0.000284 1560.000000 0.000094 -0.003101 0.003032 -1921 1 0.000286 1560.000000 -0.002568 0.000139 0.009815 -1922 1 0.000222 1560.000000 -0.002697 0.000754 0.002948 -1923 1 0.000240 1560.000000 -0.000268 0.003455 0.007945 -1924 1 0.000251 1560.000000 -0.001204 -0.000871 0.005552 -1925 1 0.000214 1560.000000 -0.000163 -0.001794 0.000511 -1926 1 0.000271 1560.000000 0.000363 -0.001890 0.009520 -1927 1 0.000230 1560.000000 0.002178 0.001554 0.007558 -1928 1 0.000216 1560.000000 -0.001281 -0.001046 0.009184 -1929 1 0.000216 1560.000000 -0.002125 0.001468 0.001045 -1930 1 0.000247 1560.000000 0.001616 -0.000610 0.003250 -1931 1 0.000208 1560.000000 0.000847 -0.000433 0.001510 -1932 1 0.000199 1560.000000 -0.002913 0.001619 0.001968 -1933 1 0.000256 1560.000000 0.000726 -0.000263 0.002543 -1934 1 0.000239 1560.000000 -0.000266 0.000017 0.002882 -1935 1 0.000207 1560.000000 0.002844 0.000231 0.007887 -1936 1 0.000201 1560.000000 0.000574 -0.000833 0.003150 -1937 1 0.000260 1560.000000 -0.000851 0.001222 0.007084 -1938 1 0.000243 1560.000000 -0.001442 0.002943 0.008710 -1939 1 0.000283 1560.000000 -0.000721 0.002752 0.008429 -1940 1 0.000233 1560.000000 0.002280 0.002590 0.001116 -1941 1 0.000262 1560.000000 -0.000106 0.000375 0.006722 -1942 1 0.000270 1560.000000 0.001048 0.002491 0.006353 -1943 1 0.000197 1560.000000 -0.001184 0.002016 0.007256 -1944 1 0.000195 1560.000000 0.000447 -0.000472 0.007652 -1945 1 0.000222 1560.000000 -0.000643 -0.001620 0.000585 -1946 1 0.000221 1560.000000 -0.000294 0.000273 0.008122 -1947 1 0.000243 1560.000000 -0.001763 0.000733 0.007904 -1948 1 0.000219 1560.000000 -0.000415 0.000706 0.007361 -1949 1 0.000276 1560.000000 -0.000871 -0.002879 0.005842 -1950 1 0.000205 1560.000000 -0.002558 -0.001558 0.004609 -1951 1 0.000245 1560.000000 -0.002045 -0.001836 0.003192 -1952 1 0.000219 1560.000000 -0.002913 0.000569 0.005952 -1953 1 0.000196 1560.000000 0.000457 -0.001071 0.005556 -1954 1 0.000209 1560.000000 -0.000990 0.000040 0.008044 -1955 1 0.000272 1560.000000 -0.002672 -0.002138 0.008172 -1956 1 0.000215 1560.000000 -0.000469 0.000230 0.008848 -1957 1 0.000198 1560.000000 -0.002453 -0.002289 0.005370 -1958 1 0.000211 1560.000000 0.003607 0.000011 0.009501 -1959 1 0.000238 1560.000000 0.001480 0.002871 0.000883 -1960 1 0.000197 1560.000000 -0.002910 -0.001727 0.008679 -1961 1 0.000260 1560.000000 0.003223 -0.000049 0.007185 -1962 1 0.000260 1560.000000 0.001190 -0.001806 0.005536 -1963 1 0.000265 1560.000000 -0.000306 0.000514 0.009235 -1964 1 0.000204 1560.000000 -0.000087 -0.000067 0.002475 -1965 1 0.000234 1560.000000 -0.002759 0.001383 0.002426 -1966 1 0.000203 1560.000000 -0.001463 -0.000056 0.003123 -1967 1 0.000203 1560.000000 0.001133 0.002821 0.004956 -1968 1 0.000207 1560.000000 -0.001097 -0.003271 0.007166 -1969 1 0.000279 1560.000000 0.001242 -0.002701 0.002458 -1970 1 0.000261 1560.000000 -0.002007 0.002893 0.004179 -1971 1 0.000211 1560.000000 -0.001424 -0.001689 0.003971 -1972 1 0.000238 1560.000000 -0.002483 -0.001492 0.008836 -1973 1 0.000202 1560.000000 -0.001623 -0.000428 0.000111 -1974 1 0.000212 1560.000000 -0.000593 -0.002663 0.000812 -1975 1 0.000265 1560.000000 0.000761 0.002958 0.006738 -1976 1 0.000210 1560.000000 -0.001505 0.001972 0.008322 -1977 1 0.000207 1560.000000 0.001462 -0.000910 0.005803 -1978 1 0.000214 1560.000000 0.003084 -0.000070 0.002630 -1979 1 0.000193 1560.000000 -0.000518 -0.000422 0.006150 -1980 1 0.000238 1560.000000 0.000606 0.002573 0.003870 -1981 1 0.000262 1560.000000 -0.001869 -0.001492 0.001924 -1982 1 0.000205 1560.000000 0.003112 -0.000182 0.003348 -1983 1 0.000250 1560.000000 0.001292 0.002725 0.002739 -1984 1 0.000279 1560.000000 -0.003127 0.000030 0.009752 -1985 1 0.000286 1560.000000 0.002791 0.000408 0.005072 -1986 1 0.000215 1560.000000 0.000053 0.001212 0.006665 -1987 1 0.000225 1560.000000 0.000041 -0.001741 0.001144 -1988 1 0.000219 1560.000000 0.001934 0.002481 0.003820 -1989 1 0.000270 1560.000000 -0.002640 0.002082 0.007338 -1990 1 0.000227 1560.000000 0.002506 0.001732 0.006631 -1991 1 0.000238 1560.000000 -0.000049 0.000337 0.007474 -1992 1 0.000238 1560.000000 0.001629 -0.001394 0.003826 -1993 1 0.000235 1560.000000 -0.001879 -0.000807 0.000201 -1994 1 0.000277 1560.000000 0.000324 0.000738 0.008720 -1995 1 0.000268 1560.000000 0.001515 -0.001333 0.005384 -1996 1 0.000198 1560.000000 -0.000532 -0.000308 0.002946 -1997 1 0.000243 1560.000000 -0.002483 -0.000332 0.007016 -1998 1 0.000278 1560.000000 0.000627 -0.003138 0.002081 -1999 1 0.000201 1560.000000 0.002513 -0.001981 0.004626 -2000 1 0.000220 1560.000000 -0.001012 -0.000916 0.000735 -2001 1 0.000282 1560.000000 0.001187 -0.000926 0.003510 -2002 1 0.000256 1560.000000 0.000513 -0.002184 0.003882 -2003 1 0.000215 1560.000000 -0.000454 0.000939 0.000832 -2004 1 0.000204 1560.000000 0.001953 -0.003276 0.001965 -2005 1 0.000224 1560.000000 0.000174 -0.000617 0.002565 -2006 1 0.000262 1560.000000 -0.003621 0.000501 0.003286 -2007 1 0.000229 1560.000000 0.000226 0.000800 0.009346 -2008 1 0.000199 1560.000000 -0.001259 -0.001684 0.008904 -2009 1 0.000209 1560.000000 -0.000981 0.000552 0.002657 -2010 1 0.000194 1560.000000 -0.000362 -0.001209 0.005023 -2011 1 0.000192 1560.000000 0.000130 0.001074 0.005119 -2012 1 0.000238 1560.000000 0.001540 -0.000093 0.007528 -2013 1 0.000218 1560.000000 0.000035 -0.002035 0.007075 -2014 1 0.000200 1560.000000 0.003499 -0.000572 0.004008 -2015 1 0.000276 1560.000000 0.001831 0.002251 0.009015 -2016 1 0.000200 1560.000000 -0.000602 -0.000334 0.000843 -2017 1 0.000202 1560.000000 -0.001483 0.002910 0.009201 -2018 1 0.000202 1560.000000 -0.001938 -0.000053 0.006191 -2019 1 0.000203 1560.000000 -0.002454 -0.000266 0.004641 -2020 1 0.000240 1560.000000 -0.000469 -0.000390 0.002017 -2021 1 0.000228 1560.000000 0.002468 -0.000486 0.002841 -2022 1 0.000205 1560.000000 -0.000246 0.003265 0.009420 -2023 1 0.000265 1560.000000 0.003129 -0.001040 0.008141 -2024 1 0.000250 1560.000000 -0.000300 0.001066 0.000487 -2025 1 0.000207 1560.000000 0.000723 0.002724 0.005258 -2026 1 0.000207 1560.000000 -0.000307 -0.000383 0.008841 -2027 1 0.000261 1560.000000 -0.000625 -0.002835 0.005671 -2028 1 0.000214 1560.000000 -0.002209 -0.001808 0.000979 -2029 1 0.000200 1560.000000 -0.002711 -0.000629 0.000264 -2030 1 0.000202 1560.000000 -0.000780 -0.001322 0.006675 -2031 1 0.000275 1560.000000 -0.000696 -0.001075 0.001146 -2032 1 0.000240 1560.000000 -0.002885 -0.001283 0.000526 -2033 1 0.000253 1560.000000 0.001084 0.000444 0.007538 -2034 1 0.000266 1560.000000 -0.000174 0.000251 0.001689 -2035 1 0.000209 1560.000000 -0.000652 0.003673 0.003351 -2036 1 0.000202 1560.000000 -0.000858 -0.002672 0.005359 -2037 1 0.000214 1560.000000 0.000489 0.000110 0.002200 -2038 1 0.000220 1560.000000 -0.003461 -0.001112 0.007962 -2039 1 0.000227 1560.000000 0.001646 -0.001322 0.003411 -2040 1 0.000207 1560.000000 0.001576 -0.001526 0.009450 -2041 1 0.000195 1560.000000 -0.002218 -0.001350 0.003017 -2042 1 0.000237 1560.000000 0.001027 0.002198 0.005091 -2043 1 0.000240 1560.000000 0.002351 0.002638 0.003859 -2044 1 0.000224 1560.000000 -0.000843 -0.001309 0.008864 -2045 1 0.000276 1560.000000 0.000228 0.000126 0.008017 -2046 1 0.000212 1560.000000 0.000560 0.000187 0.003565 -2047 1 0.000225 1560.000000 0.002222 0.002085 0.006101 -2048 1 0.000227 1560.000000 -0.000656 0.000664 0.005795 -2049 1 0.000231 1560.000000 0.002112 0.000106 0.004114 -2050 1 0.000196 1560.000000 0.001117 0.000102 0.004311 -2051 1 0.000229 1560.000000 -0.000803 -0.002572 0.000325 -2052 1 0.000215 1560.000000 0.000402 -0.002056 0.000870 -2053 1 0.000194 1560.000000 0.000552 -0.002466 0.000171 -2054 1 0.000216 1560.000000 0.000842 0.000757 0.001462 -2055 1 0.000223 1560.000000 0.000453 0.001545 0.005214 -2056 1 0.000206 1560.000000 0.000308 0.000238 0.006781 -2057 1 0.000200 1560.000000 0.000711 0.000928 0.003494 -2058 1 0.000209 1560.000000 0.001919 0.001072 0.008726 -2059 1 0.000216 1560.000000 0.000672 0.000288 0.006840 -2060 1 0.000223 1560.000000 -0.001095 -0.002188 0.003897 -2061 1 0.000224 1560.000000 -0.003590 0.001140 0.000533 -2062 1 0.000198 1560.000000 0.003509 0.000585 0.005063 -2063 1 0.000196 1560.000000 -0.002622 -0.002457 0.003811 -2064 1 0.000208 1560.000000 0.001561 -0.001696 0.004015 -2065 1 0.000271 1560.000000 0.003673 -0.000027 0.000341 -2066 1 0.000242 1560.000000 -0.000490 0.002125 0.006935 -2067 1 0.000215 1560.000000 0.000832 -0.000154 0.000518 -2068 1 0.000236 1560.000000 0.003501 0.000939 0.009713 -2069 1 0.000280 1560.000000 -0.000320 -0.000830 0.008842 -2070 1 0.000248 1560.000000 0.000513 0.000327 0.003107 -2071 1 0.000280 1560.000000 0.003069 -0.000132 0.008970 -2072 1 0.000267 1560.000000 -0.001132 -0.001985 0.007036 -2073 1 0.000238 1560.000000 -0.001774 0.002346 0.008664 -2074 1 0.000232 1560.000000 0.002557 0.002458 0.001913 -2075 1 0.000209 1560.000000 -0.000280 -0.002287 0.003058 -2076 1 0.000201 1560.000000 -0.003571 -0.001067 0.007465 -2077 1 0.000228 1560.000000 -0.003172 -0.000267 0.003563 -2078 1 0.000204 1560.000000 -0.002451 0.002186 0.002881 -2079 1 0.000232 1560.000000 0.001735 0.002815 0.007820 -2080 1 0.000243 1560.000000 0.002046 0.000007 0.001372 -2081 1 0.000278 1560.000000 -0.001598 0.000944 0.001290 -2082 1 0.000205 1560.000000 -0.001799 -0.000026 0.006447 -2083 1 0.000230 1560.000000 -0.000482 0.000493 0.002055 -2084 1 0.000211 1560.000000 0.001568 -0.003456 0.003358 -2085 1 0.000233 1560.000000 0.000552 0.002926 0.009471 -2086 1 0.000205 1560.000000 -0.002174 -0.000567 0.007916 -2087 1 0.000239 1560.000000 -0.001230 -0.001956 0.000513 -2088 1 0.000234 1560.000000 -0.002847 -0.000327 0.001269 -2089 1 0.000236 1560.000000 0.003445 -0.000465 0.003305 -2090 1 0.000196 1560.000000 0.000494 -0.002480 0.003441 -2091 1 0.000201 1560.000000 0.000854 -0.003116 0.006062 -2092 1 0.000198 1560.000000 0.001656 -0.003407 0.005400 -2093 1 0.000218 1560.000000 -0.001596 0.000926 0.004291 -2094 1 0.000268 1560.000000 0.001808 0.002005 0.001188 -2095 1 0.000267 1560.000000 -0.002239 0.002719 0.007947 -2096 1 0.000243 1560.000000 -0.001418 -0.001698 0.006307 -2097 1 0.000224 1560.000000 -0.001365 0.001049 0.006047 -2098 1 0.000241 1560.000000 0.000474 0.000605 0.005046 -2099 1 0.000211 1560.000000 0.000970 0.000188 0.003271 -2100 1 0.000195 1560.000000 0.001280 -0.002761 0.006830 -2101 1 0.000197 1560.000000 -0.003240 0.001900 0.006045 -2102 1 0.000204 1560.000000 -0.000437 -0.000057 0.007861 -2103 1 0.000253 1560.000000 -0.003317 -0.000094 0.005914 -2104 1 0.000249 1560.000000 -0.000542 0.003328 0.002096 -2105 1 0.000205 1560.000000 -0.000450 -0.000863 0.005006 -2106 1 0.000205 1560.000000 -0.001750 -0.000039 0.003230 -2107 1 0.000237 1560.000000 0.002386 -0.001488 0.000756 -2108 1 0.000210 1560.000000 -0.000611 -0.001751 0.004861 -2109 1 0.000271 1560.000000 -0.002088 -0.000722 0.001471 -2110 1 0.000197 1560.000000 0.002968 0.001617 0.004942 -2111 1 0.000203 1560.000000 0.000350 0.001267 0.001115 -2112 1 0.000204 1560.000000 -0.002938 -0.002055 0.007912 -2113 1 0.000244 1560.000000 -0.000444 0.002750 0.009090 -2114 1 0.000230 1560.000000 0.000762 0.003264 0.002564 -2115 1 0.000238 1560.000000 0.001427 -0.003494 0.008468 -2116 1 0.000226 1560.000000 -0.001742 -0.002856 0.003686 -2117 1 0.000276 1560.000000 -0.000543 -0.000258 0.007563 -2118 1 0.000238 1560.000000 -0.000650 -0.000998 0.008024 -2119 1 0.000264 1560.000000 0.002522 -0.002766 0.005054 -2120 1 0.000235 1560.000000 0.001914 -0.002840 0.009359 -2121 1 0.000215 1560.000000 0.002726 -0.000749 0.004781 -2122 1 0.000219 1560.000000 -0.001827 -0.000404 0.006983 -2123 1 0.000194 1560.000000 -0.001571 0.000177 0.003314 -2124 1 0.000217 1560.000000 0.002429 0.000709 0.002460 -2125 1 0.000193 1560.000000 -0.000117 0.003462 0.002624 -2126 1 0.000271 1560.000000 0.002073 -0.002471 0.002677 -2127 1 0.000283 1560.000000 -0.001428 -0.001546 0.008739 -2128 1 0.000193 1560.000000 -0.000119 0.000537 0.001551 -2129 1 0.000239 1560.000000 0.000977 -0.000758 0.007972 -2130 1 0.000226 1560.000000 0.000555 0.000245 0.009542 -2131 1 0.000283 1560.000000 0.000767 0.000841 0.007384 -2132 1 0.000232 1560.000000 0.000943 -0.002422 0.003702 -2133 1 0.000218 1560.000000 0.000432 0.003686 0.006694 -2134 1 0.000232 1560.000000 -0.000713 0.001586 0.004659 -2135 1 0.000224 1560.000000 0.000565 0.001799 0.009095 -2136 1 0.000195 1560.000000 -0.002430 0.000449 0.003937 -2137 1 0.000214 1560.000000 -0.000010 0.000162 0.002992 -2138 1 0.000211 1560.000000 -0.000506 -0.000960 0.000608 -2139 1 0.000215 1560.000000 0.002762 -0.000161 0.008519 -2140 1 0.000269 1560.000000 -0.000405 0.003025 0.004477 -2141 1 0.000255 1560.000000 -0.000816 -0.002241 0.000231 -2142 1 0.000222 1560.000000 -0.000251 -0.000483 0.009588 -2143 1 0.000206 1560.000000 0.001536 0.001430 0.001261 -2144 1 0.000209 1560.000000 0.001137 -0.003200 0.001366 -2145 1 0.000233 1560.000000 -0.001395 0.001795 0.007307 -2146 1 0.000206 1560.000000 0.000349 -0.003543 0.009071 -2147 1 0.000242 1560.000000 0.000719 0.002869 0.004588 -2148 1 0.000255 1560.000000 -0.000213 -0.001602 0.006231 -2149 1 0.000250 1560.000000 0.001513 0.001513 0.002612 -2150 1 0.000224 1560.000000 -0.002777 0.002228 0.008554 -2151 1 0.000196 1560.000000 -0.001643 0.000953 0.006717 -2152 1 0.000286 1560.000000 0.001339 -0.001639 0.003793 -2153 1 0.000230 1560.000000 -0.000454 0.000263 0.007617 -2154 1 0.000208 1560.000000 -0.000340 -0.001124 0.005695 -2155 1 0.000278 1560.000000 -0.001479 0.001550 0.002056 -2156 1 0.000224 1560.000000 -0.001483 0.002005 0.005047 -2157 1 0.000241 1560.000000 0.003128 0.000278 0.008911 -2158 1 0.000194 1560.000000 0.000784 -0.001220 0.002554 -2159 1 0.000218 1560.000000 -0.002552 -0.001778 0.009463 -2160 1 0.000242 1560.000000 -0.002196 -0.000764 0.008780 -2161 1 0.000205 1560.000000 -0.001140 -0.001318 0.006315 -2162 1 0.000265 1560.000000 -0.002916 0.001937 0.001426 -2163 1 0.000235 1560.000000 -0.002227 -0.000990 0.004380 -2164 1 0.000268 1560.000000 0.002561 0.000989 0.005295 -2165 1 0.000194 1560.000000 -0.000323 -0.000045 0.006008 -2166 1 0.000227 1560.000000 -0.002531 -0.000992 0.005200 -2167 1 0.000210 1560.000000 -0.003155 0.000424 0.002529 -2168 1 0.000265 1560.000000 -0.001394 -0.001267 0.006432 -2169 1 0.000209 1560.000000 -0.000158 0.000026 0.003702 -2170 1 0.000214 1560.000000 -0.000341 0.000174 0.003119 -2171 1 0.000251 1560.000000 -0.001871 -0.000024 0.007133 -2172 1 0.000192 1560.000000 -0.001112 0.003567 0.008364 -2173 1 0.000220 1560.000000 0.000901 0.000684 0.002307 -2174 1 0.000198 1560.000000 0.001524 -0.003160 0.004473 -2175 1 0.000207 1560.000000 -0.001825 -0.002326 0.005851 -2176 1 0.000237 1560.000000 0.000097 0.002843 0.006178 -2177 1 0.000250 1560.000000 0.000384 0.001475 0.002978 -2178 1 0.000196 1560.000000 0.000618 0.000738 0.006582 -2179 1 0.000205 1560.000000 -0.003385 0.000386 0.004757 -2180 1 0.000249 1560.000000 0.000743 -0.000312 0.008368 -2181 1 0.000283 1560.000000 -0.000030 -0.001282 0.007342 -2182 1 0.000249 1560.000000 -0.001501 -0.001070 0.000579 -2183 1 0.000270 1560.000000 -0.000243 0.000446 0.003674 -2184 1 0.000194 1560.000000 0.002240 -0.001132 0.006665 -2185 1 0.000236 1560.000000 0.000339 0.001402 0.005648 -2186 1 0.000256 1560.000000 -0.000445 -0.001055 0.009038 -2187 1 0.000275 1560.000000 -0.000907 0.001515 0.003882 -2188 1 0.000226 1560.000000 -0.001574 -0.002960 0.001054 -2189 1 0.000240 1560.000000 0.000993 0.001508 0.001708 -2190 1 0.000232 1560.000000 0.002445 -0.001351 0.004637 -2191 1 0.000228 1560.000000 -0.000234 0.003262 0.004695 -2192 1 0.000193 1560.000000 -0.003006 -0.000955 0.002353 -2193 1 0.000225 1560.000000 0.001522 -0.001350 0.006644 -2194 1 0.000208 1560.000000 -0.000317 -0.002308 0.002821 -2195 1 0.000237 1560.000000 0.000658 0.003218 0.007044 -2196 1 0.000230 1560.000000 -0.000275 0.001111 0.009607 -2197 1 0.000229 1560.000000 0.001333 -0.001189 0.003726 -2198 1 0.000271 1560.000000 0.002759 -0.000296 0.007934 -2199 1 0.000225 1560.000000 0.000810 0.000937 0.008683 -2200 1 0.000242 1560.000000 0.001171 0.001614 0.001352 -2201 1 0.000194 1560.000000 0.000418 -0.001362 0.003162 -2202 1 0.000228 1560.000000 0.001266 -0.003353 0.000878 -2203 1 0.000255 1560.000000 0.000941 -0.000170 0.007031 -2204 1 0.000233 1560.000000 -0.000233 -0.003195 0.000260 -2205 1 0.000213 1560.000000 0.001451 0.002660 0.004700 -2206 1 0.000225 1560.000000 0.002510 0.001749 0.006037 -2207 1 0.000230 1560.000000 -0.002282 0.000837 0.005129 -2208 1 0.000227 1560.000000 0.000999 -0.000216 0.009067 -2209 1 0.000247 1560.000000 -0.002655 -0.001247 0.005776 -2210 1 0.000243 1560.000000 0.000964 0.002630 0.008371 -2211 1 0.000223 1560.000000 0.000385 -0.000001 0.007269 -2212 1 0.000219 1560.000000 0.001444 -0.000773 0.001818 -2213 1 0.000239 1560.000000 -0.000857 -0.003574 0.001371 -2214 1 0.000281 1560.000000 -0.000858 0.002729 0.002728 -2215 1 0.000197 1560.000000 0.000355 -0.000355 0.003906 -2216 1 0.000209 1560.000000 -0.000788 0.000429 0.008232 -2217 1 0.000264 1560.000000 0.003162 0.000882 0.001916 -2218 1 0.000235 1560.000000 -0.002644 -0.000004 0.009536 -2219 1 0.000209 1560.000000 -0.000050 -0.001177 0.000601 -2220 1 0.000218 1560.000000 -0.002620 0.001748 0.007820 -2221 1 0.000242 1560.000000 -0.000512 0.002251 0.006633 -2222 1 0.000193 1560.000000 0.000292 0.000381 0.009537 -2223 1 0.000204 1560.000000 -0.002680 0.001348 0.007651 -2224 1 0.000281 1560.000000 -0.000497 0.000770 0.003842 -2225 1 0.000197 1560.000000 0.001295 -0.000407 0.007982 -2226 1 0.000265 1560.000000 0.001512 -0.002927 0.006577 -2227 1 0.000193 1560.000000 0.001517 0.000458 0.009055 -2228 1 0.000210 1560.000000 0.000869 -0.002408 0.007891 -2229 1 0.000244 1560.000000 -0.000240 -0.000714 0.005318 -2230 1 0.000242 1560.000000 -0.000953 -0.001282 0.000802 -2231 1 0.000218 1560.000000 -0.002944 0.001081 0.000161 -2232 1 0.000259 1560.000000 0.000090 0.003055 0.002872 -2233 1 0.000211 1560.000000 -0.000211 0.002384 0.002286 -2234 1 0.000198 1560.000000 -0.002090 0.002962 0.001205 -2235 1 0.000206 1560.000000 -0.001946 0.000673 0.009156 -2236 1 0.000212 1560.000000 0.000359 -0.001154 0.005987 -2237 1 0.000215 1560.000000 0.000084 0.001060 0.004847 -2238 1 0.000208 1560.000000 0.002576 0.000777 0.003411 -2239 1 0.000245 1560.000000 -0.002502 0.002930 0.004837 -2240 1 0.000227 1560.000000 -0.001786 0.000418 0.001637 -2241 1 0.000230 1560.000000 0.000017 0.000177 0.005733 -2242 1 0.000194 1560.000000 0.000481 0.001386 0.003695 -2243 1 0.000267 1560.000000 0.000859 -0.000948 0.009033 -2244 1 0.000228 1560.000000 0.000130 -0.001251 0.001445 -2245 1 0.000257 1560.000000 0.002655 0.000441 0.002916 -2246 1 0.000193 1560.000000 -0.001089 -0.000725 0.003701 -2247 1 0.000263 1560.000000 -0.000654 -0.000151 0.000352 -2248 1 0.000249 1560.000000 -0.001680 -0.000628 0.004121 -2249 1 0.000220 1560.000000 0.000318 -0.001292 0.001229 -2250 1 0.000208 1560.000000 -0.001050 -0.001498 0.006133 -2251 1 0.000241 1560.000000 0.002752 -0.000508 0.003218 -2252 1 0.000222 1560.000000 0.001980 0.001273 0.002013 -2253 1 0.000225 1560.000000 0.000217 0.000584 0.003719 -2254 1 0.000265 1560.000000 0.002902 0.001506 0.002939 -2255 1 0.000229 1560.000000 -0.000394 -0.000812 0.007412 -2256 1 0.000200 1560.000000 -0.000299 -0.000695 0.002654 -2257 1 0.000250 1560.000000 0.002524 0.001228 0.007034 -2258 1 0.000262 1560.000000 0.002807 0.000780 0.002755 -2259 1 0.000217 1560.000000 0.002018 -0.001034 0.008057 -2260 1 0.000196 1560.000000 0.000880 -0.002827 0.002841 -2261 1 0.000259 1560.000000 0.001781 -0.003138 0.004890 -2262 1 0.000242 1560.000000 0.000641 -0.001662 0.006750 -2263 1 0.000250 1560.000000 0.000884 -0.001110 0.007188 -2264 1 0.000250 1560.000000 0.001267 -0.001148 0.004247 -2265 1 0.000245 1560.000000 -0.000267 -0.001935 0.008523 -2266 1 0.000236 1560.000000 -0.002041 -0.003119 0.000466 -2267 1 0.000196 1560.000000 -0.001048 0.003580 0.004076 -2268 1 0.000253 1560.000000 0.001300 0.002994 0.009557 -2269 1 0.000221 1560.000000 -0.000053 -0.000742 0.007364 -2270 1 0.000241 1560.000000 0.000269 0.003494 0.009433 -2271 1 0.000280 1560.000000 -0.000164 -0.003377 0.004836 -2272 1 0.000206 1560.000000 -0.002120 0.001358 0.008947 -2273 1 0.000200 1560.000000 0.002728 0.001730 0.006272 -2274 1 0.000208 1560.000000 0.003142 0.001416 0.000610 -2275 1 0.000198 1560.000000 -0.001107 0.000143 0.005608 -2276 1 0.000217 1560.000000 -0.001149 0.003594 0.003457 -2277 1 0.000193 1560.000000 -0.001354 0.001623 0.009185 -2278 1 0.000212 1560.000000 -0.000876 0.000459 0.002839 -2279 1 0.000268 1560.000000 -0.000132 -0.003154 0.002698 -2280 1 0.000194 1560.000000 -0.000125 -0.002522 0.005153 -2281 1 0.000209 1560.000000 -0.003703 0.000657 0.007386 -2282 1 0.000243 1560.000000 0.001782 0.000330 0.005378 -2283 1 0.000212 1560.000000 -0.000042 0.000345 0.002023 -2284 1 0.000243 1560.000000 0.000794 0.000557 0.007949 -2285 1 0.000244 1560.000000 0.001555 -0.001163 0.008721 -2286 1 0.000271 1560.000000 -0.001025 -0.003404 0.001268 -2287 1 0.000279 1560.000000 -0.001721 -0.000129 0.004678 -2288 1 0.000196 1560.000000 -0.001292 0.003464 0.004668 -2289 1 0.000227 1560.000000 -0.003387 0.000313 0.006229 -2290 1 0.000206 1560.000000 -0.002122 0.001291 0.002124 -2291 1 0.000228 1560.000000 -0.000755 0.001988 0.009379 -2292 1 0.000249 1560.000000 -0.001318 -0.000310 0.005418 -2293 1 0.000194 1560.000000 -0.000259 0.001025 0.005272 -2294 1 0.000229 1560.000000 -0.000434 -0.000378 0.002308 -2295 1 0.000222 1560.000000 0.002015 0.003272 0.006211 -2296 1 0.000282 1560.000000 -0.001776 -0.001154 0.007841 -2297 1 0.000212 1560.000000 -0.000698 0.000457 0.004819 -2298 1 0.000279 1560.000000 0.001092 0.002934 0.004169 -2299 1 0.000244 1560.000000 0.000927 -0.001080 0.005123 -2300 1 0.000211 1560.000000 -0.002201 0.000218 0.000315 -2301 1 0.000277 1560.000000 -0.001129 -0.001292 0.004338 -2302 1 0.000249 1560.000000 -0.001140 -0.001094 0.003309 -2303 1 0.000247 1560.000000 -0.001649 -0.001383 0.003858 -2304 1 0.000208 1560.000000 0.002708 0.000266 0.007524 -2305 1 0.000256 1560.000000 0.002515 -0.000981 0.003075 -2306 1 0.000277 1560.000000 -0.001225 0.000515 0.005302 -2307 1 0.000266 1560.000000 0.001846 -0.003273 0.000816 -2308 1 0.000201 1560.000000 -0.000948 0.000856 0.005386 -2309 1 0.000236 1560.000000 0.000274 -0.001391 0.000702 -2310 1 0.000203 1560.000000 0.001509 0.000267 0.004038 -2311 1 0.000204 1560.000000 -0.002683 0.000439 0.008486 -2312 1 0.000225 1560.000000 0.002250 0.001821 0.000793 -2313 1 0.000208 1560.000000 0.002537 0.001590 0.003967 -2314 1 0.000258 1560.000000 -0.001004 -0.002259 0.005466 -2315 1 0.000204 1560.000000 0.003205 -0.000274 0.002102 -2316 1 0.000232 1560.000000 0.000606 0.003031 0.007972 -2317 1 0.000193 1560.000000 -0.001447 -0.000966 0.002857 -2318 1 0.000252 1560.000000 -0.001125 -0.002910 0.005681 -2319 1 0.000195 1560.000000 0.000668 -0.001534 0.001634 -2320 1 0.000195 1560.000000 -0.000673 0.000502 0.005493 -2321 1 0.000192 1560.000000 -0.000755 -0.000189 0.005535 -2322 1 0.000198 1560.000000 -0.000278 0.001001 0.004898 -2323 1 0.000215 1560.000000 0.000918 0.001462 0.000376 -2324 1 0.000192 1560.000000 0.000950 -0.000796 0.001278 -2325 1 0.000282 1560.000000 -0.000184 -0.002757 0.003716 -2326 1 0.000218 1560.000000 0.001798 -0.000647 0.004578 -2327 1 0.000218 1560.000000 -0.001709 -0.001505 0.001232 -2328 1 0.000201 1560.000000 -0.002057 -0.000699 0.003607 -2329 1 0.000259 1560.000000 0.001840 -0.000891 0.000596 -2330 1 0.000221 1560.000000 0.000628 0.000130 0.005144 -2331 1 0.000193 1560.000000 0.001445 0.001247 0.005282 -2332 1 0.000260 1560.000000 -0.000742 0.003274 0.001367 -2333 1 0.000219 1560.000000 0.000275 0.000166 0.005862 -2334 1 0.000240 1560.000000 -0.000017 -0.000107 0.001189 -2335 1 0.000193 1560.000000 -0.000895 -0.000031 0.005656 -2336 1 0.000211 1560.000000 -0.003564 0.000359 0.000817 -2337 1 0.000200 1560.000000 0.003650 0.000687 0.009767 -2338 1 0.000211 1560.000000 0.000514 0.001903 0.002710 -2339 1 0.000221 1560.000000 0.002787 0.000874 0.008824 -2340 1 0.000197 1560.000000 0.000920 -0.000061 0.005514 -2341 1 0.000198 1560.000000 -0.000252 0.002333 0.002501 -2342 1 0.000213 1560.000000 -0.002949 -0.000746 0.001998 -2343 1 0.000210 1560.000000 0.000220 0.002125 0.000167 -2344 1 0.000243 1560.000000 0.002084 -0.002139 0.005287 -2345 1 0.000221 1560.000000 0.001709 0.001038 0.007462 -2346 1 0.000276 1560.000000 0.001127 -0.000611 0.001021 -2347 1 0.000220 1560.000000 0.000562 0.001581 0.004507 -2348 1 0.000267 1560.000000 0.003201 0.001401 0.003566 -2349 1 0.000203 1560.000000 -0.003332 0.001077 0.000185 -2350 1 0.000247 1560.000000 -0.000752 0.001138 0.004461 -2351 1 0.000267 1560.000000 -0.001883 0.000907 0.000969 -2352 1 0.000248 1560.000000 0.001329 -0.001091 0.000962 -2353 1 0.000214 1560.000000 -0.000529 0.001729 0.007191 -2354 1 0.000279 1560.000000 0.000606 -0.000643 0.002265 -2355 1 0.000194 1560.000000 0.001007 0.001755 0.001625 -2356 1 0.000230 1560.000000 -0.003579 0.000632 0.004604 -2357 1 0.000211 1560.000000 -0.001197 -0.000670 0.001976 -2358 1 0.000233 1560.000000 0.001476 0.000017 0.002899 -2359 1 0.000211 1560.000000 0.000935 0.002800 0.005109 -2360 1 0.000248 1560.000000 -0.001261 0.001332 0.000804 -2361 1 0.000244 1560.000000 -0.002641 0.000894 0.003591 -2362 1 0.000199 1560.000000 -0.000842 -0.002169 0.004751 -2363 1 0.000207 1560.000000 0.001295 -0.000177 0.000403 -2364 1 0.000209 1560.000000 -0.000616 -0.000352 0.008985 -2365 1 0.000199 1560.000000 -0.002158 -0.001212 0.001471 -2366 1 0.000199 1560.000000 -0.003308 0.001022 0.005387 -2367 1 0.000218 1560.000000 -0.001962 0.001960 0.001549 -2368 1 0.000207 1560.000000 0.000470 -0.000397 0.004988 -2369 1 0.000200 1560.000000 0.001181 -0.002052 0.009136 -2370 1 0.000218 1560.000000 0.001638 -0.000145 0.002882 -2371 1 0.000193 1560.000000 -0.003617 -0.000829 0.006062 -2372 1 0.000237 1560.000000 -0.000047 -0.001636 0.001416 -2373 1 0.000216 1560.000000 0.002188 -0.002307 0.008943 -2374 1 0.000228 1560.000000 -0.001821 0.002589 0.006060 -2375 1 0.000205 1560.000000 -0.001379 -0.003109 0.009049 -2376 1 0.000212 1560.000000 0.000449 0.001306 0.002821 -2377 1 0.000229 1560.000000 -0.003452 0.000151 0.000318 -2378 1 0.000219 1560.000000 0.000507 -0.001773 0.003989 -2379 1 0.000245 1560.000000 0.000425 0.002681 0.000280 -2380 1 0.000285 1560.000000 0.000533 0.001397 0.007239 -2381 1 0.000244 1560.000000 0.000948 -0.002915 0.007008 -2382 1 0.000203 1560.000000 -0.000579 -0.002655 0.009459 -2383 1 0.000232 1560.000000 -0.000230 -0.001961 0.007423 -2384 1 0.000221 1560.000000 -0.002720 0.000019 0.004548 -2385 1 0.000202 1560.000000 -0.002201 -0.000037 0.005825 -2386 1 0.000195 1560.000000 0.000797 0.000334 0.000526 -2387 1 0.000241 1560.000000 -0.001025 0.002711 0.008299 -2388 1 0.000208 1560.000000 0.002025 0.001482 0.007815 -2389 1 0.000203 1560.000000 0.000457 0.002278 0.006995 -2390 1 0.000240 1560.000000 0.000584 0.000386 0.006437 -2391 1 0.000212 1560.000000 0.001024 0.002682 0.002112 -2392 1 0.000201 1560.000000 -0.003031 0.000776 0.003798 -2393 1 0.000236 1560.000000 0.002672 -0.001437 0.006717 -2394 1 0.000199 1560.000000 0.002662 0.001432 0.008768 -2395 1 0.000219 1560.000000 -0.001207 -0.000829 0.002202 -2396 1 0.000258 1560.000000 0.002204 0.001136 0.005226 -2397 1 0.000229 1560.000000 0.001595 -0.003308 0.000394 -2398 1 0.000241 1560.000000 -0.001427 0.002482 0.007651 -2399 1 0.000287 1560.000000 0.000389 -0.001263 0.008293 -2400 1 0.000203 1560.000000 -0.001475 0.001370 0.009073 -2401 1 0.000236 1560.000000 0.001654 0.001014 0.008604 -2402 1 0.000261 1560.000000 -0.001539 -0.001603 0.003104 -2403 1 0.000273 1560.000000 0.000280 0.001006 0.007853 -2404 1 0.000198 1560.000000 0.000478 0.002988 0.002787 -2405 1 0.000229 1560.000000 0.002019 0.001918 0.001805 -2406 1 0.000193 1560.000000 -0.001870 -0.000950 0.005204 -2407 1 0.000206 1560.000000 0.000049 -0.001180 0.008462 -2408 1 0.000254 1560.000000 0.001248 0.000059 0.001372 -2409 1 0.000242 1560.000000 -0.002083 -0.001410 0.004654 -2410 1 0.000238 1560.000000 -0.001004 -0.000215 0.001568 -2411 1 0.000250 1560.000000 0.000063 -0.002820 0.000154 -2412 1 0.000208 1560.000000 -0.000398 -0.000952 0.009773 -2413 1 0.000204 1560.000000 -0.000154 -0.000166 0.009053 -2414 1 0.000200 1560.000000 -0.002175 -0.001903 0.001660 -2415 1 0.000206 1560.000000 0.001531 0.000642 0.003950 -2416 1 0.000285 1560.000000 -0.001644 0.000974 0.006246 -2417 1 0.000227 1560.000000 -0.001563 0.001613 0.000907 -2418 1 0.000260 1560.000000 0.001419 -0.001296 0.005970 -2419 1 0.000235 1560.000000 -0.001983 -0.002555 0.003328 -2420 1 0.000269 1560.000000 -0.000502 0.002561 0.001876 -2421 1 0.000230 1560.000000 0.002280 -0.000631 0.009467 -2422 1 0.000242 1560.000000 -0.000458 -0.000267 0.008234 -2423 1 0.000213 1560.000000 0.000263 -0.001074 0.001214 -2424 1 0.000243 1560.000000 0.002745 0.001222 0.008826 -2425 1 0.000278 1560.000000 0.001045 0.003507 0.005145 -2426 1 0.000200 1560.000000 0.000332 -0.001473 0.009187 -2427 1 0.000235 1560.000000 0.000276 -0.000323 0.005810 -2428 1 0.000268 1560.000000 -0.000034 -0.002022 0.003967 -2429 1 0.000249 1560.000000 0.000625 -0.001495 0.002934 -2430 1 0.000243 1560.000000 0.001038 0.002246 0.003247 -2431 1 0.000210 1560.000000 -0.002780 0.001871 0.007148 -2432 1 0.000206 1560.000000 0.000387 0.002002 0.004234 -2433 1 0.000237 1560.000000 0.000621 0.000804 0.003973 -2434 1 0.000240 1560.000000 0.000584 0.002472 0.009345 -2435 1 0.000270 1560.000000 -0.002195 0.000986 0.000667 -2436 1 0.000234 1560.000000 0.000539 0.000568 0.008569 -2437 1 0.000288 1560.000000 0.001260 -0.002349 0.001468 -2438 1 0.000221 1560.000000 0.000455 -0.000560 0.006566 -2439 1 0.000203 1560.000000 -0.001308 -0.002453 0.001270 -2440 1 0.000228 1560.000000 0.001556 0.001223 0.009484 -2441 1 0.000197 1560.000000 -0.000073 -0.001530 0.009608 -2442 1 0.000250 1560.000000 0.000621 0.000288 0.002474 -2443 1 0.000249 1560.000000 -0.002248 -0.002119 0.003637 -2444 1 0.000198 1560.000000 -0.001867 -0.000234 0.005309 -2445 1 0.000200 1560.000000 -0.000923 0.002392 0.009807 -2446 1 0.000210 1560.000000 0.003260 0.000237 0.002349 -2447 1 0.000263 1560.000000 0.002474 -0.000540 0.003910 -2448 1 0.000225 1560.000000 -0.002231 0.000739 0.001312 -2449 1 0.000202 1560.000000 -0.000968 -0.000564 0.002883 -2450 1 0.000220 1560.000000 -0.002257 -0.003049 0.007786 -2451 1 0.000221 1560.000000 0.001164 -0.001606 0.006327 -2452 1 0.000261 1560.000000 0.000430 0.000994 0.008666 -2453 1 0.000202 1560.000000 -0.001120 0.000846 0.001726 -2454 1 0.000195 1560.000000 0.002698 0.000072 0.000758 -2455 1 0.000282 1560.000000 -0.000127 -0.001997 0.005438 -2456 1 0.000241 1560.000000 0.000474 -0.001376 0.008653 -2457 1 0.000217 1560.000000 0.000230 0.001976 0.003796 -2458 1 0.000262 1560.000000 -0.001293 0.001326 0.001636 -2459 1 0.000245 1560.000000 0.000030 -0.000375 0.004983 -2460 1 0.000257 1560.000000 -0.002384 -0.001437 0.001667 -2461 1 0.000242 1560.000000 0.001156 0.002776 0.003036 -2462 1 0.000219 1560.000000 -0.002243 -0.000069 0.008274 -2463 1 0.000256 1560.000000 0.000372 0.000586 0.007459 -2464 1 0.000196 1560.000000 -0.000230 0.000220 0.001440 -2465 1 0.000196 1560.000000 0.002524 0.000097 0.007978 -2466 1 0.000199 1560.000000 -0.000757 0.000875 0.006647 -2467 1 0.000272 1560.000000 0.001250 -0.000367 0.002852 -2468 1 0.000217 1560.000000 0.000071 0.000985 0.004344 -2469 1 0.000219 1560.000000 -0.003776 -0.000649 0.005906 -2470 1 0.000277 1560.000000 -0.001429 0.001085 0.004559 -2471 1 0.000204 1560.000000 0.000121 -0.000478 0.004354 -2472 1 0.000193 1560.000000 -0.001374 0.001658 0.005720 -2473 1 0.000225 1560.000000 0.002582 0.001487 0.008274 -2474 1 0.000217 1560.000000 0.003384 0.000589 0.000843 -2475 1 0.000216 1560.000000 0.003230 -0.000610 0.008336 -2476 1 0.000243 1560.000000 -0.001288 -0.002867 0.009589 -2477 1 0.000219 1560.000000 0.001539 -0.000641 0.006368 -2478 1 0.000248 1560.000000 0.002640 -0.002103 0.007497 -2479 1 0.000248 1560.000000 0.000614 -0.003395 0.005644 -2480 1 0.000224 1560.000000 0.001506 -0.001372 0.007686 -2481 1 0.000241 1560.000000 -0.001556 0.001980 0.003756 -2482 1 0.000283 1560.000000 0.001937 -0.002710 0.002811 -2483 1 0.000207 1560.000000 0.002957 -0.000338 0.003686 -2484 1 0.000247 1560.000000 -0.000920 0.000064 0.006449 -2485 1 0.000237 1560.000000 -0.000734 -0.000104 0.005803 -2486 1 0.000256 1560.000000 -0.000477 -0.000962 0.004771 -2487 1 0.000196 1560.000000 -0.002911 -0.000939 0.004428 -2488 1 0.000243 1560.000000 0.000541 0.002814 0.001969 -2489 1 0.000221 1560.000000 -0.001592 -0.003241 0.005844 -2490 1 0.000193 1560.000000 -0.000209 -0.002163 0.005000 -2491 1 0.000240 1560.000000 0.001962 0.001135 0.001669 -2492 1 0.000194 1560.000000 0.000431 -0.000911 0.006206 -2493 1 0.000193 1560.000000 0.002090 -0.000775 0.004245 -2494 1 0.000250 1560.000000 -0.002090 -0.000699 0.003926 -2495 1 0.000202 1560.000000 0.000398 -0.001807 0.003706 -2496 1 0.000229 1560.000000 -0.000923 0.003554 0.004640 -2497 1 0.000234 1560.000000 -0.003036 0.001149 0.009451 -2498 1 0.000223 1560.000000 -0.003062 0.000433 0.006150 -2499 1 0.000216 1560.000000 -0.003710 -0.000000 0.007145 -2500 1 0.000247 1560.000000 0.001209 0.001323 0.002469 -2501 1 0.000262 1560.000000 -0.003136 -0.002219 0.007436 -2502 1 0.000193 1560.000000 0.000951 0.000641 0.009125 -2503 1 0.000288 1560.000000 -0.002778 0.001808 0.008411 -2504 1 0.000277 1560.000000 0.002271 0.001038 0.003536 -2505 1 0.000233 1560.000000 0.000596 0.002335 0.003279 -2506 1 0.000202 1560.000000 0.001653 0.001857 0.009532 -2507 1 0.000200 1560.000000 0.000324 0.001448 0.001201 -2508 1 0.000265 1560.000000 0.001776 -0.000864 0.003204 -2509 1 0.000210 1560.000000 -0.000943 -0.001941 0.008788 -2510 1 0.000260 1560.000000 0.001232 -0.000557 0.005198 -2511 1 0.000200 1560.000000 -0.000334 0.000767 0.000438 -2512 1 0.000202 1560.000000 0.000704 -0.001902 0.002543 -2513 1 0.000234 1560.000000 0.001063 -0.002123 0.005332 -2514 1 0.000210 1560.000000 -0.003080 0.001425 0.004137 -2515 1 0.000202 1560.000000 -0.001184 -0.000766 0.001682 -2516 1 0.000254 1560.000000 -0.000826 -0.002559 0.002011 -2517 1 0.000212 1560.000000 -0.000292 0.000420 0.005080 -2518 1 0.000274 1560.000000 -0.000298 -0.002174 0.002234 -2519 1 0.000201 1560.000000 0.001535 0.000041 0.000612 -2520 1 0.000244 1560.000000 0.001269 0.003365 0.003233 -2521 1 0.000257 1560.000000 0.001467 -0.002569 0.002782 -2522 1 0.000281 1560.000000 -0.000604 -0.001040 0.002538 -2523 1 0.000192 1560.000000 -0.000185 -0.002672 0.007365 -2524 1 0.000205 1560.000000 0.001777 0.002701 0.001769 -2525 1 0.000256 1560.000000 -0.000839 -0.003077 0.001507 -2526 1 0.000282 1560.000000 0.001656 0.001437 0.005555 -2527 1 0.000212 1560.000000 -0.001920 0.001608 0.003298 -2528 1 0.000252 1560.000000 -0.001575 -0.002940 0.004577 -2529 1 0.000262 1560.000000 0.003513 0.000341 0.001297 -2530 1 0.000240 1560.000000 -0.000322 0.003260 0.001577 -2531 1 0.000251 1560.000000 -0.001452 -0.003491 0.002486 -2532 1 0.000233 1560.000000 0.002088 0.001469 0.007167 -2533 1 0.000262 1560.000000 -0.002406 -0.000569 0.008235 -2534 1 0.000201 1560.000000 -0.002982 0.000143 0.003954 -2535 1 0.000267 1560.000000 -0.002563 -0.002115 0.009693 -2536 1 0.000194 1560.000000 0.001008 0.000485 0.007057 -2537 1 0.000239 1560.000000 -0.002191 -0.000262 0.001368 -2538 1 0.000225 1560.000000 -0.001403 -0.001357 0.004621 -2539 1 0.000223 1560.000000 -0.000499 -0.000026 0.004798 -2540 1 0.000221 1560.000000 0.001925 0.002195 0.005189 -2541 1 0.000204 1560.000000 0.000515 0.001714 0.005922 -2542 1 0.000254 1560.000000 0.001136 -0.002289 0.004137 -2543 1 0.000248 1560.000000 0.000200 -0.001610 0.008693 -2544 1 0.000254 1560.000000 -0.001746 0.002081 0.007026 -2545 1 0.000235 1560.000000 -0.000298 -0.001531 0.004287 -2546 1 0.000220 1560.000000 -0.001225 0.000219 0.004221 -2547 1 0.000277 1560.000000 0.002964 0.000536 0.006649 -2548 1 0.000247 1560.000000 -0.001619 -0.001168 0.001766 -2549 1 0.000255 1560.000000 0.003789 -0.000212 0.006611 -2550 1 0.000213 1560.000000 -0.003590 0.000468 0.009000 -2551 1 0.000201 1560.000000 0.002815 0.000626 0.001918 -2552 1 0.000281 1560.000000 0.000920 0.000484 0.003108 -2553 1 0.000197 1560.000000 0.000399 0.001922 0.001967 -2554 1 0.000274 1560.000000 -0.000108 0.000482 0.007819 -2555 1 0.000232 1560.000000 0.001519 -0.000684 0.003837 -2556 1 0.000278 1560.000000 -0.000620 -0.001757 0.004060 -2557 1 0.000222 1560.000000 -0.001460 0.001258 0.008542 -2558 1 0.000232 1560.000000 -0.000826 -0.003418 0.009394 -2559 1 0.000212 1560.000000 -0.003213 -0.001159 0.004540 -2560 1 0.000198 1560.000000 0.000163 0.002201 0.004195 -2561 1 0.000205 1560.000000 -0.001127 0.000614 0.005526 -2562 1 0.000199 1560.000000 0.000171 0.001116 0.008934 -2563 1 0.000210 1560.000000 -0.002503 -0.002567 0.004371 -2564 1 0.000247 1560.000000 0.002064 0.000814 0.009769 -2565 1 0.000194 1560.000000 0.000836 0.002584 0.002636 -2566 1 0.000193 1560.000000 0.001900 -0.001556 0.006771 -2567 1 0.000193 1560.000000 0.001001 0.001805 0.003258 -2568 1 0.000260 1560.000000 0.001070 -0.002628 0.008598 -2569 1 0.000199 1560.000000 0.002320 0.001592 0.001085 -2570 1 0.000236 1560.000000 0.000865 0.002357 0.000980 -2571 1 0.000271 1560.000000 0.000393 0.003150 0.002621 -2572 1 0.000228 1560.000000 -0.002774 -0.000358 0.009478 -2573 1 0.000261 1560.000000 0.001971 -0.001906 0.009718 -2574 1 0.000224 1560.000000 -0.000056 -0.002886 0.009101 -2575 1 0.000233 1560.000000 0.000753 0.003541 0.007703 -2576 1 0.000249 1560.000000 0.000082 -0.000767 0.006645 -2577 1 0.000227 1560.000000 0.002059 -0.001741 0.000903 -2578 1 0.000234 1560.000000 0.001151 0.001713 0.006966 -2579 1 0.000263 1560.000000 0.002088 0.000599 0.005184 -2580 1 0.000228 1560.000000 0.001116 0.001789 0.004050 -2581 1 0.000199 1560.000000 0.000283 -0.003260 0.004453 -2582 1 0.000232 1560.000000 0.001087 -0.002753 0.004430 -2583 1 0.000194 1560.000000 0.003375 0.001422 0.009388 -2584 1 0.000241 1560.000000 -0.000365 -0.002775 0.003094 -2585 1 0.000220 1560.000000 0.001544 -0.000224 0.006845 -2586 1 0.000228 1560.000000 0.000433 -0.000485 0.009149 -2587 1 0.000216 1560.000000 0.001706 0.001639 0.007115 -2588 1 0.000204 1560.000000 0.002048 -0.001737 0.003719 -2589 1 0.000223 1560.000000 0.000694 0.000778 0.005921 -2590 1 0.000225 1560.000000 -0.001541 -0.000234 0.004028 -2591 1 0.000198 1560.000000 0.002221 0.001621 0.000679 -2592 1 0.000241 1560.000000 -0.000536 0.001951 0.005150 -2593 1 0.000217 1560.000000 -0.000926 0.001803 0.003357 -2594 1 0.000218 1560.000000 0.000309 -0.001097 0.003082 -2595 1 0.000209 1560.000000 0.000454 -0.000354 0.006352 -2596 1 0.000199 1560.000000 0.001329 -0.000045 0.003118 -2597 1 0.000251 1560.000000 -0.000649 -0.000705 0.002166 -2598 1 0.000219 1560.000000 0.001707 -0.001604 0.007267 -2599 1 0.000267 1560.000000 -0.000205 -0.000557 0.007825 -2600 1 0.000239 1560.000000 0.003150 -0.002103 0.002204 -2601 1 0.000221 1560.000000 -0.002656 -0.001247 0.009482 -2602 1 0.000215 1560.000000 0.000796 -0.000510 0.002878 -2603 1 0.000262 1560.000000 0.000364 0.001858 0.003561 -2604 1 0.000279 1560.000000 -0.000307 0.000583 0.005345 -2605 1 0.000261 1560.000000 -0.002853 0.001555 0.001731 -2606 1 0.000231 1560.000000 0.001462 -0.002403 0.006182 -2607 1 0.000254 1560.000000 0.000990 -0.000442 0.000154 -2608 1 0.000238 1560.000000 0.000806 0.003460 0.008447 -2609 1 0.000220 1560.000000 -0.002554 -0.000229 0.000489 -2610 1 0.000246 1560.000000 0.001561 0.002983 0.007730 -2611 1 0.000241 1560.000000 -0.000893 -0.001113 0.007954 -2612 1 0.000285 1560.000000 0.000855 0.001135 0.004298 -2613 1 0.000221 1560.000000 -0.001036 -0.000063 0.000566 -2614 1 0.000248 1560.000000 0.001318 -0.001385 0.003296 -2615 1 0.000227 1560.000000 -0.002191 0.002702 0.007385 -2616 1 0.000199 1560.000000 -0.002489 -0.000830 0.001664 -2617 1 0.000260 1560.000000 -0.002445 0.000507 0.003373 -2618 1 0.000218 1560.000000 0.002583 -0.000130 0.004140 -2619 1 0.000195 1560.000000 0.000508 0.001797 0.006561 -2620 1 0.000205 1560.000000 -0.001467 0.000555 0.007332 -2621 1 0.000282 1560.000000 0.003230 -0.000377 0.008834 -2622 1 0.000234 1560.000000 -0.001405 -0.000905 0.005179 -2623 1 0.000231 1560.000000 -0.003617 -0.000113 0.002426 -2624 1 0.000220 1560.000000 0.001406 -0.001070 0.009606 -2625 1 0.000248 1560.000000 -0.003237 0.001721 0.004445 -2626 1 0.000222 1560.000000 0.000139 0.000376 0.006023 -2627 1 0.000210 1560.000000 -0.001702 -0.001712 0.001709 -2628 1 0.000217 1560.000000 0.000389 0.001807 0.008580 -2629 1 0.000195 1560.000000 0.002108 -0.000170 0.000527 -2630 1 0.000241 1560.000000 0.001225 0.001244 0.007346 -2631 1 0.000233 1560.000000 0.001582 0.002660 0.003319 -2632 1 0.000223 1560.000000 0.000759 -0.003671 0.007909 -2633 1 0.000213 1560.000000 -0.001171 0.000518 0.001611 -2634 1 0.000219 1560.000000 -0.002372 -0.002776 0.004137 -2635 1 0.000269 1560.000000 -0.001238 0.001354 0.005914 -2636 1 0.000260 1560.000000 0.002077 -0.000698 0.003905 -2637 1 0.000210 1560.000000 -0.001556 -0.002934 0.005560 -2638 1 0.000229 1560.000000 -0.001822 0.001821 0.007082 -2639 1 0.000217 1560.000000 -0.002994 -0.002003 0.001004 -2640 1 0.000197 1560.000000 0.002243 0.001642 0.003956 -2641 1 0.000256 1560.000000 0.002094 -0.002083 0.001629 -2642 1 0.000202 1560.000000 0.001377 0.002660 0.003418 -2643 1 0.000253 1560.000000 0.000785 0.000192 0.005534 -2644 1 0.000225 1560.000000 -0.001677 -0.002548 0.008477 -2645 1 0.000225 1560.000000 0.003747 0.000909 0.007176 -2646 1 0.000257 1560.000000 -0.002019 -0.000549 0.005653 -2647 1 0.000207 1560.000000 0.001439 0.000582 0.007508 -2648 1 0.000217 1560.000000 0.000957 -0.001754 0.002801 -2649 1 0.000251 1560.000000 0.001406 0.000005 0.002034 -2650 1 0.000256 1560.000000 -0.001824 0.001969 0.005180 -2651 1 0.000201 1560.000000 0.003335 0.000929 0.001425 -2652 1 0.000200 1560.000000 -0.000986 0.000234 0.001537 -2653 1 0.000233 1560.000000 0.002812 -0.000645 0.005473 -2654 1 0.000228 1560.000000 0.000713 -0.001858 0.004100 -2655 1 0.000222 1560.000000 0.000378 0.001919 0.006836 -2656 1 0.000202 1560.000000 0.002467 -0.000362 0.009798 -2657 1 0.000263 1560.000000 -0.002491 0.001710 0.005019 -2658 1 0.000192 1560.000000 0.000856 -0.003629 0.003074 -2659 1 0.000227 1560.000000 -0.000693 0.002167 0.007082 -2660 1 0.000253 1560.000000 0.000726 -0.001802 0.009622 -2661 1 0.000225 1560.000000 0.003405 -0.000903 0.003320 -2662 1 0.000274 1560.000000 -0.000513 0.002120 0.000530 -2663 1 0.000211 1560.000000 -0.003065 -0.000989 0.002911 -2664 1 0.000255 1560.000000 0.000810 0.001246 0.008255 -2665 1 0.000278 1560.000000 0.002061 0.002730 0.001167 -2666 1 0.000280 1560.000000 -0.002257 0.002639 0.009278 -2667 1 0.000201 1560.000000 0.001059 0.003630 0.001179 -2668 1 0.000255 1560.000000 0.000171 -0.000420 0.003016 -2669 1 0.000230 1560.000000 -0.001811 0.003214 0.003304 -2670 1 0.000217 1560.000000 0.000953 0.000877 0.000564 -2671 1 0.000203 1560.000000 0.001187 0.003582 0.001384 -2672 1 0.000200 1560.000000 0.000210 -0.000626 0.006153 -2673 1 0.000219 1560.000000 0.002070 0.002627 0.007113 -2674 1 0.000227 1560.000000 -0.002211 0.002308 0.007621 -2675 1 0.000247 1560.000000 -0.003217 -0.001344 0.002176 -2676 1 0.000204 1560.000000 0.000376 0.002312 0.009194 -2677 1 0.000239 1560.000000 0.001085 -0.000451 0.005489 -2678 1 0.000213 1560.000000 0.000510 0.002940 0.006799 -2679 1 0.000216 1560.000000 -0.001517 0.002201 0.005758 -2680 1 0.000229 1560.000000 0.001740 0.001273 0.008264 -2681 1 0.000221 1560.000000 -0.001828 0.000448 0.004761 -2682 1 0.000193 1560.000000 0.001239 -0.000217 0.008481 -2683 1 0.000287 1560.000000 -0.000865 -0.001783 0.006388 -2684 1 0.000248 1560.000000 -0.000600 -0.001094 0.006734 -2685 1 0.000257 1560.000000 0.001325 -0.003349 0.001759 -2686 1 0.000209 1560.000000 0.003670 0.000232 0.002477 -2687 1 0.000252 1560.000000 -0.003379 -0.000288 0.003069 -2688 1 0.000275 1560.000000 -0.000069 -0.000918 0.006264 -2689 1 0.000225 1560.000000 -0.001404 -0.002021 0.006453 -2690 1 0.000259 1560.000000 0.000075 -0.003490 0.005602 -2691 1 0.000195 1560.000000 -0.002539 0.001619 0.003657 -2692 1 0.000269 1560.000000 -0.000730 0.000152 0.004527 -2693 1 0.000246 1560.000000 0.000418 -0.001243 0.005291 -2694 1 0.000194 1560.000000 -0.003391 -0.001467 0.005705 -2695 1 0.000237 1560.000000 -0.003483 0.000328 0.002622 -2696 1 0.000217 1560.000000 0.000154 -0.002666 0.005321 -2697 1 0.000211 1560.000000 -0.000752 -0.000644 0.005898 -2698 1 0.000274 1560.000000 0.003594 -0.000192 0.000629 -2699 1 0.000227 1560.000000 -0.003684 0.000775 0.003893 -2700 1 0.000200 1560.000000 0.000770 0.003702 0.004080 -2701 1 0.000199 1560.000000 -0.002287 -0.001705 0.006695 -2702 1 0.000215 1560.000000 -0.000003 0.003726 0.002154 -2703 1 0.000196 1560.000000 0.000925 -0.002904 0.001800 -2704 1 0.000197 1560.000000 -0.001492 0.000400 0.004351 -2705 1 0.000240 1560.000000 0.000032 -0.001586 0.009318 -2706 1 0.000268 1560.000000 -0.003115 -0.000141 0.004633 -2707 1 0.000215 1560.000000 -0.002167 0.002826 0.002347 -2708 1 0.000217 1560.000000 -0.003063 0.001678 0.000364 -2709 1 0.000252 1560.000000 0.002501 0.002058 0.004890 -2710 1 0.000199 1560.000000 0.002486 0.000718 0.004780 -2711 1 0.000271 1560.000000 0.000971 -0.002945 0.003773 -2712 1 0.000285 1560.000000 0.002429 0.001859 0.003602 -2713 1 0.000256 1560.000000 0.001885 -0.000446 0.002841 -2714 1 0.000236 1560.000000 0.000879 -0.000566 0.006567 -2715 1 0.000238 1560.000000 -0.000306 -0.000151 0.005573 -2716 1 0.000235 1560.000000 -0.001692 -0.002617 0.000148 -2717 1 0.000235 1560.000000 -0.000390 -0.003586 0.004343 -2718 1 0.000192 1560.000000 -0.000795 0.000961 0.005788 -2719 1 0.000211 1560.000000 0.002824 -0.001809 0.005517 -2720 1 0.000234 1560.000000 -0.000004 -0.002101 0.004574 -2721 1 0.000202 1560.000000 0.001276 -0.001049 0.002993 -2722 1 0.000285 1560.000000 -0.003309 -0.000637 0.000981 -2723 1 0.000196 1560.000000 0.001748 0.000288 0.003832 -2724 1 0.000283 1560.000000 0.000040 0.003336 0.004579 -2725 1 0.000272 1560.000000 -0.001654 0.000194 0.000682 -2726 1 0.000236 1560.000000 -0.000060 -0.003795 0.001482 -2727 1 0.000199 1560.000000 0.001604 -0.000588 0.001857 -2728 1 0.000203 1560.000000 -0.002148 0.001857 0.008691 -2729 1 0.000200 1560.000000 -0.000856 -0.001232 0.009578 -2730 1 0.000223 1560.000000 -0.000463 -0.001564 0.005538 -2731 1 0.000204 1560.000000 -0.003151 0.002022 0.008034 -2732 1 0.000197 1560.000000 -0.000689 -0.000546 0.006661 -2733 1 0.000198 1560.000000 0.002583 -0.000449 0.002299 -2734 1 0.000198 1560.000000 0.000450 -0.001446 0.005707 -2735 1 0.000207 1560.000000 0.003209 0.000214 0.007597 -2736 1 0.000284 1560.000000 -0.001783 -0.001317 0.004397 -2737 1 0.000242 1560.000000 0.000031 0.000531 0.000270 -2738 1 0.000194 1560.000000 0.001235 0.000189 0.001874 -2739 1 0.000244 1560.000000 -0.001078 0.000484 0.006234 -2740 1 0.000208 1560.000000 -0.000315 -0.002907 0.001634 -2741 1 0.000212 1560.000000 -0.000067 -0.000444 0.005913 -2742 1 0.000231 1560.000000 0.000931 -0.000713 0.008435 -2743 1 0.000282 1560.000000 -0.000883 -0.000471 0.004288 -2744 1 0.000199 1560.000000 0.000751 0.000011 0.000312 -2745 1 0.000193 1560.000000 0.002608 0.002224 0.007370 -2746 1 0.000219 1560.000000 -0.000035 -0.003165 0.004653 -2747 1 0.000198 1560.000000 0.000043 0.001393 0.001174 -2748 1 0.000231 1560.000000 0.001370 -0.003074 0.001389 -2749 1 0.000274 1560.000000 -0.000051 -0.003303 0.000409 -2750 1 0.000252 1560.000000 0.000485 -0.000768 0.008414 -2751 1 0.000234 1560.000000 0.001360 0.002741 0.002443 -2752 1 0.000231 1560.000000 0.000079 0.003601 0.006360 -2753 1 0.000267 1560.000000 0.000124 0.000071 0.004519 -2754 1 0.000276 1560.000000 0.003053 -0.000112 0.008010 -2755 1 0.000251 1560.000000 0.001764 0.001721 0.002353 -2756 1 0.000204 1560.000000 -0.002780 -0.000368 0.000657 -2757 1 0.000196 1560.000000 0.001395 -0.000888 0.007140 -2758 1 0.000266 1560.000000 0.000173 -0.000853 0.005007 -2759 1 0.000210 1560.000000 0.002847 -0.000741 0.007664 -2760 1 0.000217 1560.000000 -0.001367 0.000129 0.006018 -2761 1 0.000194 1560.000000 0.002302 -0.001152 0.000500 -2762 1 0.000242 1560.000000 -0.000479 -0.001075 0.003446 -2763 1 0.000199 1560.000000 -0.000187 -0.000448 0.001856 -2764 1 0.000194 1560.000000 0.001200 0.000017 0.006036 -2765 1 0.000217 1560.000000 -0.000212 0.002937 0.008486 -2766 1 0.000246 1560.000000 0.002354 -0.001907 0.000310 -2767 1 0.000275 1560.000000 0.002701 0.001278 0.008387 -2768 1 0.000209 1560.000000 0.000124 0.000871 0.005648 -2769 1 0.000224 1560.000000 -0.002075 0.000000 0.009286 -2770 1 0.000274 1560.000000 -0.000701 0.000949 0.005127 -2771 1 0.000198 1560.000000 0.000754 -0.000904 0.008142 -2772 1 0.000252 1560.000000 0.001889 0.000435 0.000670 -2773 1 0.000201 1560.000000 0.000015 0.001002 0.000775 -2774 1 0.000242 1560.000000 0.002765 0.001176 0.003741 -2775 1 0.000208 1560.000000 -0.000523 0.003747 0.006331 -2776 1 0.000243 1560.000000 -0.003159 -0.001012 0.006164 -2777 1 0.000205 1560.000000 0.003028 -0.002249 0.004054 -2778 1 0.000237 1560.000000 -0.001451 0.002720 0.007522 -2779 1 0.000252 1560.000000 -0.000944 -0.002332 0.007587 -2780 1 0.000212 1560.000000 -0.001809 -0.002589 0.009290 -2781 1 0.000285 1560.000000 0.000767 0.001591 0.007620 -2782 1 0.000208 1560.000000 -0.001914 0.002982 0.009019 -2783 1 0.000209 1560.000000 -0.002359 -0.001777 0.002317 -2784 1 0.000258 1560.000000 0.001916 -0.002094 0.007278 -2785 1 0.000230 1560.000000 -0.001430 -0.001437 0.005730 -2786 1 0.000243 1560.000000 -0.000721 -0.001729 0.001083 -2787 1 0.000248 1560.000000 -0.001132 -0.000571 0.006348 -2788 1 0.000210 1560.000000 -0.000849 0.002806 0.006987 -2789 1 0.000211 1560.000000 -0.001651 0.001905 0.000445 -2790 1 0.000205 1560.000000 0.003508 0.000161 0.000842 -2791 1 0.000223 1560.000000 -0.001403 0.000889 0.006878 -2792 1 0.000199 1560.000000 0.003646 0.000122 0.004051 -2793 1 0.000250 1560.000000 0.002454 -0.002217 0.006294 -2794 1 0.000192 1560.000000 -0.002819 -0.002402 0.006313 -2795 1 0.000250 1560.000000 -0.001854 0.003279 0.001929 -2796 1 0.000204 1560.000000 -0.000421 -0.002690 0.006674 -2797 1 0.000288 1560.000000 0.000800 -0.000465 0.004977 -2798 1 0.000243 1560.000000 -0.002772 -0.001637 0.008410 -2799 1 0.000196 1560.000000 -0.001736 0.002310 0.006879 -2800 1 0.000206 1560.000000 -0.002465 -0.002723 0.001325 -2801 1 0.000224 1560.000000 0.001607 0.001681 0.004393 -2802 1 0.000223 1560.000000 0.002667 -0.000881 0.005078 -2803 1 0.000279 1560.000000 -0.001146 -0.000408 0.009751 -2804 1 0.000249 1560.000000 -0.000257 0.001105 0.001954 -2805 1 0.000226 1560.000000 0.000887 -0.001316 0.000903 -2806 1 0.000276 1560.000000 0.000975 0.002533 0.007317 -2807 1 0.000219 1560.000000 -0.002337 0.000371 0.008021 -2808 1 0.000251 1560.000000 0.001725 -0.001840 0.005729 -2809 1 0.000212 1560.000000 0.001476 0.002007 0.007961 -2810 1 0.000206 1560.000000 0.002909 -0.000088 0.002465 -2811 1 0.000201 1560.000000 -0.000850 -0.002716 0.003170 -2812 1 0.000258 1560.000000 0.002276 0.001621 0.006041 -2813 1 0.000222 1560.000000 -0.001207 0.000951 0.004511 -2814 1 0.000270 1560.000000 -0.000599 -0.001610 0.009284 -2815 1 0.000252 1560.000000 0.001177 0.003266 0.006969 -2816 1 0.000265 1560.000000 0.001765 0.001083 0.000380 -2817 1 0.000229 1560.000000 -0.000752 0.003511 0.007693 -2818 1 0.000225 1560.000000 -0.003203 -0.000496 0.007516 -2819 1 0.000207 1560.000000 -0.001437 0.002313 0.001341 -2820 1 0.000248 1560.000000 0.002427 -0.001580 0.001848 -2821 1 0.000242 1560.000000 -0.000186 -0.000068 0.007093 -2822 1 0.000215 1560.000000 -0.000899 -0.001826 0.005126 -2823 1 0.000240 1560.000000 0.001058 -0.000746 0.007082 -2824 1 0.000272 1560.000000 -0.000722 0.001255 0.002063 -2825 1 0.000227 1560.000000 -0.002372 0.000140 0.008803 -2826 1 0.000207 1560.000000 0.002682 0.000012 0.000324 -2827 1 0.000267 1560.000000 -0.001397 -0.002014 0.005418 -2828 1 0.000241 1560.000000 -0.000813 -0.000324 0.006659 -2829 1 0.000202 1560.000000 0.003767 -0.000067 0.005271 -2830 1 0.000240 1560.000000 0.002886 -0.000921 0.009482 -2831 1 0.000238 1560.000000 -0.000976 -0.001662 0.004329 -2832 1 0.000266 1560.000000 0.000596 -0.003775 0.003537 -2833 1 0.000245 1560.000000 -0.000406 0.001022 0.006892 -2834 1 0.000208 1560.000000 0.002557 -0.002459 0.002835 -2835 1 0.000267 1560.000000 0.000530 0.000640 0.005527 -2836 1 0.000214 1560.000000 -0.000269 -0.000238 0.005315 -2837 1 0.000195 1560.000000 0.002104 -0.001039 0.007352 -2838 1 0.000208 1560.000000 0.003222 0.000611 0.008137 -2839 1 0.000217 1560.000000 -0.000456 0.000496 0.004041 -2840 1 0.000243 1560.000000 -0.000652 -0.003395 0.004075 -2841 1 0.000207 1560.000000 0.003481 0.000019 0.006383 -2842 1 0.000206 1560.000000 -0.002269 0.000745 0.003607 -2843 1 0.000206 1560.000000 0.000556 -0.000496 0.007921 -2844 1 0.000243 1560.000000 -0.001129 -0.000831 0.006957 -2845 1 0.000212 1560.000000 -0.001151 -0.002546 0.006674 -2846 1 0.000219 1560.000000 0.003352 -0.000274 0.007876 -2847 1 0.000228 1560.000000 0.003100 0.000807 0.007707 -2848 1 0.000218 1560.000000 -0.001873 0.003354 0.003781 -2849 1 0.000254 1560.000000 -0.001231 -0.000590 0.009240 -2850 1 0.000199 1560.000000 0.001433 -0.000621 0.004479 -2851 1 0.000216 1560.000000 0.001435 -0.001054 0.007575 -2852 1 0.000212 1560.000000 0.003086 -0.001527 0.007408 -2853 1 0.000206 1560.000000 -0.000793 -0.003441 0.001162 -2854 1 0.000218 1560.000000 -0.001228 0.000963 0.001541 -2855 1 0.000205 1560.000000 -0.001877 0.000224 0.009099 -2856 1 0.000224 1560.000000 0.000100 0.002619 0.008644 -2857 1 0.000197 1560.000000 0.001747 -0.002610 0.001656 -2858 1 0.000228 1560.000000 -0.002487 0.000227 0.002747 -2859 1 0.000233 1560.000000 -0.001454 -0.001031 0.008537 -2860 1 0.000282 1560.000000 -0.000657 0.002503 0.002631 -2861 1 0.000273 1560.000000 -0.002951 0.002190 0.009422 -2862 1 0.000224 1560.000000 -0.000192 -0.001990 0.006712 -2863 1 0.000258 1560.000000 -0.003018 -0.001267 0.007561 -2864 1 0.000276 1560.000000 0.001504 0.001094 0.009191 -2865 1 0.000216 1560.000000 0.002361 -0.001567 0.002393 -2866 1 0.000284 1560.000000 -0.000156 -0.000287 0.004153 -2867 1 0.000252 1560.000000 0.000502 -0.000731 0.007578 -2868 1 0.000212 1560.000000 -0.000347 0.001604 0.008100 -2869 1 0.000281 1560.000000 0.001403 -0.001540 0.009021 -2870 1 0.000247 1560.000000 -0.000297 -0.002347 0.008117 -2871 1 0.000214 1560.000000 -0.000418 -0.002624 0.008674 -2872 1 0.000193 1560.000000 -0.001976 0.002801 0.003652 -2873 1 0.000266 1560.000000 0.003751 0.000090 0.004430 -2874 1 0.000233 1560.000000 0.000031 -0.002168 0.002014 -2875 1 0.000260 1560.000000 0.002340 0.000228 0.005098 -2876 1 0.000266 1560.000000 -0.000556 -0.001175 0.008222 -2877 1 0.000256 1560.000000 0.003362 0.001750 0.007945 -2878 1 0.000214 1560.000000 0.000572 -0.001662 0.005525 -2879 1 0.000212 1560.000000 -0.000546 0.002902 0.006600 -2880 1 0.000218 1560.000000 -0.000024 0.001157 0.009141 -2881 1 0.000262 1560.000000 0.001032 -0.000291 0.003788 -2882 1 0.000204 1560.000000 0.000737 -0.002256 0.000716 -2883 1 0.000243 1560.000000 -0.002268 -0.003086 0.002289 -2884 1 0.000240 1560.000000 0.000781 -0.002786 0.009414 -2885 1 0.000223 1560.000000 -0.001981 -0.002040 0.006887 -2886 1 0.000250 1560.000000 -0.000785 -0.000029 0.000765 -2887 1 0.000246 1560.000000 0.001809 -0.003091 0.002666 -2888 1 0.000201 1560.000000 0.000843 -0.003687 0.009779 -2889 1 0.000203 1560.000000 0.002418 0.000970 0.005523 -2890 1 0.000209 1560.000000 0.000668 0.000217 0.001196 -2891 1 0.000213 1560.000000 -0.003498 0.000075 0.006486 -2892 1 0.000227 1560.000000 -0.000859 0.003234 0.008629 -2893 1 0.000264 1560.000000 0.001620 -0.001393 0.006149 -2894 1 0.000200 1560.000000 0.000631 -0.003599 0.006429 -2895 1 0.000195 1560.000000 -0.001802 -0.001089 0.003817 -2896 1 0.000218 1560.000000 -0.000816 0.003274 0.009077 -2897 1 0.000198 1560.000000 -0.000045 -0.002671 0.007113 -2898 1 0.000204 1560.000000 -0.002181 0.001795 0.009690 -2899 1 0.000195 1560.000000 -0.000981 0.002647 0.001116 -2900 1 0.000219 1560.000000 0.001408 -0.000576 0.001327 -2901 1 0.000192 1560.000000 0.000029 -0.001351 0.003505 -2902 1 0.000219 1560.000000 -0.000015 0.001744 0.006719 -2903 1 0.000220 1560.000000 -0.001889 -0.001564 0.009454 -2904 1 0.000265 1560.000000 0.000930 0.001328 0.003783 -2905 1 0.000220 1560.000000 -0.000775 0.000487 0.004493 -2906 1 0.000280 1560.000000 0.001509 -0.000229 0.009614 -2907 1 0.000285 1560.000000 -0.001696 -0.000457 0.007701 -2908 1 0.000231 1560.000000 -0.001240 -0.000647 0.003029 -2909 1 0.000214 1560.000000 0.000441 0.000248 0.002840 -2910 1 0.000226 1560.000000 -0.003176 -0.001724 0.003703 -2911 1 0.000225 1560.000000 0.002501 -0.000401 0.006782 -2912 1 0.000217 1560.000000 -0.000367 -0.001594 0.006963 -2913 1 0.000213 1560.000000 0.001687 0.000385 0.009458 -2914 1 0.000284 1560.000000 0.002001 -0.001461 0.002235 -2915 1 0.000233 1560.000000 -0.000509 0.002482 0.004940 -2916 1 0.000202 1560.000000 0.001601 -0.001018 0.001066 -2917 1 0.000242 1560.000000 0.001915 0.002693 0.008868 -2918 1 0.000258 1560.000000 0.002246 -0.001868 0.008638 -2919 1 0.000223 1560.000000 0.000265 -0.002042 0.008936 -2920 1 0.000273 1560.000000 0.000012 0.000754 0.000752 -2921 1 0.000194 1560.000000 0.001401 -0.000421 0.001847 -2922 1 0.000212 1560.000000 0.000641 0.001904 0.006930 -2923 1 0.000215 1560.000000 -0.002476 0.002476 0.005857 -2924 1 0.000229 1560.000000 -0.000296 -0.000761 0.007961 -2925 1 0.000225 1560.000000 -0.002929 0.001117 0.005077 -2926 1 0.000250 1560.000000 0.000181 0.002352 0.005996 -2927 1 0.000234 1560.000000 0.000694 0.001423 0.001294 -2928 1 0.000202 1560.000000 0.000675 0.000213 0.008958 -2929 1 0.000201 1560.000000 0.001362 0.000752 0.004427 -2930 1 0.000205 1560.000000 0.003278 0.001668 0.001201 -2931 1 0.000241 1560.000000 0.002196 -0.003027 0.005099 -2932 1 0.000261 1560.000000 -0.002823 0.002264 0.004424 -2933 1 0.000220 1560.000000 -0.001746 0.002652 0.008816 -2934 1 0.000205 1560.000000 -0.002334 -0.002994 0.001631 -2935 1 0.000214 1560.000000 0.000355 0.003154 0.007478 -2936 1 0.000203 1560.000000 -0.001392 0.000830 0.003071 -2937 1 0.000266 1560.000000 0.002894 0.002477 0.005980 -2938 1 0.000212 1560.000000 0.002560 0.000682 0.004271 -2939 1 0.000273 1560.000000 0.001245 0.003421 0.006466 -2940 1 0.000214 1560.000000 -0.003708 -0.001041 0.001832 -2941 1 0.000263 1560.000000 -0.002528 0.001071 0.001928 -2942 1 0.000240 1560.000000 -0.001885 0.002230 0.002270 -2943 1 0.000202 1560.000000 0.000114 0.000078 0.001988 -2944 1 0.000227 1560.000000 -0.000625 0.001483 0.000938 -2945 1 0.000201 1560.000000 0.002471 -0.002865 0.006326 -2946 1 0.000216 1560.000000 0.003022 0.001435 0.009469 -2947 1 0.000206 1560.000000 -0.002825 -0.000864 0.004627 -2948 1 0.000255 1560.000000 0.001777 -0.002164 0.003044 -2949 1 0.000220 1560.000000 -0.000516 0.000639 0.001243 -2950 1 0.000193 1560.000000 -0.001790 -0.002824 0.006704 -2951 1 0.000229 1560.000000 -0.000694 0.002292 0.003194 -2952 1 0.000249 1560.000000 -0.000592 0.002521 0.009607 -2953 1 0.000203 1560.000000 -0.001896 -0.003213 0.004852 -2954 1 0.000238 1560.000000 0.000883 -0.002987 0.000159 -2955 1 0.000193 1560.000000 -0.002222 -0.002972 0.005018 -2956 1 0.000230 1560.000000 -0.001816 -0.001010 0.008202 -2957 1 0.000275 1560.000000 -0.000849 -0.000186 0.007038 -2958 1 0.000210 1560.000000 0.002563 -0.000916 0.002553 -2959 1 0.000198 1560.000000 0.001656 0.001460 0.002877 -2960 1 0.000196 1560.000000 0.000525 0.003061 0.000471 -2961 1 0.000252 1560.000000 -0.002216 -0.000219 0.009504 -2962 1 0.000209 1560.000000 -0.000066 0.000164 0.008367 -2963 1 0.000214 1560.000000 -0.002498 0.000262 0.000713 -2964 1 0.000271 1560.000000 0.000590 0.002135 0.004493 -2965 1 0.000229 1560.000000 -0.003786 0.000253 0.005915 -2966 1 0.000234 1560.000000 -0.003817 0.000061 0.009812 -2967 1 0.000235 1560.000000 -0.003497 -0.001606 0.004110 -2968 1 0.000213 1560.000000 0.002635 0.001335 0.007766 -2969 1 0.000271 1560.000000 -0.000951 -0.002410 0.000877 -2970 1 0.000258 1560.000000 0.003246 0.000650 0.002175 -2971 1 0.000259 1560.000000 0.000998 0.003522 0.009107 -2972 1 0.000215 1560.000000 0.001109 0.001490 0.004493 -2973 1 0.000218 1560.000000 0.000693 0.001594 0.009043 -2974 1 0.000285 1560.000000 -0.002054 0.002599 0.003898 -2975 1 0.000204 1560.000000 0.000578 0.003232 0.002888 -2976 1 0.000247 1560.000000 0.002817 0.000553 0.004342 -2977 1 0.000282 1560.000000 -0.001655 -0.001092 0.005105 -2978 1 0.000254 1560.000000 0.000708 0.001090 0.005066 -2979 1 0.000272 1560.000000 -0.001175 -0.002222 0.004272 -2980 1 0.000197 1560.000000 -0.003158 0.000592 0.005274 -2981 1 0.000287 1560.000000 -0.003021 0.000832 0.009317 -2982 1 0.000196 1560.000000 -0.000192 -0.003717 0.008189 -2983 1 0.000236 1560.000000 0.001337 0.001879 0.000950 -2984 1 0.000202 1560.000000 -0.000856 0.002178 0.002051 -2985 1 0.000257 1560.000000 -0.000516 -0.001661 0.008268 -2986 1 0.000258 1560.000000 0.001867 -0.000001 0.005542 -2987 1 0.000194 1560.000000 0.000793 -0.001778 0.007068 -2988 1 0.000237 1560.000000 -0.002514 -0.002504 0.004788 -2989 1 0.000205 1560.000000 -0.001625 0.001615 0.007130 -2990 1 0.000247 1560.000000 -0.001180 -0.002867 0.000777 -2991 1 0.000205 1560.000000 -0.001299 0.000153 0.002449 -2992 1 0.000219 1560.000000 0.001575 -0.001366 0.000428 -2993 1 0.000202 1560.000000 0.000651 -0.000488 0.001937 -2994 1 0.000238 1560.000000 -0.001032 -0.000407 0.005406 -2995 1 0.000206 1560.000000 -0.003292 0.000872 0.008195 -2996 1 0.000283 1560.000000 -0.000823 0.001131 0.008410 -2997 1 0.000261 1560.000000 -0.003486 -0.001506 0.009605 -2998 1 0.000222 1560.000000 0.001651 -0.000734 0.005654 -2999 1 0.000210 1560.000000 -0.000442 0.000402 0.004904 -3000 1 0.000286 1560.000000 0.002352 -0.001545 0.006301 -3001 1 0.000216 1560.000000 0.001104 -0.001966 0.000626 -3002 1 0.000220 1560.000000 -0.000586 0.001666 0.008297 -3003 1 0.000270 1560.000000 -0.003274 -0.001570 0.003109 -3004 1 0.000200 1560.000000 0.000882 0.002304 0.008236 -3005 1 0.000222 1560.000000 -0.003515 0.000805 0.002461 -3006 1 0.000213 1560.000000 -0.001330 0.001035 0.007027 -3007 1 0.000230 1560.000000 -0.002381 -0.001304 0.007781 -3008 1 0.000212 1560.000000 0.001890 -0.002324 0.000447 -3009 1 0.000212 1560.000000 0.000139 0.001921 0.006167 -3010 1 0.000199 1560.000000 -0.000913 0.000374 0.007853 -3011 1 0.000247 1560.000000 0.002501 0.001091 0.001472 -3012 1 0.000214 1560.000000 -0.001330 0.003467 0.001180 -3013 1 0.000197 1560.000000 0.000717 -0.000984 0.006911 -3014 1 0.000267 1560.000000 -0.002994 0.002015 0.005884 -3015 1 0.000224 1560.000000 0.002089 0.001838 0.002985 -3016 1 0.000266 1560.000000 0.000276 -0.000354 0.008754 -3017 1 0.000213 1560.000000 0.000538 -0.001925 0.000257 -3018 1 0.000220 1560.000000 0.001580 0.000148 0.004851 -3019 1 0.000232 1560.000000 -0.001215 -0.000725 0.000946 -3020 1 0.000195 1560.000000 0.000383 0.000628 0.000383 -3021 1 0.000206 1560.000000 0.001790 -0.001153 0.008509 -3022 1 0.000249 1560.000000 0.002777 0.001275 0.004436 -3023 1 0.000200 1560.000000 -0.002880 -0.002080 0.000537 -3024 1 0.000220 1560.000000 0.000446 0.001143 0.006157 -3025 1 0.000267 1560.000000 -0.001057 0.002354 0.004769 -3026 1 0.000254 1560.000000 0.000802 -0.000525 0.008135 -3027 1 0.000193 1560.000000 -0.002246 -0.001278 0.006550 -3028 1 0.000195 1560.000000 0.000718 0.001134 0.003003 -3029 1 0.000198 1560.000000 -0.001662 0.001850 0.001878 -3030 1 0.000242 1560.000000 0.001206 -0.000008 0.008989 -3031 1 0.000286 1560.000000 0.000333 0.002336 0.003442 -3032 1 0.000232 1560.000000 -0.000327 0.002449 0.006999 -3033 1 0.000263 1560.000000 0.000808 -0.003589 0.003465 -3034 1 0.000198 1560.000000 0.000498 0.001588 0.008336 -3035 1 0.000195 1560.000000 0.000043 0.000009 0.007018 -3036 1 0.000193 1560.000000 -0.000534 0.000029 0.003861 -3037 1 0.000195 1560.000000 0.002978 0.001337 0.008010 -3038 1 0.000196 1560.000000 0.000188 -0.001961 0.005084 -3039 1 0.000249 1560.000000 0.002295 -0.000316 0.004056 -3040 1 0.000218 1560.000000 -0.001096 -0.000331 0.002281 -3041 1 0.000216 1560.000000 0.000016 -0.001804 0.002355 -3042 1 0.000216 1560.000000 -0.000751 0.002078 0.008642 -3043 1 0.000224 1560.000000 -0.001482 0.001861 0.005690 -3044 1 0.000268 1560.000000 0.001046 0.000504 0.006268 -3045 1 0.000246 1560.000000 -0.002197 0.000759 0.002184 -3046 1 0.000263 1560.000000 -0.001358 0.000971 0.000730 -3047 1 0.000255 1560.000000 0.002457 0.000444 0.004862 -3048 1 0.000224 1560.000000 0.001565 -0.002317 0.009650 -3049 1 0.000256 1560.000000 -0.001435 0.001446 0.003203 -3050 1 0.000250 1560.000000 -0.001134 -0.003220 0.009550 -3051 1 0.000257 1560.000000 0.002189 -0.000704 0.006656 -3052 1 0.000287 1560.000000 0.002048 -0.001031 0.007024 -3053 1 0.000201 1560.000000 0.000067 -0.001755 0.001717 -3054 1 0.000259 1560.000000 0.001691 -0.000106 0.008481 -3055 1 0.000218 1560.000000 0.000574 -0.003574 0.007130 -3056 1 0.000208 1560.000000 0.000177 0.002660 0.009774 -3057 1 0.000284 1560.000000 0.003509 0.000500 0.002586 -3058 1 0.000197 1560.000000 -0.001800 0.000927 0.008335 -3059 1 0.000193 1560.000000 0.000624 0.000403 0.003353 -3060 1 0.000221 1560.000000 0.002609 0.000681 0.007128 -3061 1 0.000200 1560.000000 0.002632 0.001523 0.003333 -3062 1 0.000286 1560.000000 0.001690 -0.002091 0.005940 -3063 1 0.000223 1560.000000 -0.000971 -0.001088 0.001301 -3064 1 0.000229 1560.000000 0.001955 -0.000553 0.002609 -3065 1 0.000242 1560.000000 0.000311 0.000665 0.003076 -3066 1 0.000240 1560.000000 0.001818 -0.000818 0.007734 -3067 1 0.000226 1560.000000 -0.002366 -0.001180 0.004072 -3068 1 0.000232 1560.000000 0.001266 -0.002679 0.005115 -3069 1 0.000243 1560.000000 0.001783 0.001857 0.004236 -3070 1 0.000228 1560.000000 0.000695 -0.000264 0.001487 -3071 1 0.000225 1560.000000 0.000266 0.000228 0.000504 -3072 1 0.000227 1560.000000 0.002783 -0.001992 0.003437 -3073 1 0.000225 1560.000000 0.001011 0.002600 0.007662 -3074 1 0.000198 1560.000000 -0.000526 0.000464 0.001691 -3075 1 0.000252 1560.000000 -0.001878 0.002554 0.004527 -3076 1 0.000203 1560.000000 -0.002137 0.000429 0.006642 -3077 1 0.000284 1560.000000 -0.000240 -0.003671 0.007483 -3078 1 0.000225 1560.000000 0.001925 -0.000505 0.006402 -3079 1 0.000218 1560.000000 0.000391 0.002815 0.006257 -3080 1 0.000210 1560.000000 0.000688 0.000919 0.006379 -3081 1 0.000213 1560.000000 0.002501 0.001874 0.009594 -3082 1 0.000210 1560.000000 -0.002094 0.000402 0.000761 -3083 1 0.000256 1560.000000 -0.000907 0.003140 0.009677 -3084 1 0.000243 1560.000000 -0.000946 0.000773 0.005116 -3085 1 0.000264 1560.000000 0.001138 0.000407 0.001197 -3086 1 0.000230 1560.000000 0.000312 -0.003635 0.002753 -3087 1 0.000226 1560.000000 0.000456 -0.003457 0.009765 -3088 1 0.000204 1560.000000 -0.001139 -0.000751 0.005938 -3089 1 0.000215 1560.000000 0.000898 0.000186 0.008912 -3090 1 0.000268 1560.000000 -0.003187 -0.001218 0.008983 -3091 1 0.000259 1560.000000 0.002725 0.000275 0.002136 -3092 1 0.000268 1560.000000 0.001005 -0.003434 0.006638 -3093 1 0.000252 1560.000000 0.001849 -0.001709 0.001680 -3094 1 0.000217 1560.000000 0.000412 -0.000025 0.007934 -3095 1 0.000211 1560.000000 0.001215 0.001366 0.009215 -3096 1 0.000238 1560.000000 -0.001446 0.000922 0.008465 -3097 1 0.000240 1560.000000 0.000529 -0.000123 0.003565 -3098 1 0.000268 1560.000000 0.000650 -0.002930 0.002486 -3099 1 0.000232 1560.000000 0.002488 -0.000590 0.001573 -3100 1 0.000229 1560.000000 -0.000067 0.000728 0.009046 -3101 1 0.000211 1560.000000 0.003546 -0.000738 0.008791 -3102 1 0.000259 1560.000000 -0.001369 -0.003285 0.004965 -3103 1 0.000195 1560.000000 0.000061 0.000844 0.004074 -3104 1 0.000206 1560.000000 0.001142 -0.000915 0.004137 -3105 1 0.000246 1560.000000 0.000415 0.001730 0.006228 -3106 1 0.000238 1560.000000 0.001855 0.000614 0.000962 -3107 1 0.000203 1560.000000 0.001186 0.000971 0.003185 -3108 1 0.000216 1560.000000 0.000151 -0.000678 0.004081 -3109 1 0.000232 1560.000000 0.002925 -0.001239 0.002412 -3110 1 0.000259 1560.000000 0.000371 -0.002045 0.002211 -3111 1 0.000252 1560.000000 -0.002866 0.001998 0.007948 -3112 1 0.000210 1560.000000 -0.002241 -0.002794 0.003801 -3113 1 0.000203 1560.000000 -0.002867 -0.000854 0.004074 -3114 1 0.000213 1560.000000 0.001383 0.000579 0.002135 -3115 1 0.000219 1560.000000 0.000166 -0.000151 0.005063 -3116 1 0.000270 1560.000000 0.001008 0.001757 0.007185 -3117 1 0.000273 1560.000000 -0.002191 0.002742 0.006885 -3118 1 0.000194 1560.000000 -0.000147 0.000445 0.000164 -3119 1 0.000198 1560.000000 -0.000226 0.001784 0.000795 -3120 1 0.000261 1560.000000 0.002055 -0.001032 0.005432 -3121 1 0.000197 1560.000000 -0.000315 0.002903 0.007494 -3122 1 0.000195 1560.000000 -0.001512 0.001163 0.004127 -3123 1 0.000223 1560.000000 0.000044 0.002345 0.007996 -3124 1 0.000195 1560.000000 0.000569 0.000821 0.005211 -3125 1 0.000244 1560.000000 -0.000024 0.000934 0.006991 -3126 1 0.000288 1560.000000 0.001635 0.001565 0.008764 -3127 1 0.000239 1560.000000 0.000777 0.001080 0.005539 -3128 1 0.000206 1560.000000 -0.002648 -0.000141 0.007867 -3129 1 0.000198 1560.000000 0.000278 -0.001853 0.007027 -3130 1 0.000192 1560.000000 0.000290 0.001641 0.003898 -3131 1 0.000204 1560.000000 -0.001201 -0.003547 0.006841 -3132 1 0.000218 1560.000000 0.000573 0.001629 0.005579 -3133 1 0.000272 1560.000000 0.001750 0.002494 0.004954 -3134 1 0.000266 1560.000000 -0.002764 0.002535 0.000357 -3135 1 0.000283 1560.000000 -0.001851 0.003100 0.002513 -3136 1 0.000229 1560.000000 -0.000682 -0.001685 0.009511 -3137 1 0.000207 1560.000000 0.000790 0.000129 0.007787 -3138 1 0.000198 1560.000000 -0.000362 -0.000593 0.003121 -3139 1 0.000262 1560.000000 0.002099 -0.002731 0.006690 -3140 1 0.000199 1560.000000 -0.003614 -0.000599 0.000767 -3141 1 0.000226 1560.000000 -0.000017 0.001738 0.003562 -3142 1 0.000270 1560.000000 -0.000621 -0.000657 0.006177 -3143 1 0.000207 1560.000000 -0.000776 -0.001755 0.005324 -3144 1 0.000192 1560.000000 0.000793 -0.003055 0.001144 -3145 1 0.000268 1560.000000 0.001283 -0.002327 0.002833 -3146 1 0.000226 1560.000000 0.002671 0.000770 0.004687 -3147 1 0.000211 1560.000000 0.001551 -0.003292 0.002419 -3148 1 0.000268 1560.000000 0.001851 -0.001191 0.001921 -3149 1 0.000231 1560.000000 0.000188 0.001317 0.002401 -3150 1 0.000214 1560.000000 -0.000008 0.001632 0.003916 -3151 1 0.000232 1560.000000 0.001165 -0.002764 0.005811 -3152 1 0.000220 1560.000000 -0.001255 0.003183 0.007442 -3153 1 0.000207 1560.000000 0.003782 0.000368 0.008238 -3154 1 0.000241 1560.000000 -0.002704 0.001668 0.002095 -3155 1 0.000237 1560.000000 -0.001514 0.002151 0.002800 -3156 1 0.000214 1560.000000 0.001070 -0.000862 0.009678 -3157 1 0.000211 1560.000000 -0.000630 -0.000446 0.007202 -3158 1 0.000195 1560.000000 -0.001299 0.001962 0.003926 -3159 1 0.000282 1560.000000 -0.000633 -0.000348 0.004415 -3160 1 0.000277 1560.000000 -0.002940 -0.001230 0.009544 -3161 1 0.000208 1560.000000 -0.000745 0.001015 0.005441 -3162 1 0.000253 1560.000000 0.001156 0.002448 0.003007 -3163 1 0.000196 1560.000000 -0.002491 -0.000895 0.005836 -3164 1 0.000218 1560.000000 -0.001743 -0.002957 0.009393 -3165 1 0.000269 1560.000000 -0.001021 -0.000146 0.002028 -3166 1 0.000288 1560.000000 0.003440 -0.001402 0.001263 -3167 1 0.000193 1560.000000 -0.000337 -0.001702 0.005354 -3168 1 0.000237 1560.000000 0.001539 0.002510 0.000947 -3169 1 0.000221 1560.000000 0.002770 -0.001128 0.003982 -3170 1 0.000235 1560.000000 -0.000411 -0.003323 0.002185 -3171 1 0.000276 1560.000000 -0.002746 -0.000056 0.005789 -3172 1 0.000227 1560.000000 0.002512 -0.001262 0.001034 -3173 1 0.000263 1560.000000 0.003274 -0.000171 0.007585 -3174 1 0.000244 1560.000000 -0.001966 0.000009 0.005688 -3175 1 0.000273 1560.000000 -0.000763 0.001212 0.001567 -3176 1 0.000288 1560.000000 0.002447 0.001564 0.005107 -3177 1 0.000268 1560.000000 0.001673 0.000617 0.000311 -3178 1 0.000287 1560.000000 -0.000432 0.000202 0.004260 -3179 1 0.000281 1560.000000 -0.000616 -0.001794 0.000180 -3180 1 0.000263 1560.000000 0.001654 -0.001023 0.007674 -3181 1 0.000214 1560.000000 -0.000917 0.001465 0.006713 -3182 1 0.000226 1560.000000 0.000964 -0.001291 0.003213 -3183 1 0.000202 1560.000000 0.000341 -0.002157 0.004388 -3184 1 0.000237 1560.000000 -0.000775 -0.001163 0.001631 -3185 1 0.000235 1560.000000 -0.001041 -0.000639 0.007667 -3186 1 0.000193 1560.000000 -0.001218 -0.000525 0.008377 -3187 1 0.000231 1560.000000 0.000596 -0.002575 0.001116 -3188 1 0.000234 1560.000000 0.002373 -0.000375 0.003479 -3189 1 0.000247 1560.000000 0.000383 0.000579 0.002779 -3190 1 0.000195 1560.000000 -0.001728 0.000216 0.009583 -3191 1 0.000203 1560.000000 -0.000903 -0.003377 0.009633 -3192 1 0.000225 1560.000000 -0.002405 0.002944 0.005670 -3193 1 0.000226 1560.000000 0.001618 -0.000331 0.008958 -3194 1 0.000276 1560.000000 -0.001022 -0.000580 0.001615 -3195 1 0.000226 1560.000000 0.000743 0.000346 0.000819 -3196 1 0.000204 1560.000000 -0.001936 -0.002894 0.007908 -3197 1 0.000201 1560.000000 0.002526 0.000407 0.002534 -3198 1 0.000236 1560.000000 0.003519 0.000561 0.009054 -3199 1 0.000207 1560.000000 -0.000518 -0.001972 0.008837 -3200 1 0.000272 1560.000000 0.001766 0.000253 0.000140 -3201 1 0.000224 1560.000000 -0.001219 -0.001177 0.007929 -3202 1 0.000197 1560.000000 0.000034 -0.003154 0.000819 -3203 1 0.000196 1560.000000 0.000910 -0.002644 0.008211 -3204 1 0.000237 1560.000000 0.002841 -0.000238 0.009506 -3205 1 0.000213 1560.000000 0.000410 -0.001137 0.009667 -3206 1 0.000194 1560.000000 -0.001721 0.000066 0.003648 -3207 1 0.000231 1560.000000 -0.002830 0.002386 0.004722 -3208 1 0.000275 1560.000000 -0.003256 -0.000237 0.006313 -3209 1 0.000203 1560.000000 -0.000941 -0.000648 0.002176 -3210 1 0.000209 1560.000000 0.003025 0.000087 0.001040 -3211 1 0.000234 1560.000000 0.002953 -0.001509 0.006445 -3212 1 0.000256 1560.000000 0.002367 -0.002566 0.007595 -3213 1 0.000221 1560.000000 0.000099 -0.000459 0.006354 -3214 1 0.000203 1560.000000 0.002292 -0.002004 0.004075 -3215 1 0.000279 1560.000000 0.001732 -0.000857 0.001965 -3216 1 0.000192 1560.000000 0.002896 0.000417 0.007941 -3217 1 0.000193 1560.000000 -0.000365 -0.000812 0.002069 -3218 1 0.000192 1560.000000 0.002111 -0.002397 0.003746 -3219 1 0.000223 1560.000000 0.000038 -0.001875 0.000456 -3220 1 0.000200 1560.000000 0.001949 0.001706 0.009550 -3221 1 0.000196 1560.000000 0.002839 -0.000642 0.000584 -3222 1 0.000260 1560.000000 -0.001161 -0.002329 0.005066 -3223 1 0.000192 1560.000000 0.001848 -0.003043 0.000601 -3224 1 0.000209 1560.000000 0.002043 0.002251 0.004381 -3225 1 0.000263 1560.000000 -0.002320 0.002170 0.003625 -3226 1 0.000254 1560.000000 0.001462 0.000509 0.000152 -3227 1 0.000233 1560.000000 -0.001658 -0.001067 0.000822 -3228 1 0.000202 1560.000000 -0.003634 -0.000392 0.009388 -3229 1 0.000218 1560.000000 0.001581 0.000443 0.005348 -3230 1 0.000241 1560.000000 -0.003116 0.000743 0.004401 -3231 1 0.000226 1560.000000 0.002919 -0.001465 0.001152 -3232 1 0.000287 1560.000000 -0.001836 0.001706 0.008177 -3233 1 0.000261 1560.000000 -0.002822 -0.001496 0.007570 -3234 1 0.000217 1560.000000 0.003457 -0.001326 0.002886 -3235 1 0.000219 1560.000000 0.000814 -0.000911 0.009454 -3236 1 0.000253 1560.000000 0.002859 -0.001600 0.008456 -3237 1 0.000234 1560.000000 0.001143 -0.000354 0.004435 -3238 1 0.000194 1560.000000 -0.000843 -0.001351 0.004794 -3239 1 0.000215 1560.000000 -0.000022 -0.000504 0.004671 -3240 1 0.000220 1560.000000 -0.001166 0.001728 0.003212 -3241 1 0.000279 1560.000000 0.001971 -0.000152 0.000728 -3242 1 0.000271 1560.000000 0.003156 -0.000832 0.004741 -3243 1 0.000199 1560.000000 0.000197 0.000075 0.007140 -3244 1 0.000210 1560.000000 -0.001173 0.001735 0.007738 -3245 1 0.000216 1560.000000 0.000292 0.000381 0.000260 -3246 1 0.000198 1560.000000 0.002914 0.000619 0.003032 -3247 1 0.000284 1560.000000 0.000185 0.002379 0.006962 -3248 1 0.000225 1560.000000 -0.000991 -0.002304 0.008797 -3249 1 0.000195 1560.000000 0.002287 0.002830 0.009614 -3250 1 0.000205 1560.000000 -0.002264 0.001984 0.002563 -3251 1 0.000212 1560.000000 0.001039 -0.002847 0.002568 -3252 1 0.000235 1560.000000 -0.000852 -0.002560 0.005964 -3253 1 0.000195 1560.000000 0.002012 -0.000344 0.006909 -3254 1 0.000193 1560.000000 -0.001610 0.000040 0.009499 -3255 1 0.000193 1560.000000 -0.000554 -0.000642 0.002627 -3256 1 0.000261 1560.000000 0.002453 -0.001008 0.009537 -3257 1 0.000211 1560.000000 0.000103 -0.003748 0.003203 -3258 1 0.000282 1560.000000 -0.000194 0.001038 0.004199 -3259 1 0.000279 1560.000000 0.002829 0.000813 0.007138 -3260 1 0.000201 1560.000000 0.000955 0.001954 0.001184 -3261 1 0.000192 1560.000000 -0.002841 -0.001057 0.004964 -3262 1 0.000237 1560.000000 -0.001315 -0.001316 0.009462 -3263 1 0.000206 1560.000000 -0.002981 0.000968 0.002842 -3264 1 0.000280 1560.000000 -0.001679 0.002784 0.006676 -3265 1 0.000195 1560.000000 -0.000956 -0.002543 0.005066 -3266 1 0.000226 1560.000000 0.000794 0.000527 0.003926 -3267 1 0.000267 1560.000000 0.001873 0.002413 0.007103 -3268 1 0.000268 1560.000000 0.001804 -0.002845 0.007411 -3269 1 0.000232 1560.000000 0.002543 0.002556 0.007517 -3270 1 0.000212 1560.000000 0.000241 0.003607 0.001462 -3271 1 0.000271 1560.000000 -0.002221 0.000301 0.006953 -3272 1 0.000254 1560.000000 0.002229 -0.000060 0.003758 -3273 1 0.000199 1560.000000 0.000381 0.001926 0.009795 -3274 1 0.000207 1560.000000 0.003514 -0.000764 0.008553 -3275 1 0.000233 1560.000000 0.001431 -0.001218 0.009025 -3276 1 0.000195 1560.000000 0.003439 -0.000738 0.001456 -3277 1 0.000283 1560.000000 0.001223 0.003570 0.007350 -3278 1 0.000211 1560.000000 -0.001040 -0.002927 0.002365 -3279 1 0.000246 1560.000000 -0.000872 0.003702 0.001005 -3280 1 0.000202 1560.000000 -0.001966 0.001088 0.005208 -3281 1 0.000230 1560.000000 0.001070 -0.000427 0.005897 -3282 1 0.000232 1560.000000 -0.002185 0.002681 0.002590 -3283 1 0.000227 1560.000000 0.000763 0.002054 0.005948 -3284 1 0.000241 1560.000000 0.001224 -0.001516 0.000571 -3285 1 0.000211 1560.000000 0.000774 0.000787 0.002614 -3286 1 0.000222 1560.000000 0.000567 0.003347 0.001430 -3287 1 0.000202 1560.000000 -0.000705 0.000616 0.008132 -3288 1 0.000226 1560.000000 -0.000024 -0.000881 0.007731 -3289 1 0.000212 1560.000000 0.001384 -0.003418 0.006508 -3290 1 0.000255 1560.000000 0.000535 -0.001653 0.003212 -3291 1 0.000217 1560.000000 -0.000025 -0.002297 0.004382 -3292 1 0.000254 1560.000000 -0.000392 0.001282 0.007705 -3293 1 0.000228 1560.000000 -0.001599 -0.001060 0.009756 -3294 1 0.000287 1560.000000 -0.001879 0.001532 0.008579 -3295 1 0.000201 1560.000000 -0.000590 -0.000255 0.009789 -3296 1 0.000217 1560.000000 -0.000431 -0.000502 0.007616 -3297 1 0.000231 1560.000000 0.001120 -0.001959 0.001737 -3298 1 0.000239 1560.000000 -0.002008 0.001783 0.007696 -3299 1 0.000273 1560.000000 0.003123 0.000923 0.000376 -3300 1 0.000280 1560.000000 -0.001116 0.000712 0.003781 -3301 1 0.000231 1560.000000 0.000677 -0.001224 0.001681 -3302 1 0.000210 1560.000000 -0.000387 0.001355 0.000333 -3303 1 0.000213 1560.000000 -0.000995 -0.001804 0.005927 -3304 1 0.000252 1560.000000 -0.000311 -0.003196 0.005703 -3305 1 0.000233 1560.000000 0.001581 0.001965 0.009091 -3306 1 0.000214 1560.000000 0.002408 0.002450 0.008312 -3307 1 0.000253 1560.000000 0.002895 -0.002002 0.001448 -3308 1 0.000213 1560.000000 0.001380 0.000719 0.000549 -3309 1 0.000216 1560.000000 0.000735 0.000353 0.008763 -3310 1 0.000236 1560.000000 0.001941 0.003304 0.009196 -3311 1 0.000232 1560.000000 0.000777 0.000206 0.006166 -3312 1 0.000244 1560.000000 0.002186 -0.000965 0.009728 -3313 1 0.000231 1560.000000 0.000447 -0.002034 0.001721 -3314 1 0.000214 1560.000000 0.001212 0.000214 0.009737 -3315 1 0.000217 1560.000000 -0.000744 0.001112 0.002625 -3316 1 0.000192 1560.000000 0.000975 -0.003366 0.006003 -3317 1 0.000215 1560.000000 0.002894 0.002138 0.004134 -3318 1 0.000212 1560.000000 -0.001382 0.002721 0.009721 -3319 1 0.000276 1560.000000 0.001709 0.003201 0.001945 -3320 1 0.000247 1560.000000 -0.001342 0.003031 0.005011 -3321 1 0.000207 1560.000000 -0.000236 0.001431 0.006959 -3322 1 0.000210 1560.000000 0.000489 0.000904 0.005799 -3323 1 0.000214 1560.000000 -0.000319 0.003013 0.006698 -3324 1 0.000288 1560.000000 -0.001606 0.002208 0.006046 -3325 1 0.000271 1560.000000 -0.001988 -0.003005 0.003755 -3326 1 0.000219 1560.000000 0.000194 0.000758 0.006043 -3327 1 0.000217 1560.000000 0.000023 -0.002474 0.000434 -3328 1 0.000258 1560.000000 -0.000419 -0.003752 0.002864 -3329 1 0.000253 1560.000000 -0.001633 0.000186 0.006047 -3330 1 0.000197 1560.000000 0.003178 -0.000807 0.002596 -3331 1 0.000246 1560.000000 0.000258 -0.000260 0.007424 -3332 1 0.000247 1560.000000 0.000044 -0.001211 0.009126 -3333 1 0.000228 1560.000000 -0.000907 -0.002330 0.004344 -3334 1 0.000239 1560.000000 -0.000698 -0.003568 0.004453 -3335 1 0.000208 1560.000000 -0.000087 0.000368 0.001083 -3336 1 0.000284 1560.000000 0.001625 -0.001939 0.007709 -3337 1 0.000208 1560.000000 -0.000004 -0.001433 0.000633 -3338 1 0.000204 1560.000000 -0.000155 0.002144 0.006876 -3339 1 0.000249 1560.000000 0.000734 -0.000789 0.006011 -3340 1 0.000201 1560.000000 0.000476 -0.002835 0.009152 -3341 1 0.000251 1560.000000 -0.001666 -0.001987 0.008796 -3342 1 0.000239 1560.000000 0.003130 -0.001449 0.002656 -3343 1 0.000226 1560.000000 -0.000016 -0.003409 0.003075 -3344 1 0.000240 1560.000000 0.000577 0.000607 0.004827 -3345 1 0.000277 1560.000000 0.001459 -0.000232 0.005086 -3346 1 0.000239 1560.000000 0.001640 0.000290 0.002639 -3347 1 0.000210 1560.000000 -0.000235 -0.001798 0.004631 -3348 1 0.000226 1560.000000 0.001038 -0.000107 0.000910 -3349 1 0.000278 1560.000000 0.003675 -0.001153 0.008650 -3350 1 0.000267 1560.000000 -0.000455 0.003790 0.000159 -3351 1 0.000260 1560.000000 0.002389 0.001593 0.009697 -3352 1 0.000197 1560.000000 0.001269 0.003246 0.002933 -3353 1 0.000210 1560.000000 0.001812 0.002559 0.008708 -3354 1 0.000220 1560.000000 0.001473 0.000311 0.009374 -3355 1 0.000196 1560.000000 -0.001707 0.000917 0.009704 -3356 1 0.000251 1560.000000 -0.000890 0.000708 0.008243 -3357 1 0.000241 1560.000000 0.000282 0.000008 0.001444 -3358 1 0.000238 1560.000000 0.003750 -0.000107 0.001485 -3359 1 0.000231 1560.000000 -0.001330 0.002820 0.008955 -3360 1 0.000287 1560.000000 0.001443 -0.001062 0.002616 -3361 1 0.000228 1560.000000 0.001994 0.000631 0.002408 -3362 1 0.000217 1560.000000 -0.000572 -0.003314 0.001401 -3363 1 0.000204 1560.000000 -0.001719 0.002783 0.001762 -3364 1 0.000195 1560.000000 0.001137 -0.001558 0.009090 -3365 1 0.000247 1560.000000 -0.000200 0.000746 0.002680 -3366 1 0.000200 1560.000000 0.000765 -0.000433 0.006371 -3367 1 0.000239 1560.000000 0.001462 -0.000486 0.002071 -3368 1 0.000222 1560.000000 -0.000533 0.001813 0.003377 -3369 1 0.000256 1560.000000 0.000732 -0.002097 0.001996 -3370 1 0.000203 1560.000000 -0.000852 -0.000248 0.007924 -3371 1 0.000287 1560.000000 0.000094 0.003528 0.000989 -3372 1 0.000279 1560.000000 0.000924 0.002876 0.000194 -3373 1 0.000277 1560.000000 0.002341 -0.001034 0.000947 -3374 1 0.000207 1560.000000 0.000667 0.000858 0.008386 -3375 1 0.000276 1560.000000 0.001577 -0.000464 0.005482 -3376 1 0.000194 1560.000000 0.002089 -0.002576 0.006865 -3377 1 0.000263 1560.000000 -0.001122 0.000563 0.002407 -3378 1 0.000193 1560.000000 0.000514 -0.000227 0.001321 -3379 1 0.000284 1560.000000 0.001215 0.001818 0.001984 -3380 1 0.000273 1560.000000 0.003658 -0.000138 0.008510 -3381 1 0.000255 1560.000000 -0.002300 -0.000932 0.007321 -3382 1 0.000210 1560.000000 0.000100 0.001994 0.002995 -3383 1 0.000206 1560.000000 -0.000179 0.000071 0.003216 -3384 1 0.000217 1560.000000 -0.001195 0.003232 0.008333 -3385 1 0.000204 1560.000000 -0.002934 0.000154 0.002854 -3386 1 0.000283 1560.000000 -0.003254 -0.000491 0.005301 -3387 1 0.000203 1560.000000 0.001506 0.000387 0.006329 -3388 1 0.000258 1560.000000 -0.000053 -0.000673 0.003110 -3389 1 0.000245 1560.000000 -0.000442 -0.001392 0.004766 -3390 1 0.000198 1560.000000 0.002730 0.000349 0.006175 -3391 1 0.000202 1560.000000 0.001212 0.003215 0.006742 -3392 1 0.000195 1560.000000 0.000445 0.001864 0.007674 -3393 1 0.000194 1560.000000 0.000595 -0.003187 0.006023 -3394 1 0.000200 1560.000000 -0.001917 0.002530 0.005480 -3395 1 0.000192 1560.000000 -0.002444 -0.000853 0.000908 -3396 1 0.000227 1560.000000 -0.001735 0.001866 0.006664 -3397 1 0.000239 1560.000000 0.002750 -0.001518 0.001354 -3398 1 0.000226 1560.000000 -0.002691 -0.000723 0.002909 -3399 1 0.000205 1560.000000 -0.001736 -0.001458 0.008292 -3400 1 0.000250 1560.000000 0.000935 -0.001649 0.002485 -3401 1 0.000229 1560.000000 -0.001424 -0.001661 0.000984 -3402 1 0.000208 1560.000000 0.002482 0.001226 0.006512 -3403 1 0.000199 1560.000000 0.001262 0.003233 0.002491 -3404 1 0.000199 1560.000000 -0.002817 0.000004 0.009378 -3405 1 0.000198 1560.000000 -0.000355 0.000391 0.005605 -3406 1 0.000249 1560.000000 0.003284 0.001291 0.001609 -3407 1 0.000237 1560.000000 0.000690 0.002191 0.002425 -3408 1 0.000287 1560.000000 0.002418 0.001210 0.007905 -3409 1 0.000194 1560.000000 -0.000211 0.002743 0.001631 -3410 1 0.000195 1560.000000 -0.000686 0.000111 0.005072 -3411 1 0.000251 1560.000000 -0.000522 0.000177 0.000439 -3412 1 0.000196 1560.000000 0.002033 0.000821 0.003432 -3413 1 0.000233 1560.000000 -0.001413 -0.001099 0.004633 -3414 1 0.000197 1560.000000 0.000116 -0.002412 0.007525 -3415 1 0.000207 1560.000000 0.002213 0.001052 0.007731 -3416 1 0.000253 1560.000000 -0.001825 0.003044 0.001682 -3417 1 0.000214 1560.000000 -0.001209 0.000038 0.001806 -3418 1 0.000209 1560.000000 0.001428 0.000166 0.007330 -3419 1 0.000223 1560.000000 0.000583 0.000082 0.006894 -3420 1 0.000205 1560.000000 -0.002221 0.000518 0.001920 -3421 1 0.000236 1560.000000 0.003450 -0.001595 0.006891 -3422 1 0.000201 1560.000000 -0.001545 0.001118 0.003614 -3423 1 0.000286 1560.000000 0.002973 -0.000760 0.004474 -3424 1 0.000265 1560.000000 0.002816 -0.001004 0.002961 -3425 1 0.000214 1560.000000 0.003510 -0.000161 0.005300 -3426 1 0.000243 1560.000000 0.003223 -0.000879 0.006598 -3427 1 0.000283 1560.000000 0.000216 0.001215 0.008071 -3428 1 0.000249 1560.000000 0.002440 -0.002910 0.007468 -3429 1 0.000236 1560.000000 0.002032 -0.002649 0.006063 -3430 1 0.000214 1560.000000 -0.001959 0.001396 0.002407 -3431 1 0.000223 1560.000000 -0.003157 0.000074 0.005234 -3432 1 0.000214 1560.000000 -0.000853 0.002808 0.005409 -3433 1 0.000223 1560.000000 -0.000730 -0.001746 0.006883 -3434 1 0.000286 1560.000000 -0.001594 -0.000883 0.003641 -3435 1 0.000211 1560.000000 0.000946 -0.002983 0.003036 -3436 1 0.000211 1560.000000 0.002204 -0.002125 0.007115 -3437 1 0.000195 1560.000000 0.001524 -0.002443 0.000230 -3438 1 0.000262 1560.000000 -0.000855 -0.001550 0.007536 -3439 1 0.000227 1560.000000 -0.001980 -0.002806 0.009053 -3440 1 0.000246 1560.000000 0.000271 -0.000729 0.002844 -3441 1 0.000267 1560.000000 -0.000558 0.001039 0.007132 -3442 1 0.000270 1560.000000 0.000423 -0.002568 0.003954 -3443 1 0.000210 1560.000000 -0.000602 0.000365 0.003710 -3444 1 0.000195 1560.000000 0.002491 -0.000551 0.002494 -3445 1 0.000245 1560.000000 0.001774 0.000900 0.001154 -3446 1 0.000224 1560.000000 -0.003396 -0.000617 0.000670 -3447 1 0.000261 1560.000000 -0.001615 0.000550 0.006029 -3448 1 0.000209 1560.000000 0.000840 -0.002625 0.002769 -3449 1 0.000254 1560.000000 0.002845 -0.001732 0.006567 -3450 1 0.000193 1560.000000 -0.002392 -0.000089 0.001023 -3451 1 0.000217 1560.000000 0.003256 0.001882 0.001328 -3452 1 0.000226 1560.000000 -0.002311 0.000390 0.007200 -3453 1 0.000216 1560.000000 -0.002207 0.002757 0.003640 -3454 1 0.000256 1560.000000 0.002329 -0.002773 0.001072 -3455 1 0.000265 1560.000000 -0.001524 -0.002726 0.001930 -3456 1 0.000259 1560.000000 -0.000086 0.003273 0.008327 -3457 1 0.000284 1560.000000 0.001742 0.003048 0.007361 -3458 1 0.000277 1560.000000 0.000867 -0.000623 0.005833 -3459 1 0.000286 1560.000000 -0.000724 -0.003506 0.007399 -3460 1 0.000208 1560.000000 0.002938 0.000368 0.006124 -3461 1 0.000249 1560.000000 -0.000588 -0.000500 0.009583 -3462 1 0.000219 1560.000000 -0.001629 0.000991 0.007590 -3463 1 0.000232 1560.000000 0.003389 -0.001423 0.007838 -3464 1 0.000197 1560.000000 0.003310 -0.001913 0.008864 -3465 1 0.000223 1560.000000 0.003018 -0.002172 0.002765 -3466 1 0.000256 1560.000000 0.002732 -0.002356 0.002234 -3467 1 0.000280 1560.000000 0.000359 -0.003000 0.001774 -3468 1 0.000203 1560.000000 -0.002493 0.000454 0.007370 -3469 1 0.000214 1560.000000 0.002447 -0.000752 0.004808 -3470 1 0.000247 1560.000000 -0.001350 0.001363 0.006990 -3471 1 0.000261 1560.000000 -0.002219 0.001843 0.001213 -3472 1 0.000261 1560.000000 0.002849 -0.000111 0.006479 -3473 1 0.000215 1560.000000 0.000073 -0.000223 0.003311 -3474 1 0.000233 1560.000000 -0.002182 -0.000067 0.007016 -3475 1 0.000202 1560.000000 -0.000288 -0.002318 0.003584 -3476 1 0.000194 1560.000000 0.000324 -0.000112 0.006769 -3477 1 0.000253 1560.000000 0.001047 -0.001397 0.003662 -3478 1 0.000267 1560.000000 0.001486 0.000313 0.003548 -3479 1 0.000195 1560.000000 -0.002910 -0.001086 0.004623 -3480 1 0.000217 1560.000000 -0.001375 0.002327 0.008041 -3481 1 0.000215 1560.000000 -0.001248 0.002916 0.002336 -3482 1 0.000260 1560.000000 0.000277 -0.000990 0.007594 -3483 1 0.000230 1560.000000 0.000175 -0.000720 0.001818 -3484 1 0.000236 1560.000000 -0.001775 -0.001734 0.002631 -3485 1 0.000236 1560.000000 0.001739 0.001399 0.009351 -3486 1 0.000253 1560.000000 0.000299 -0.000209 0.004559 -3487 1 0.000192 1560.000000 -0.000018 -0.003226 0.007903 -3488 1 0.000239 1560.000000 -0.001659 0.002755 0.002498 -3489 1 0.000197 1560.000000 -0.003382 0.001492 0.003750 -3490 1 0.000233 1560.000000 0.001896 0.001934 0.007348 -3491 1 0.000235 1560.000000 -0.000428 0.001495 0.000148 -3492 1 0.000270 1560.000000 0.002387 -0.001593 0.009370 -3493 1 0.000250 1560.000000 -0.002402 0.001481 0.001961 -3494 1 0.000249 1560.000000 -0.000724 0.002207 0.007528 -3495 1 0.000271 1560.000000 0.001462 0.001942 0.002655 -3496 1 0.000192 1560.000000 0.000813 -0.002107 0.000228 -3497 1 0.000223 1560.000000 -0.000322 -0.000154 0.008606 -3498 1 0.000209 1560.000000 0.002855 -0.000592 0.004245 -3499 1 0.000245 1560.000000 0.000852 -0.000834 0.007286 -3500 1 0.000212 1560.000000 -0.002267 0.000855 0.009055 -3501 1 0.000194 1560.000000 -0.001326 -0.003281 0.005830 -3502 1 0.000229 1560.000000 0.001837 -0.001026 0.003622 -3503 1 0.000198 1560.000000 -0.000831 -0.003721 0.001019 -3504 1 0.000218 1560.000000 0.002670 -0.001681 0.006884 -3505 1 0.000286 1560.000000 -0.002233 0.000660 0.004479 -3506 1 0.000224 1560.000000 -0.000625 0.001355 0.003873 -3507 1 0.000199 1560.000000 0.000994 0.002978 0.002350 -3508 1 0.000200 1560.000000 -0.002810 -0.001561 0.007882 -3509 1 0.000258 1560.000000 0.000878 -0.002430 0.006622 -3510 1 0.000204 1560.000000 -0.000673 0.000727 0.007578 -3511 1 0.000201 1560.000000 0.001402 0.002857 0.003837 -3512 1 0.000215 1560.000000 -0.001307 0.003075 0.002859 -3513 1 0.000228 1560.000000 0.001464 0.002494 0.006747 -3514 1 0.000224 1560.000000 -0.000333 -0.001352 0.005224 -3515 1 0.000207 1560.000000 0.002321 0.000423 0.006731 -3516 1 0.000273 1560.000000 -0.000169 0.000617 0.004741 -3517 1 0.000233 1560.000000 -0.002618 -0.002678 0.000793 -3518 1 0.000222 1560.000000 0.001212 -0.002698 0.009364 -3519 1 0.000235 1560.000000 -0.001351 0.001479 0.002880 -3520 1 0.000232 1560.000000 -0.002593 0.000246 0.009321 -3521 1 0.000278 1560.000000 -0.001406 -0.000983 0.002005 -3522 1 0.000249 1560.000000 0.001515 -0.002525 0.006594 -3523 1 0.000267 1560.000000 0.002576 0.000443 0.008034 -3524 1 0.000201 1560.000000 0.002346 0.001754 0.002214 -3525 1 0.000205 1560.000000 -0.002302 -0.002205 0.007875 -3526 1 0.000274 1560.000000 -0.000475 0.000564 0.006867 -3527 1 0.000196 1560.000000 -0.001323 0.000325 0.003373 -3528 1 0.000242 1560.000000 -0.001756 0.001629 0.007438 -3529 1 0.000229 1560.000000 -0.001103 -0.001671 0.000691 -3530 1 0.000258 1560.000000 -0.001754 0.002132 0.004787 -3531 1 0.000193 1560.000000 -0.001813 0.000372 0.006890 -3532 1 0.000197 1560.000000 0.000505 0.000373 0.004395 -3533 1 0.000246 1560.000000 0.000558 0.001943 0.001806 -3534 1 0.000195 1560.000000 -0.001230 0.002209 0.002834 -3535 1 0.000223 1560.000000 0.000055 -0.001420 0.003191 -3536 1 0.000262 1560.000000 -0.002015 0.000434 0.005125 -3537 1 0.000250 1560.000000 -0.000334 -0.000607 0.007003 -3538 1 0.000234 1560.000000 0.000868 0.000353 0.004849 -3539 1 0.000229 1560.000000 0.000075 0.001569 0.004296 -3540 1 0.000211 1560.000000 0.000201 0.000881 0.001214 -3541 1 0.000236 1560.000000 0.000953 -0.000777 0.001586 -3542 1 0.000232 1560.000000 0.000512 0.001911 0.001042 -3543 1 0.000241 1560.000000 0.001682 0.000942 0.009795 -3544 1 0.000271 1560.000000 0.002261 0.000451 0.002663 -3545 1 0.000221 1560.000000 -0.002617 0.000207 0.002552 -3546 1 0.000208 1560.000000 -0.001723 -0.002672 0.006104 -3547 1 0.000286 1560.000000 -0.000341 -0.003184 0.006388 -3548 1 0.000253 1560.000000 0.001359 0.001430 0.008498 -3549 1 0.000212 1560.000000 -0.001672 0.001319 0.007050 -3550 1 0.000214 1560.000000 -0.000044 0.000487 0.008953 -3551 1 0.000203 1560.000000 0.003522 -0.001222 0.005689 -3552 1 0.000202 1560.000000 0.001812 -0.000021 0.007422 -3553 1 0.000228 1560.000000 -0.000220 -0.000269 0.009370 -3554 1 0.000230 1560.000000 -0.000577 0.001106 0.009396 -3555 1 0.000195 1560.000000 0.001446 0.003501 0.001788 -3556 1 0.000210 1560.000000 -0.002248 -0.002113 0.009798 -3557 1 0.000283 1560.000000 0.001567 -0.000044 0.009240 -3558 1 0.000194 1560.000000 -0.000585 -0.000597 0.004133 -3559 1 0.000205 1560.000000 0.001419 -0.002208 0.000704 -3560 1 0.000284 1560.000000 0.000183 0.001401 0.003290 -3561 1 0.000204 1560.000000 -0.000552 -0.001440 0.001982 -3562 1 0.000267 1560.000000 0.000111 0.001335 0.002897 -3563 1 0.000207 1560.000000 0.002226 0.002087 0.006870 -3564 1 0.000194 1560.000000 0.001915 -0.001971 0.003942 -3565 1 0.000269 1560.000000 0.001101 -0.003209 0.006347 -3566 1 0.000219 1560.000000 0.002351 -0.002542 0.005242 -3567 1 0.000200 1560.000000 -0.001929 0.002862 0.001919 -3568 1 0.000214 1560.000000 0.000094 -0.000181 0.005609 -3569 1 0.000231 1560.000000 0.000478 -0.001654 0.000167 -3570 1 0.000273 1560.000000 0.000278 -0.001789 0.000246 -3571 1 0.000206 1560.000000 0.000638 0.001051 0.008304 -3572 1 0.000203 1560.000000 -0.000754 -0.001239 0.000682 -3573 1 0.000216 1560.000000 -0.001371 0.000430 0.000816 -3574 1 0.000239 1560.000000 -0.000387 -0.000848 0.003303 -3575 1 0.000234 1560.000000 0.000054 -0.000959 0.008589 -3576 1 0.000203 1560.000000 -0.001265 -0.003135 0.003740 -3577 1 0.000269 1560.000000 0.001610 0.000312 0.008851 -3578 1 0.000273 1560.000000 0.001832 0.002339 0.006568 -3579 1 0.000281 1560.000000 -0.000222 -0.001363 0.005999 -3580 1 0.000221 1560.000000 -0.002833 0.001544 0.003411 -3581 1 0.000247 1560.000000 -0.002431 0.001555 0.005317 -3582 1 0.000251 1560.000000 -0.000839 -0.001944 0.007480 -3583 1 0.000228 1560.000000 0.000766 -0.000423 0.003748 -3584 1 0.000195 1560.000000 -0.000118 0.002295 0.009537 -3585 1 0.000233 1560.000000 -0.003422 0.000066 0.004229 -3586 1 0.000240 1560.000000 0.000256 -0.003495 0.004356 -3587 1 0.000210 1560.000000 0.001917 0.000762 0.004347 -3588 1 0.000250 1560.000000 0.001445 -0.001509 0.001176 -3589 1 0.000264 1560.000000 0.000026 -0.001474 0.002898 -3590 1 0.000209 1560.000000 -0.000842 0.000289 0.002713 -3591 1 0.000257 1560.000000 0.000198 0.000957 0.006794 -3592 1 0.000242 1560.000000 0.000629 -0.000807 0.009165 -3593 1 0.000247 1560.000000 0.001129 0.001093 0.009403 -3594 1 0.000236 1560.000000 -0.000674 0.000525 0.008985 -3595 1 0.000203 1560.000000 -0.002907 0.001861 0.001063 -3596 1 0.000275 1560.000000 -0.001834 0.000635 0.005761 -3597 1 0.000252 1560.000000 0.001320 -0.000268 0.005972 -3598 1 0.000210 1560.000000 0.003643 0.000267 0.008565 -3599 1 0.000196 1560.000000 -0.000722 0.001300 0.004256 -3600 1 0.000209 1560.000000 0.000133 -0.000050 0.007312 -3601 1 0.000234 1560.000000 0.003177 0.000783 0.000656 -3602 1 0.000261 1560.000000 -0.001896 -0.002100 0.001347 -3603 1 0.000208 1560.000000 -0.000191 0.002252 0.002705 -3604 1 0.000250 1560.000000 0.000101 -0.000536 0.005725 -3605 1 0.000206 1560.000000 -0.001386 -0.003172 0.001442 -3606 1 0.000282 1560.000000 0.001652 0.000573 0.009296 -3607 1 0.000285 1560.000000 0.000061 0.001215 0.005578 -3608 1 0.000196 1560.000000 0.000625 -0.001549 0.004031 -3609 1 0.000212 1560.000000 -0.000282 0.002344 0.000350 -3610 1 0.000217 1560.000000 -0.001431 0.003318 0.004027 -3611 1 0.000226 1560.000000 0.001610 -0.003503 0.009578 -3612 1 0.000253 1560.000000 0.001930 -0.003060 0.004121 -3613 1 0.000243 1560.000000 -0.001657 -0.001112 0.006710 -3614 1 0.000192 1560.000000 -0.002961 -0.000935 0.005415 -3615 1 0.000281 1560.000000 0.001171 0.002481 0.000956 -3616 1 0.000233 1560.000000 -0.003151 0.000304 0.004811 -3617 1 0.000278 1560.000000 0.003492 -0.001595 0.009396 -3618 1 0.000222 1560.000000 0.000175 0.000439 0.002787 -3619 1 0.000274 1560.000000 0.001949 -0.002479 0.004985 -3620 1 0.000254 1560.000000 -0.000479 -0.003655 0.005129 -3621 1 0.000256 1560.000000 -0.003290 -0.001657 0.003438 -3622 1 0.000208 1560.000000 -0.002394 0.002669 0.001641 -3623 1 0.000245 1560.000000 0.001105 0.001292 0.007979 -3624 1 0.000224 1560.000000 -0.000023 -0.003008 0.006248 -3625 1 0.000219 1560.000000 0.001310 -0.001765 0.000873 -3626 1 0.000233 1560.000000 0.000774 -0.000699 0.003548 -3627 1 0.000284 1560.000000 -0.000153 0.000928 0.002445 -3628 1 0.000240 1560.000000 0.002285 -0.000920 0.007224 -3629 1 0.000209 1560.000000 -0.002572 0.001943 0.006905 -3630 1 0.000244 1560.000000 -0.000112 0.001668 0.007893 -3631 1 0.000193 1560.000000 -0.001266 0.000137 0.003675 -3632 1 0.000216 1560.000000 0.001653 -0.000380 0.002215 -3633 1 0.000257 1560.000000 0.001754 0.001791 0.005963 -3634 1 0.000214 1560.000000 -0.002799 -0.001494 0.003946 -3635 1 0.000252 1560.000000 0.001822 -0.003123 0.004408 -3636 1 0.000266 1560.000000 0.003384 0.001467 0.006465 -3637 1 0.000215 1560.000000 0.000598 -0.001200 0.002951 -3638 1 0.000218 1560.000000 -0.000552 0.000681 0.008651 -3639 1 0.000229 1560.000000 0.001342 0.001410 0.006575 -3640 1 0.000281 1560.000000 -0.000880 0.003124 0.000395 -3641 1 0.000200 1560.000000 0.001696 -0.000987 0.007124 -3642 1 0.000230 1560.000000 0.000644 -0.003267 0.009484 -3643 1 0.000217 1560.000000 0.000760 -0.000622 0.006206 -3644 1 0.000272 1560.000000 -0.000491 0.000950 0.005892 -3645 1 0.000276 1560.000000 -0.002175 0.002773 0.004473 -3646 1 0.000213 1560.000000 0.003133 0.000021 0.008311 -3647 1 0.000224 1560.000000 0.002487 -0.000608 0.000806 -3648 1 0.000215 1560.000000 -0.000281 -0.000169 0.002730 -3649 1 0.000277 1560.000000 -0.002064 0.002043 0.001021 -3650 1 0.000229 1560.000000 0.000397 -0.000066 0.004069 -3651 1 0.000212 1560.000000 0.001649 -0.000032 0.006446 -3652 1 0.000201 1560.000000 -0.001022 0.000604 0.000500 -3653 1 0.000215 1560.000000 0.003170 -0.002159 0.000611 -3654 1 0.000273 1560.000000 0.001879 -0.000470 0.003484 -3655 1 0.000196 1560.000000 0.002744 0.001629 0.003585 -3656 1 0.000241 1560.000000 0.001387 0.003258 0.002106 -3657 1 0.000274 1560.000000 -0.002968 -0.002005 0.004413 -3658 1 0.000259 1560.000000 -0.001183 0.001526 0.005266 -3659 1 0.000266 1560.000000 0.000637 -0.003304 0.007462 -3660 1 0.000198 1560.000000 -0.000962 0.003470 0.003641 -3661 1 0.000224 1560.000000 -0.001822 0.001411 0.006424 -3662 1 0.000234 1560.000000 0.002424 0.001553 0.004776 -3663 1 0.000198 1560.000000 0.000573 0.000682 0.000601 -3664 1 0.000224 1560.000000 0.000715 0.000159 0.002790 -3665 1 0.000251 1560.000000 0.000593 -0.000222 0.007435 -3666 1 0.000255 1560.000000 -0.000865 0.002069 0.004210 -3667 1 0.000230 1560.000000 0.000765 -0.001457 0.004822 -3668 1 0.000195 1560.000000 0.000867 -0.003120 0.004672 -3669 1 0.000212 1560.000000 0.001407 -0.002820 0.008663 -3670 1 0.000261 1560.000000 0.000268 -0.001550 0.001852 -3671 1 0.000255 1560.000000 -0.001801 0.000053 0.004478 -3672 1 0.000286 1560.000000 -0.001377 -0.001531 0.002170 -3673 1 0.000200 1560.000000 0.000177 -0.002565 0.004768 -3674 1 0.000274 1560.000000 0.002096 -0.002882 0.008826 -3675 1 0.000209 1560.000000 0.000509 -0.002766 0.002043 -3676 1 0.000214 1560.000000 -0.000306 -0.001791 0.000948 -3677 1 0.000199 1560.000000 -0.002034 -0.001277 0.006619 -3678 1 0.000267 1560.000000 0.000439 0.002586 0.004744 -3679 1 0.000240 1560.000000 -0.000992 0.000861 0.008687 -3680 1 0.000266 1560.000000 0.000803 0.000033 0.001014 -3681 1 0.000234 1560.000000 0.000545 -0.003297 0.001754 -3682 1 0.000221 1560.000000 0.003745 0.000767 0.003171 -3683 1 0.000240 1560.000000 0.002482 -0.000158 0.004476 -3684 1 0.000222 1560.000000 0.001650 -0.001473 0.008897 -3685 1 0.000254 1560.000000 -0.001634 -0.000163 0.009657 -3686 1 0.000200 1560.000000 -0.000522 0.002420 0.000732 -3687 1 0.000284 1560.000000 0.000856 -0.001794 0.006008 -3688 1 0.000234 1560.000000 0.003026 0.001088 0.000634 -3689 1 0.000279 1560.000000 0.002783 0.002350 0.009122 -3690 1 0.000220 1560.000000 -0.000652 -0.000064 0.007972 -3691 1 0.000225 1560.000000 -0.002394 0.002564 0.002902 -3692 1 0.000259 1560.000000 -0.001914 0.001543 0.004739 -3693 1 0.000256 1560.000000 -0.001355 -0.000385 0.008543 -3694 1 0.000287 1560.000000 -0.002850 -0.000052 0.005077 -3695 1 0.000287 1560.000000 0.000617 -0.000492 0.004524 -3696 1 0.000210 1560.000000 -0.002315 -0.001005 0.005984 -3697 1 0.000205 1560.000000 -0.000415 0.000445 0.000734 -3698 1 0.000249 1560.000000 0.002520 0.000153 0.004004 -3699 1 0.000266 1560.000000 0.000540 -0.002767 0.005279 -3700 1 0.000266 1560.000000 -0.001962 0.002492 0.000744 -3701 1 0.000209 1560.000000 -0.000407 -0.000208 0.006206 -3702 1 0.000194 1560.000000 0.003364 0.000941 0.004984 -3703 1 0.000230 1560.000000 0.000351 0.001820 0.007940 -3704 1 0.000211 1560.000000 -0.000561 0.000287 0.008613 -3705 1 0.000240 1560.000000 0.000691 -0.001397 0.009460 -3706 1 0.000250 1560.000000 0.003133 -0.001348 0.008652 -3707 1 0.000193 1560.000000 0.003062 0.002098 0.006666 -3708 1 0.000263 1560.000000 0.000301 0.000145 0.005382 -3709 1 0.000244 1560.000000 -0.002259 -0.001382 0.008931 -3710 1 0.000194 1560.000000 -0.000944 -0.002839 0.000725 -3711 1 0.000261 1560.000000 0.000791 0.000319 0.004163 -3712 1 0.000217 1560.000000 0.002463 0.001180 0.002146 -3713 1 0.000249 1560.000000 0.000632 -0.000120 0.005483 -3714 1 0.000198 1560.000000 0.000349 -0.002320 0.008309 -3715 1 0.000230 1560.000000 0.000696 0.002069 0.003220 -3716 1 0.000193 1560.000000 -0.000732 -0.001223 0.000330 -3717 1 0.000232 1560.000000 -0.000408 0.000114 0.009253 -3718 1 0.000205 1560.000000 0.000501 0.001965 0.008765 -3719 1 0.000195 1560.000000 0.002657 -0.000737 0.003560 -3720 1 0.000227 1560.000000 0.001411 -0.000983 0.005381 -3721 1 0.000277 1560.000000 -0.002888 0.000559 0.005522 -3722 1 0.000194 1560.000000 -0.002879 0.000635 0.003505 -3723 1 0.000193 1560.000000 -0.002124 -0.000446 0.007051 -3724 1 0.000247 1560.000000 0.002717 -0.000444 0.007407 -3725 1 0.000215 1560.000000 -0.001713 0.002368 0.009813 -3726 1 0.000223 1560.000000 0.000036 -0.001924 0.009644 -3727 1 0.000209 1560.000000 0.001815 0.000800 0.002050 -3728 1 0.000207 1560.000000 -0.001476 -0.000145 0.008567 -3729 1 0.000270 1560.000000 -0.002040 0.000370 0.002623 -3730 1 0.000204 1560.000000 0.002979 -0.001715 0.008840 -3731 1 0.000203 1560.000000 0.002478 -0.000129 0.009436 -3732 1 0.000264 1560.000000 0.001523 0.003145 0.006220 -3733 1 0.000287 1560.000000 -0.003309 0.000051 0.000708 -3734 1 0.000243 1560.000000 -0.003568 -0.001130 0.005256 -3735 1 0.000265 1560.000000 -0.000901 -0.002389 0.008328 -3736 1 0.000211 1560.000000 0.000040 -0.001910 0.002011 -3737 1 0.000204 1560.000000 0.000405 -0.002089 0.008688 -3738 1 0.000284 1560.000000 0.002624 0.001253 0.001799 -3739 1 0.000203 1560.000000 -0.000456 -0.000711 0.000295 -3740 1 0.000223 1560.000000 -0.001063 -0.001954 0.002679 -3741 1 0.000215 1560.000000 -0.001047 -0.001249 0.007418 -3742 1 0.000222 1560.000000 -0.000439 -0.001309 0.006911 -3743 1 0.000236 1560.000000 0.000555 -0.002387 0.002629 -3744 1 0.000245 1560.000000 0.003147 0.000943 0.004889 -3745 1 0.000284 1560.000000 0.000347 0.000164 0.006137 -3746 1 0.000223 1560.000000 -0.001462 0.002136 0.008590 -3747 1 0.000270 1560.000000 -0.003105 0.002086 0.003200 -3748 1 0.000223 1560.000000 -0.000447 -0.003410 0.009228 -3749 1 0.000197 1560.000000 -0.000248 0.000375 0.008891 -3750 1 0.000202 1560.000000 -0.000093 -0.002220 0.008237 -3751 1 0.000202 1560.000000 0.001656 0.000994 0.009527 -3752 1 0.000197 1560.000000 -0.000957 -0.003096 0.002696 -3753 1 0.000214 1560.000000 -0.000424 -0.002839 0.001858 -3754 1 0.000258 1560.000000 -0.000777 -0.000359 0.001499 -3755 1 0.000255 1560.000000 -0.003230 -0.000184 0.002195 -3756 1 0.000284 1560.000000 0.000508 0.001383 0.006395 -3757 1 0.000234 1560.000000 -0.002951 -0.000290 0.000538 -3758 1 0.000249 1560.000000 0.000653 -0.002940 0.006435 -3759 1 0.000195 1560.000000 -0.000256 -0.002179 0.007250 -3760 1 0.000222 1560.000000 0.000492 -0.003617 0.006223 -3761 1 0.000206 1560.000000 0.000662 -0.002318 0.009721 -3762 1 0.000258 1560.000000 -0.001765 -0.003052 0.006491 -3763 1 0.000200 1560.000000 -0.000049 -0.000064 0.005074 -3764 1 0.000211 1560.000000 -0.003300 -0.000987 0.005437 -3765 1 0.000208 1560.000000 -0.002346 0.001563 0.001309 -3766 1 0.000221 1560.000000 0.001038 0.002927 0.004677 -3767 1 0.000210 1560.000000 -0.002857 -0.000667 0.005361 -3768 1 0.000202 1560.000000 -0.002559 0.000271 0.006267 -3769 1 0.000196 1560.000000 0.001424 -0.001733 0.008014 -3770 1 0.000217 1560.000000 0.000763 -0.001697 0.007602 -3771 1 0.000204 1560.000000 0.000308 0.001263 0.006735 -3772 1 0.000227 1560.000000 0.000305 -0.000155 0.002029 -3773 1 0.000286 1560.000000 0.000920 -0.003727 0.007116 -3774 1 0.000224 1560.000000 -0.002051 0.001185 0.005424 -3775 1 0.000256 1560.000000 0.001516 0.003452 0.008234 -3776 1 0.000279 1560.000000 0.000542 -0.000905 0.005864 -3777 1 0.000218 1560.000000 -0.001943 0.001655 0.008940 -3778 1 0.000247 1560.000000 0.003214 -0.001246 0.006094 -3779 1 0.000255 1560.000000 -0.003324 -0.000076 0.006991 -3780 1 0.000199 1560.000000 -0.001096 0.001963 0.004239 -3781 1 0.000222 1560.000000 0.002086 0.001772 0.006602 -3782 1 0.000196 1560.000000 0.002569 0.001504 0.008986 -3783 1 0.000256 1560.000000 -0.002852 0.002366 0.001276 -3784 1 0.000208 1560.000000 0.000402 0.000753 0.009140 -3785 1 0.000275 1560.000000 0.002643 0.000467 0.003903 -3786 1 0.000281 1560.000000 0.000398 -0.001866 0.001343 -3787 1 0.000246 1560.000000 0.001421 -0.001763 0.004715 -3788 1 0.000239 1560.000000 0.002286 0.000616 0.006042 -3789 1 0.000216 1560.000000 0.003152 -0.000498 0.008052 -3790 1 0.000268 1560.000000 -0.001984 0.001906 0.002708 -3791 1 0.000229 1560.000000 0.001751 -0.001486 0.001899 -3792 1 0.000252 1560.000000 -0.000599 0.001685 0.006383 -3793 1 0.000209 1560.000000 0.000662 0.000965 0.003112 -3794 1 0.000283 1560.000000 -0.001462 0.000890 0.007975 -3795 1 0.000287 1560.000000 -0.001300 0.003045 0.007891 -3796 1 0.000214 1560.000000 0.002412 -0.001845 0.001993 -3797 1 0.000230 1560.000000 -0.002275 -0.002417 0.003398 -3798 1 0.000196 1560.000000 -0.000155 0.001450 0.008440 -3799 1 0.000200 1560.000000 -0.000862 -0.002288 0.003723 -3800 1 0.000271 1560.000000 0.001921 -0.000539 0.007708 -3801 1 0.000244 1560.000000 0.000894 0.001367 0.008456 -3802 1 0.000199 1560.000000 0.000322 0.002508 0.003044 -3803 1 0.000202 1560.000000 0.000244 0.000852 0.004444 -3804 1 0.000277 1560.000000 -0.001287 0.000814 0.001079 -3805 1 0.000235 1560.000000 -0.000060 -0.000997 0.003216 -3806 1 0.000252 1560.000000 0.002661 0.002262 0.001282 -3807 1 0.000206 1560.000000 0.002420 0.001228 0.002955 -3808 1 0.000225 1560.000000 -0.001317 0.001531 0.004779 -3809 1 0.000215 1560.000000 -0.001351 -0.001378 0.007470 -3810 1 0.000233 1560.000000 0.002745 0.000646 0.001274 -3811 1 0.000234 1560.000000 0.001352 -0.000509 0.006453 -3812 1 0.000225 1560.000000 0.002611 -0.001661 0.006671 -3813 1 0.000206 1560.000000 0.000368 0.002008 0.006116 -3814 1 0.000255 1560.000000 -0.002682 0.000281 0.007958 -3815 1 0.000231 1560.000000 -0.002628 -0.001005 0.002568 -3816 1 0.000272 1560.000000 0.003577 -0.000111 0.002846 -3817 1 0.000254 1560.000000 -0.000288 -0.000232 0.007921 -3818 1 0.000240 1560.000000 0.001673 0.001144 0.004312 -3819 1 0.000202 1560.000000 -0.000130 0.000574 0.008368 -3820 1 0.000278 1560.000000 0.000414 -0.000999 0.000757 -3821 1 0.000266 1560.000000 -0.000000 0.000922 0.002720 -3822 1 0.000195 1560.000000 -0.001986 -0.000822 0.004713 -3823 1 0.000195 1560.000000 -0.001388 -0.000083 0.000298 -3824 1 0.000275 1560.000000 0.000371 0.000337 0.001124 -3825 1 0.000200 1560.000000 -0.000937 -0.003143 0.009315 -3826 1 0.000285 1560.000000 -0.001148 -0.001632 0.008576 -3827 1 0.000226 1560.000000 -0.001498 0.002216 0.002016 -3828 1 0.000286 1560.000000 0.001623 0.000021 0.001412 -3829 1 0.000245 1560.000000 0.002247 -0.000159 0.005230 -3830 1 0.000259 1560.000000 0.002974 0.001401 0.007453 -3831 1 0.000243 1560.000000 -0.001945 0.002730 0.002112 -3832 1 0.000194 1560.000000 -0.001875 0.002772 0.009686 -3833 1 0.000220 1560.000000 0.000791 -0.000350 0.007603 -3834 1 0.000239 1560.000000 0.001463 -0.003166 0.007629 -3835 1 0.000284 1560.000000 -0.000720 0.003420 0.000732 -3836 1 0.000200 1560.000000 0.002413 0.001677 0.005630 -3837 1 0.000250 1560.000000 -0.000335 -0.000596 0.009280 -3838 1 0.000262 1560.000000 0.002852 -0.000157 0.002694 -3839 1 0.000228 1560.000000 0.002326 -0.002287 0.004048 -3840 1 0.000248 1560.000000 0.002245 0.000056 0.003480 -3841 1 0.000267 1560.000000 0.002228 0.002880 0.005246 -3842 1 0.000256 1560.000000 -0.002585 0.001372 0.007136 -3843 1 0.000281 1560.000000 -0.003530 0.000953 0.005202 -3844 1 0.000206 1560.000000 0.001526 -0.001791 0.001912 -3845 1 0.000200 1560.000000 -0.000137 -0.000711 0.009680 -3846 1 0.000274 1560.000000 -0.001027 -0.002082 0.002144 -3847 1 0.000220 1560.000000 0.002630 -0.001950 0.006649 -3848 1 0.000212 1560.000000 0.002391 -0.000883 0.004175 -3849 1 0.000286 1560.000000 0.001606 0.000225 0.009139 -3850 1 0.000197 1560.000000 0.000365 -0.001723 0.006458 -3851 1 0.000228 1560.000000 0.000632 -0.002936 0.008977 -3852 1 0.000194 1560.000000 -0.002654 -0.000912 0.006000 -3853 1 0.000235 1560.000000 0.002452 0.000590 0.003061 -3854 1 0.000205 1560.000000 0.000348 0.001877 0.003193 -3855 1 0.000198 1560.000000 -0.001223 0.001177 0.009290 -3856 1 0.000240 1560.000000 0.002814 0.002373 0.009806 -3857 1 0.000199 1560.000000 -0.003236 0.001912 0.004898 -3858 1 0.000242 1560.000000 0.002178 -0.000946 0.009391 -3859 1 0.000217 1560.000000 0.001375 0.003596 0.004015 -3860 1 0.000199 1560.000000 0.000242 0.000694 0.007707 -3861 1 0.000266 1560.000000 -0.002175 0.001850 0.008298 -3862 1 0.000214 1560.000000 0.000236 -0.003166 0.008287 -3863 1 0.000236 1560.000000 -0.000736 -0.000371 0.005843 -3864 1 0.000200 1560.000000 -0.002967 -0.001007 0.002617 -3865 1 0.000227 1560.000000 0.003088 -0.000309 0.009688 -3866 1 0.000201 1560.000000 0.002012 -0.000330 0.001647 -3867 1 0.000251 1560.000000 0.003737 -0.000380 0.001960 -3868 1 0.000252 1560.000000 0.001248 -0.000081 0.009793 -3869 1 0.000194 1560.000000 0.002567 -0.000284 0.004681 -3870 1 0.000241 1560.000000 -0.000379 -0.002541 0.009092 -3871 1 0.000215 1560.000000 -0.000947 -0.000753 0.009121 -3872 1 0.000235 1560.000000 0.003041 0.001826 0.009384 -3873 1 0.000260 1560.000000 -0.000439 0.000778 0.009679 -3874 1 0.000288 1560.000000 -0.000677 0.003773 0.001910 -3875 1 0.000244 1560.000000 0.003535 -0.000880 0.008047 -3876 1 0.000240 1560.000000 -0.000347 0.001809 0.001149 -3877 1 0.000236 1560.000000 -0.002496 -0.000402 0.007979 -3878 1 0.000240 1560.000000 0.000015 -0.001554 0.002238 -3879 1 0.000240 1560.000000 -0.003060 -0.001017 0.007845 -3880 1 0.000222 1560.000000 -0.002457 0.002084 0.002662 -3881 1 0.000245 1560.000000 0.000132 0.002298 0.001040 -3882 1 0.000226 1560.000000 0.001132 0.000838 0.000232 -3883 1 0.000221 1560.000000 0.001797 0.002050 0.002849 -3884 1 0.000267 1560.000000 -0.002081 0.000846 0.007550 -3885 1 0.000268 1560.000000 -0.002029 0.000938 0.004233 -3886 1 0.000251 1560.000000 -0.001216 0.002001 0.003517 -3887 1 0.000203 1560.000000 -0.000752 0.000395 0.008752 -3888 1 0.000199 1560.000000 -0.001685 -0.002483 0.003658 -3889 1 0.000217 1560.000000 -0.002379 -0.002912 0.007171 -3890 1 0.000268 1560.000000 0.000329 0.001617 0.007411 -3891 1 0.000245 1560.000000 -0.003140 0.001591 0.008802 -3892 1 0.000272 1560.000000 0.001812 -0.002595 0.008366 -3893 1 0.000280 1560.000000 -0.001941 0.000367 0.007776 -3894 1 0.000197 1560.000000 0.000376 -0.001117 0.007952 -3895 1 0.000213 1560.000000 0.002674 -0.001947 0.007767 -3896 1 0.000230 1560.000000 -0.000077 -0.000167 0.006880 -3897 1 0.000214 1560.000000 0.001097 -0.002747 0.001110 -3898 1 0.000233 1560.000000 0.003095 0.001951 0.002970 -3899 1 0.000195 1560.000000 -0.002407 -0.001451 0.005615 -3900 1 0.000203 1560.000000 -0.000018 -0.001328 0.004200 -3901 1 0.000266 1560.000000 0.002566 -0.002025 0.002629 -3902 1 0.000265 1560.000000 -0.000093 0.002239 0.005430 -3903 1 0.000270 1560.000000 -0.002018 -0.001843 0.003763 -3904 1 0.000233 1560.000000 0.001061 0.002727 0.001726 -3905 1 0.000201 1560.000000 -0.001836 -0.001782 0.001182 -3906 1 0.000277 1560.000000 -0.001510 -0.002374 0.009293 -3907 1 0.000269 1560.000000 -0.001825 -0.000114 0.002934 -3908 1 0.000275 1560.000000 0.000171 0.001428 0.003999 -3909 1 0.000210 1560.000000 0.000464 0.003110 0.008814 -3910 1 0.000227 1560.000000 -0.000836 -0.001394 0.004563 -3911 1 0.000246 1560.000000 0.000397 0.003567 0.008970 -3912 1 0.000197 1560.000000 -0.001327 -0.001240 0.004020 -3913 1 0.000195 1560.000000 0.000688 -0.003686 0.000255 -3914 1 0.000235 1560.000000 -0.001896 -0.002147 0.003910 -3915 1 0.000283 1560.000000 -0.001635 0.003432 0.005550 -3916 1 0.000218 1560.000000 -0.002608 0.000526 0.006155 -3917 1 0.000223 1560.000000 -0.000484 -0.002856 0.009299 -3918 1 0.000207 1560.000000 -0.002295 -0.000662 0.001883 -3919 1 0.000214 1560.000000 -0.000665 -0.001017 0.000144 -3920 1 0.000197 1560.000000 -0.001275 -0.001332 0.008926 -3921 1 0.000208 1560.000000 -0.002009 -0.000318 0.003863 -3922 1 0.000197 1560.000000 -0.000543 -0.002496 0.001071 -3923 1 0.000193 1560.000000 -0.001742 0.001159 0.007547 -3924 1 0.000209 1560.000000 -0.001497 0.001898 0.009115 -3925 1 0.000278 1560.000000 0.001642 -0.000242 0.005851 -3926 1 0.000244 1560.000000 0.003502 0.001046 0.000467 -3927 1 0.000202 1560.000000 0.001733 0.001504 0.004509 -3928 1 0.000227 1560.000000 -0.000164 -0.000350 0.003141 -3929 1 0.000213 1560.000000 0.001825 0.002118 0.009253 -3930 1 0.000225 1560.000000 -0.002168 0.000504 0.007528 -3931 1 0.000204 1560.000000 -0.000151 -0.002392 0.008563 -3932 1 0.000206 1560.000000 -0.001811 0.001799 0.003410 -3933 1 0.000214 1560.000000 0.000962 -0.001609 0.003410 -3934 1 0.000251 1560.000000 0.000952 -0.001466 0.000581 -3935 1 0.000221 1560.000000 -0.001941 -0.002342 0.005155 -3936 1 0.000276 1560.000000 -0.000197 0.002936 0.008932 -3937 1 0.000216 1560.000000 -0.002389 0.001571 0.006744 -3938 1 0.000240 1560.000000 -0.003657 -0.000022 0.005586 -3939 1 0.000260 1560.000000 -0.000855 0.002737 0.000413 -3940 1 0.000268 1560.000000 -0.002874 -0.001213 0.001415 -3941 1 0.000238 1560.000000 0.000942 -0.003028 0.001368 -3942 1 0.000210 1560.000000 -0.000391 -0.000005 0.002625 -3943 1 0.000239 1560.000000 0.000724 -0.002096 0.006718 -3944 1 0.000203 1560.000000 -0.000123 -0.000523 0.003330 -3945 1 0.000245 1560.000000 -0.001896 0.002333 0.003511 -3946 1 0.000211 1560.000000 0.000965 0.002710 0.001347 -3947 1 0.000220 1560.000000 -0.000156 -0.000591 0.008219 -3948 1 0.000217 1560.000000 0.000412 0.002131 0.001177 -3949 1 0.000275 1560.000000 0.002951 -0.001369 0.003999 -3950 1 0.000193 1560.000000 0.001512 0.001083 0.006842 -3951 1 0.000236 1560.000000 -0.001028 0.001124 0.001626 -3952 1 0.000253 1560.000000 0.001793 0.001835 0.008711 -3953 1 0.000202 1560.000000 0.003609 0.001008 0.000759 -3954 1 0.000196 1560.000000 -0.003124 0.000373 0.002006 -3955 1 0.000238 1560.000000 -0.000698 0.001678 0.003669 -3956 1 0.000279 1560.000000 -0.000093 0.001397 0.003881 -3957 1 0.000216 1560.000000 0.001946 -0.001306 0.006363 -3958 1 0.000286 1560.000000 -0.002367 0.000141 0.005100 -3959 1 0.000212 1560.000000 -0.000876 0.000005 0.005231 -3960 1 0.000210 1560.000000 0.000700 -0.000171 0.001965 -3961 1 0.000217 1560.000000 -0.000195 -0.002576 0.005993 -3962 1 0.000275 1560.000000 0.002190 -0.001651 0.000583 -3963 1 0.000280 1560.000000 0.001272 0.000110 0.007938 -3964 1 0.000205 1560.000000 -0.000020 -0.001499 0.009108 -3965 1 0.000227 1560.000000 -0.000217 -0.002760 0.009318 -3966 1 0.000240 1560.000000 0.002088 0.001815 0.003745 -3967 1 0.000231 1560.000000 0.002895 0.001978 0.006331 -3968 1 0.000254 1560.000000 -0.001532 -0.002279 0.008917 -3969 1 0.000269 1560.000000 -0.001054 0.000490 0.000939 -3970 1 0.000275 1560.000000 -0.000720 -0.001574 0.003638 -3971 1 0.000227 1560.000000 0.001277 -0.002861 0.004678 -3972 1 0.000273 1560.000000 0.002279 -0.001126 0.004685 -3973 1 0.000249 1560.000000 -0.001254 0.001202 0.006282 -3974 1 0.000265 1560.000000 0.002726 0.000180 0.009693 -3975 1 0.000198 1560.000000 0.000252 0.003520 0.002605 -3976 1 0.000236 1560.000000 0.000886 -0.000542 0.009689 -3977 1 0.000208 1560.000000 0.001490 0.002299 0.004351 -3978 1 0.000259 1560.000000 -0.002981 0.000012 0.002192 -3979 1 0.000254 1560.000000 -0.003730 0.000287 0.008159 -3980 1 0.000256 1560.000000 -0.003336 0.000941 0.001538 -3981 1 0.000284 1560.000000 0.000570 0.001289 0.009822 -3982 1 0.000206 1560.000000 -0.000527 -0.002658 0.001788 -3983 1 0.000262 1560.000000 -0.001889 0.000626 0.008110 -3984 1 0.000204 1560.000000 -0.000841 -0.003653 0.005840 -3985 1 0.000209 1560.000000 -0.000993 -0.003725 0.005439 -3986 1 0.000230 1560.000000 0.000208 0.001579 0.006072 -3987 1 0.000197 1560.000000 -0.002024 0.001051 0.007992 -3988 1 0.000203 1560.000000 0.000921 0.000810 0.003734 -3989 1 0.000260 1560.000000 0.002239 -0.001263 0.005077 -3990 1 0.000279 1560.000000 -0.000739 0.001228 0.004738 -3991 1 0.000247 1560.000000 0.001538 0.000439 0.001413 -3992 1 0.000210 1560.000000 -0.002302 -0.001845 0.000547 -3993 1 0.000228 1560.000000 0.002939 -0.001969 0.008700 -3994 1 0.000199 1560.000000 0.000824 -0.001158 0.003086 -3995 1 0.000255 1560.000000 -0.000856 -0.001971 0.006740 -3996 1 0.000269 1560.000000 0.001557 0.001178 0.003659 -3997 1 0.000252 1560.000000 0.000430 0.000143 0.001589 -3998 1 0.000197 1560.000000 0.000092 -0.000297 0.002819 -3999 1 0.000280 1560.000000 -0.000431 0.000718 0.001700 -4000 1 0.000202 1560.000000 0.000139 0.001344 0.007500 -4001 1 0.000276 1560.000000 -0.001848 -0.000285 0.006453 -4002 1 0.000212 1560.000000 0.000461 -0.000279 0.001838 -4003 1 0.000196 1560.000000 -0.002539 0.002655 0.006848 -4004 1 0.000217 1560.000000 0.000830 -0.002631 0.001865 -4005 1 0.000239 1560.000000 -0.002419 -0.000300 0.005543 -4006 1 0.000206 1560.000000 -0.000299 0.001953 0.007330 -4007 1 0.000209 1560.000000 0.001220 0.003108 0.008107 -4008 1 0.000222 1560.000000 -0.001503 -0.001265 0.002567 -4009 1 0.000212 1560.000000 -0.000576 0.002468 0.007244 -4010 1 0.000196 1560.000000 -0.000263 -0.002874 0.006507 -4011 1 0.000279 1560.000000 0.000087 -0.003762 0.006365 -4012 1 0.000205 1560.000000 0.000371 -0.001864 0.002924 -4013 1 0.000209 1560.000000 -0.002114 0.002433 0.004148 -4014 1 0.000217 1560.000000 0.000769 0.003486 0.006922 -4015 1 0.000279 1560.000000 -0.001811 -0.003240 0.009242 -4016 1 0.000267 1560.000000 0.002829 0.000158 0.009317 -4017 1 0.000206 1560.000000 0.000225 -0.001303 0.006146 -4018 1 0.000219 1560.000000 0.003048 0.001913 0.009765 -4019 1 0.000197 1560.000000 -0.001922 0.003221 0.000288 -4020 1 0.000235 1560.000000 0.000150 -0.002068 0.006714 -4021 1 0.000207 1560.000000 -0.000750 0.003050 0.002559 -4022 1 0.000265 1560.000000 0.001632 0.002188 0.007504 -4023 1 0.000224 1560.000000 -0.002336 0.000293 0.008991 -4024 1 0.000219 1560.000000 -0.001056 0.000070 0.007253 -4025 1 0.000254 1560.000000 -0.000281 0.002485 0.003388 -4026 1 0.000195 1560.000000 -0.000564 0.000187 0.005767 -4027 1 0.000197 1560.000000 -0.003409 -0.001155 0.009645 -4028 1 0.000269 1560.000000 -0.001596 -0.001380 0.004782 -4029 1 0.000204 1560.000000 0.000529 -0.000518 0.000542 -4030 1 0.000281 1560.000000 0.000456 -0.000384 0.005399 -4031 1 0.000238 1560.000000 0.001088 -0.000577 0.007383 -4032 1 0.000196 1560.000000 -0.002796 -0.000680 0.007440 -4033 1 0.000199 1560.000000 -0.001331 0.000254 0.007043 -4034 1 0.000242 1560.000000 -0.000058 -0.002630 0.008499 -4035 1 0.000251 1560.000000 0.001007 -0.001949 0.007225 -4036 1 0.000248 1560.000000 -0.000083 -0.002306 0.001441 -4037 1 0.000193 1560.000000 -0.000314 -0.000334 0.007426 -4038 1 0.000217 1560.000000 0.001830 -0.001545 0.006996 -4039 1 0.000255 1560.000000 0.001779 0.001144 0.007137 -4040 1 0.000199 1560.000000 0.001443 -0.001913 0.007489 -4041 1 0.000226 1560.000000 0.002486 0.000822 0.006509 -4042 1 0.000245 1560.000000 0.000741 0.001488 0.006072 -4043 1 0.000270 1560.000000 0.001244 -0.003514 0.008740 -4044 1 0.000244 1560.000000 0.001033 -0.003185 0.007325 -4045 1 0.000227 1560.000000 0.000726 -0.001786 0.001225 -4046 1 0.000244 1560.000000 -0.003453 -0.000832 0.000241 -4047 1 0.000229 1560.000000 0.000110 0.003094 0.007674 -4048 1 0.000254 1560.000000 0.002408 0.001410 0.005870 -4049 1 0.000258 1560.000000 -0.003309 0.001389 0.001164 -4050 1 0.000214 1560.000000 -0.001496 0.000978 0.007216 -4051 1 0.000201 1560.000000 0.001884 0.001749 0.007143 -4052 1 0.000239 1560.000000 -0.002396 0.000028 0.001732 -4053 1 0.000199 1560.000000 0.001788 0.001103 0.005511 -4054 1 0.000261 1560.000000 0.000641 0.003777 0.002223 -4055 1 0.000206 1560.000000 -0.000774 0.002254 0.004502 -4056 1 0.000270 1560.000000 -0.000288 0.001745 0.004400 -4057 1 0.000249 1560.000000 -0.003523 0.001030 0.001374 -4058 1 0.000239 1560.000000 -0.001266 -0.001257 0.002681 -4059 1 0.000210 1560.000000 0.000044 0.001506 0.000821 -4060 1 0.000271 1560.000000 0.001119 0.000139 0.005147 -4061 1 0.000262 1560.000000 0.001301 0.000443 0.004528 -4062 1 0.000200 1560.000000 -0.000302 -0.000429 0.006056 -4063 1 0.000267 1560.000000 0.000494 -0.002286 0.006026 -4064 1 0.000266 1560.000000 -0.001466 -0.003426 0.000801 -4065 1 0.000248 1560.000000 0.000245 -0.000689 0.005918 -4066 1 0.000198 1560.000000 -0.001409 -0.001007 0.004938 -4067 1 0.000202 1560.000000 0.001357 0.001771 0.002811 -4068 1 0.000223 1560.000000 -0.002066 -0.000666 0.008355 -4069 1 0.000262 1560.000000 0.002083 -0.001999 0.007591 -4070 1 0.000262 1560.000000 0.001815 -0.003268 0.001525 -4071 1 0.000225 1560.000000 -0.000278 0.003174 0.003270 -4072 1 0.000253 1560.000000 -0.002616 -0.001284 0.008317 -4073 1 0.000286 1560.000000 0.000663 -0.001602 0.008218 -4074 1 0.000227 1560.000000 -0.002480 -0.001935 0.005655 -4075 1 0.000235 1560.000000 0.000463 -0.000742 0.001240 -4076 1 0.000212 1560.000000 -0.001690 0.000086 0.008577 -4077 1 0.000231 1560.000000 -0.002245 0.000001 0.002707 -4078 1 0.000200 1560.000000 0.002200 -0.003057 0.007499 -4079 1 0.000250 1560.000000 -0.000266 0.003329 0.003965 -4080 1 0.000228 1560.000000 0.000296 0.001615 0.007098 -4081 1 0.000233 1560.000000 0.000456 0.000520 0.008292 -4082 1 0.000203 1560.000000 -0.003810 0.000035 0.001866 -4083 1 0.000237 1560.000000 0.000850 0.001720 0.003401 -4084 1 0.000201 1560.000000 -0.000376 0.001639 0.007835 -4085 1 0.000239 1560.000000 0.001307 -0.002310 0.003227 -4086 1 0.000228 1560.000000 -0.001289 0.003186 0.001922 -4087 1 0.000213 1560.000000 0.001129 -0.001966 0.003709 -4088 1 0.000287 1560.000000 0.001049 0.002025 0.000270 -4089 1 0.000261 1560.000000 0.000417 -0.000820 0.000150 -4090 1 0.000247 1560.000000 -0.000568 -0.001604 0.005307 -4091 1 0.000226 1560.000000 0.000434 0.000898 0.000232 -4092 1 0.000250 1560.000000 0.001277 -0.001270 0.004767 -4093 1 0.000276 1560.000000 0.002799 0.000956 0.004147 -4094 1 0.000217 1560.000000 -0.001654 -0.000684 0.007297 -4095 1 0.000205 1560.000000 -0.001720 0.001360 0.008916 -4096 1 0.000202 1560.000000 0.000026 -0.002035 0.000977 -4097 1 0.000222 1560.000000 0.001015 0.003375 0.002576 -4098 1 0.000231 1560.000000 -0.000636 -0.000465 0.003491 -4099 1 0.000247 1560.000000 0.000547 -0.000733 0.005146 -4100 1 0.000255 1560.000000 0.002954 -0.002021 0.005162 -4101 1 0.000235 1560.000000 0.001343 -0.003408 0.009226 -4102 1 0.000193 1560.000000 0.000609 0.001483 0.001555 -4103 1 0.000263 1560.000000 0.001866 0.000313 0.006712 -4104 1 0.000272 1560.000000 -0.003573 -0.000790 0.008937 -4105 1 0.000252 1560.000000 -0.001323 -0.002086 0.002644 -4106 1 0.000216 1560.000000 -0.000562 0.002382 0.000341 -4107 1 0.000270 1560.000000 0.001283 -0.002323 0.008527 -4108 1 0.000231 1560.000000 0.001061 0.000598 0.004609 -4109 1 0.000193 1560.000000 -0.001531 -0.000409 0.005432 -4110 1 0.000235 1560.000000 0.001374 0.000670 0.000975 -4111 1 0.000241 1560.000000 0.002446 -0.000890 0.005850 -4112 1 0.000195 1560.000000 0.002948 -0.000072 0.007568 -4113 1 0.000201 1560.000000 0.001972 0.003085 0.009698 -4114 1 0.000207 1560.000000 -0.000868 -0.001334 0.007916 -4115 1 0.000208 1560.000000 0.002706 -0.001076 0.001431 -4116 1 0.000236 1560.000000 0.001864 0.001516 0.000567 -4117 1 0.000242 1560.000000 0.002281 -0.000084 0.000679 -4118 1 0.000275 1560.000000 -0.001786 -0.000031 0.006787 -4119 1 0.000212 1560.000000 0.000802 0.001305 0.007244 -4120 1 0.000210 1560.000000 0.003586 -0.000435 0.001040 -4121 1 0.000225 1560.000000 0.001187 0.001039 0.009065 -4122 1 0.000256 1560.000000 0.002736 0.001708 0.002212 -4123 1 0.000280 1560.000000 -0.002052 -0.002493 0.007518 -4124 1 0.000207 1560.000000 -0.003285 0.000744 0.003657 -4125 1 0.000195 1560.000000 -0.001634 0.000290 0.009411 -4126 1 0.000210 1560.000000 0.000743 -0.002671 0.009612 -4127 1 0.000214 1560.000000 0.001906 0.001015 0.008520 -4128 1 0.000199 1560.000000 -0.001519 -0.000581 0.005744 -4129 1 0.000242 1560.000000 -0.001078 0.000923 0.006833 -4130 1 0.000242 1560.000000 -0.001742 -0.002102 0.000731 -4131 1 0.000195 1560.000000 -0.001348 -0.000458 0.000244 -4132 1 0.000233 1560.000000 0.000030 0.000794 0.005090 -4133 1 0.000249 1560.000000 -0.002136 -0.002373 0.003963 -4134 1 0.000276 1560.000000 -0.001863 -0.002092 0.005115 -4135 1 0.000253 1560.000000 0.002227 -0.002324 0.000507 -4136 1 0.000288 1560.000000 0.001608 0.002306 0.001677 -4137 1 0.000216 1560.000000 -0.001347 0.002604 0.005968 -4138 1 0.000218 1560.000000 0.000503 0.000492 0.003532 -4139 1 0.000267 1560.000000 -0.002931 -0.002421 0.006887 -4140 1 0.000228 1560.000000 -0.002605 -0.002512 0.005802 -4141 1 0.000209 1560.000000 0.002331 0.000786 0.008775 -4142 1 0.000225 1560.000000 -0.000860 0.002856 0.005913 -4143 1 0.000248 1560.000000 0.002066 -0.000415 0.003741 -4144 1 0.000209 1560.000000 0.001060 0.000160 0.002746 -4145 1 0.000222 1560.000000 -0.001174 -0.002390 0.005930 -4146 1 0.000249 1560.000000 0.001778 -0.000709 0.006769 -4147 1 0.000226 1560.000000 -0.000186 -0.000578 0.002357 -4148 1 0.000202 1560.000000 0.002628 0.002443 0.000748 -4149 1 0.000253 1560.000000 0.001061 -0.000486 0.008116 -4150 1 0.000196 1560.000000 -0.000353 0.000661 0.002465 -4151 1 0.000199 1560.000000 -0.000741 -0.000012 0.009710 -4152 1 0.000203 1560.000000 -0.000563 -0.002873 0.003411 -4153 1 0.000272 1560.000000 0.001931 0.002241 0.008662 -4154 1 0.000240 1560.000000 0.001194 -0.002387 0.008155 -4155 1 0.000239 1560.000000 0.001416 -0.000772 0.008222 -4156 1 0.000286 1560.000000 0.002301 0.002038 0.003406 -4157 1 0.000211 1560.000000 -0.001034 -0.001638 0.002359 -4158 1 0.000228 1560.000000 -0.001318 0.002140 0.005640 -4159 1 0.000267 1560.000000 0.002492 -0.001199 0.007062 -4160 1 0.000207 1560.000000 -0.000799 0.000851 0.003691 -4161 1 0.000231 1560.000000 -0.000106 0.002893 0.004920 -4162 1 0.000197 1560.000000 -0.002290 -0.000360 0.006495 -4163 1 0.000205 1560.000000 -0.002374 -0.001969 0.007208 -4164 1 0.000288 1560.000000 -0.003139 -0.001011 0.005028 -4165 1 0.000265 1560.000000 -0.001371 0.000306 0.003843 -4166 1 0.000209 1560.000000 -0.001790 0.001403 0.005147 -4167 1 0.000209 1560.000000 -0.001032 -0.000089 0.008925 -4168 1 0.000271 1560.000000 -0.000771 0.002537 0.003078 -4169 1 0.000231 1560.000000 0.001514 0.001218 0.002474 -4170 1 0.000234 1560.000000 -0.003397 0.001030 0.001779 -4171 1 0.000278 1560.000000 -0.000070 -0.003786 0.003781 -4172 1 0.000230 1560.000000 0.002034 -0.000629 0.001557 -4173 1 0.000251 1560.000000 0.001462 -0.001676 0.006611 -4174 1 0.000199 1560.000000 -0.001309 -0.001732 0.006794 -4175 1 0.000221 1560.000000 -0.001896 -0.002783 0.003062 -4176 1 0.000282 1560.000000 0.000928 -0.003623 0.001831 -4177 1 0.000286 1560.000000 -0.002584 -0.000994 0.004386 -4178 1 0.000220 1560.000000 -0.002185 -0.000742 0.005063 -4179 1 0.000248 1560.000000 0.003702 0.000691 0.000509 -4180 1 0.000284 1560.000000 0.000017 -0.002882 0.004454 -4181 1 0.000208 1560.000000 0.000029 0.003409 0.003931 -4182 1 0.000195 1560.000000 -0.000390 -0.003823 0.005289 -4183 1 0.000277 1560.000000 0.002829 0.000008 0.006997 -4184 1 0.000194 1560.000000 -0.002452 -0.000716 0.003480 -4185 1 0.000288 1560.000000 0.001000 -0.000946 0.006179 -4186 1 0.000248 1560.000000 0.001726 -0.000684 0.002612 -4187 1 0.000200 1560.000000 0.002260 0.000744 0.008471 -4188 1 0.000225 1560.000000 0.002447 0.002965 0.002061 -4189 1 0.000198 1560.000000 -0.000038 -0.002843 0.008670 -4190 1 0.000283 1560.000000 -0.001048 0.002375 0.005285 -4191 1 0.000195 1560.000000 -0.001072 0.003001 0.008525 -4192 1 0.000263 1560.000000 0.000680 -0.002653 0.004929 -4193 1 0.000198 1560.000000 -0.002189 -0.001198 0.002121 -4194 1 0.000203 1560.000000 0.001905 0.001482 0.007432 -4195 1 0.000273 1560.000000 0.002552 0.002801 0.007357 -4196 1 0.000264 1560.000000 -0.000548 0.001600 0.002479 -4197 1 0.000202 1560.000000 -0.000064 -0.002196 0.006009 -4198 1 0.000205 1560.000000 -0.002400 0.002315 0.002582 -4199 1 0.000266 1560.000000 -0.001452 -0.001477 0.002809 -4200 1 0.000274 1560.000000 -0.000833 0.002783 0.001667 -4201 1 0.000212 1560.000000 -0.000656 0.001132 0.003371 -4202 1 0.000201 1560.000000 -0.003024 -0.001595 0.003875 -4203 1 0.000201 1560.000000 0.000475 -0.000746 0.002599 -4204 1 0.000248 1560.000000 -0.000984 0.000473 0.009092 -4205 1 0.000256 1560.000000 0.002882 -0.001205 0.008790 -4206 1 0.000228 1560.000000 -0.000069 -0.001127 0.002781 -4207 1 0.000208 1560.000000 0.001079 0.000361 0.005818 -4208 1 0.000236 1560.000000 -0.002333 -0.002952 0.008181 -4209 1 0.000208 1560.000000 -0.002064 -0.001157 0.007394 -4210 1 0.000230 1560.000000 -0.001950 0.001349 0.003173 -4211 1 0.000224 1560.000000 -0.003280 -0.000680 0.008168 -4212 1 0.000196 1560.000000 0.003132 0.002149 0.001989 -4213 1 0.000205 1560.000000 -0.002643 0.001549 0.009122 -4214 1 0.000227 1560.000000 -0.000846 -0.002656 0.007715 -4215 1 0.000246 1560.000000 -0.000406 0.000435 0.008464 -4216 1 0.000194 1560.000000 -0.002049 -0.001616 0.004034 -4217 1 0.000265 1560.000000 0.003736 0.000067 0.003556 -4218 1 0.000236 1560.000000 -0.001272 0.002242 0.001513 -4219 1 0.000207 1560.000000 0.000187 0.001125 0.000845 -4220 1 0.000216 1560.000000 -0.001041 0.002305 0.000887 -4221 1 0.000236 1560.000000 0.002819 -0.002042 0.009726 -4222 1 0.000211 1560.000000 0.000054 -0.000652 0.001389 -4223 1 0.000202 1560.000000 0.000512 -0.003443 0.009307 -4224 1 0.000199 1560.000000 -0.000370 0.000745 0.009011 -4225 1 0.000282 1560.000000 0.002210 -0.001294 0.003714 -4226 1 0.000263 1560.000000 -0.001140 -0.000236 0.006296 -4227 1 0.000243 1560.000000 0.000471 0.003042 0.003527 -4228 1 0.000211 1560.000000 -0.002153 -0.003101 0.009619 -4229 1 0.000261 1560.000000 0.002785 0.000082 0.004022 -4230 1 0.000204 1560.000000 0.003172 -0.000162 0.000964 -4231 1 0.000270 1560.000000 0.002337 0.001108 0.009076 -4232 1 0.000256 1560.000000 0.001419 -0.003047 0.000779 -4233 1 0.000195 1560.000000 -0.000310 0.001593 0.006501 -4234 1 0.000270 1560.000000 -0.001960 0.001635 0.002236 -4235 1 0.000194 1560.000000 -0.001088 0.000903 0.000799 -4236 1 0.000261 1560.000000 0.002183 -0.002804 0.002973 -4237 1 0.000213 1560.000000 0.003656 0.000250 0.004895 -4238 1 0.000211 1560.000000 -0.002791 -0.000662 0.008012 -4239 1 0.000223 1560.000000 0.003783 0.000005 0.002598 -4240 1 0.000248 1560.000000 -0.002332 -0.000374 0.002863 -4241 1 0.000229 1560.000000 -0.002936 0.001507 0.008996 -4242 1 0.000223 1560.000000 0.002544 0.001241 0.006776 -4243 1 0.000221 1560.000000 0.001409 -0.001981 0.001570 -4244 1 0.000199 1560.000000 -0.001110 0.000240 0.003229 -4245 1 0.000214 1560.000000 0.003215 0.000750 0.002860 -4246 1 0.000272 1560.000000 0.003100 0.002089 0.000838 -4247 1 0.000220 1560.000000 -0.000039 0.000215 0.005246 -4248 1 0.000250 1560.000000 -0.001046 0.001595 0.004403 -4249 1 0.000213 1560.000000 -0.001959 -0.001300 0.001690 -4250 1 0.000265 1560.000000 -0.000483 0.002031 0.008386 -4251 1 0.000280 1560.000000 0.001720 0.001639 0.007751 -4252 1 0.000269 1560.000000 0.000309 0.001507 0.002664 -4253 1 0.000256 1560.000000 0.002457 -0.001329 0.009711 -4254 1 0.000281 1560.000000 -0.000602 0.001647 0.009292 -4255 1 0.000225 1560.000000 0.001218 -0.002360 0.006357 -4256 1 0.000204 1560.000000 0.001706 -0.001402 0.006477 -4257 1 0.000210 1560.000000 -0.000958 -0.000416 0.003051 -4258 1 0.000214 1560.000000 0.001331 -0.000366 0.001459 -4259 1 0.000246 1560.000000 -0.000842 0.003543 0.009709 -4260 1 0.000224 1560.000000 0.002350 0.001876 0.001416 -4261 1 0.000218 1560.000000 -0.001095 0.003040 0.003059 -4262 1 0.000225 1560.000000 -0.001053 -0.001129 0.003033 -4263 1 0.000272 1560.000000 0.002827 -0.001805 0.000563 -4264 1 0.000193 1560.000000 0.000555 -0.000187 0.007910 -4265 1 0.000244 1560.000000 -0.002123 0.001024 0.003725 -4266 1 0.000232 1560.000000 0.001136 0.001077 0.008338 -4267 1 0.000221 1560.000000 0.003607 0.000279 0.006774 -4268 1 0.000266 1560.000000 0.001531 -0.000840 0.004313 -4269 1 0.000225 1560.000000 -0.002060 0.001256 0.002610 -4270 1 0.000218 1560.000000 0.002796 0.001514 0.005436 -4271 1 0.000214 1560.000000 0.000395 -0.001350 0.003495 -4272 1 0.000210 1560.000000 0.002129 -0.001325 0.004804 -4273 1 0.000275 1560.000000 0.000129 0.002139 0.002780 -4274 1 0.000220 1560.000000 0.000490 -0.000947 0.007797 -4275 1 0.000193 1560.000000 0.000538 0.000844 0.004838 -4276 1 0.000193 1560.000000 0.000222 0.002519 0.001328 -4277 1 0.000232 1560.000000 0.003597 -0.001236 0.005471 -4278 1 0.000273 1560.000000 0.000336 -0.002212 0.009788 -4279 1 0.000193 1560.000000 -0.002013 0.002609 0.009063 -4280 1 0.000284 1560.000000 0.001048 0.000105 0.002331 -4281 1 0.000246 1560.000000 0.000860 0.001289 0.006207 -4282 1 0.000217 1560.000000 -0.001973 -0.000211 0.007682 -4283 1 0.000285 1560.000000 -0.000003 0.001643 0.000407 -4284 1 0.000274 1560.000000 -0.003532 0.000571 0.001099 -4285 1 0.000239 1560.000000 -0.000372 0.002775 0.007090 -4286 1 0.000199 1560.000000 -0.001919 0.000835 0.004462 -4287 1 0.000221 1560.000000 0.000426 -0.002297 0.006618 -4288 1 0.000207 1560.000000 -0.000910 -0.001170 0.004417 -4289 1 0.000248 1560.000000 0.000660 -0.000335 0.000810 -4290 1 0.000266 1560.000000 0.000046 0.001206 0.000536 -4291 1 0.000216 1560.000000 -0.001857 0.000778 0.004690 -4292 1 0.000195 1560.000000 -0.002131 0.001024 0.002756 -4293 1 0.000281 1560.000000 -0.001319 -0.001152 0.005417 -4294 1 0.000273 1560.000000 -0.002728 0.001841 0.005561 -4295 1 0.000285 1560.000000 -0.002119 -0.001713 0.005537 -4296 1 0.000272 1560.000000 0.000770 0.002534 0.009681 -4297 1 0.000194 1560.000000 -0.001216 -0.000671 0.000395 -4298 1 0.000270 1560.000000 -0.003361 -0.001368 0.002406 -4299 1 0.000286 1560.000000 0.001819 -0.001275 0.008996 -4300 1 0.000223 1560.000000 0.000790 -0.001189 0.004846 -4301 1 0.000205 1560.000000 0.001411 -0.000732 0.007865 -4302 1 0.000267 1560.000000 0.001430 -0.000117 0.006158 -4303 1 0.000204 1560.000000 0.000374 0.003321 0.007151 -4304 1 0.000197 1560.000000 -0.002843 -0.001195 0.009759 -4305 1 0.000281 1560.000000 -0.000110 0.003461 0.007256 -4306 1 0.000213 1560.000000 -0.002704 -0.001882 0.003591 -4307 1 0.000240 1560.000000 0.002486 -0.002799 0.006871 -4308 1 0.000211 1560.000000 0.001489 0.002376 0.003823 -4309 1 0.000195 1560.000000 0.000057 -0.000222 0.005228 -4310 1 0.000221 1560.000000 0.001227 0.003008 0.002338 -4311 1 0.000233 1560.000000 0.000751 -0.001151 0.000150 -4312 1 0.000194 1560.000000 -0.001046 -0.001992 0.000819 -4313 1 0.000244 1560.000000 0.000218 -0.001673 0.003252 -4314 1 0.000244 1560.000000 0.002240 0.000551 0.007852 -4315 1 0.000282 1560.000000 -0.001612 0.003040 0.003269 -4316 1 0.000226 1560.000000 0.002943 -0.000241 0.006132 -4317 1 0.000267 1560.000000 0.003301 0.001223 0.009070 -4318 1 0.000217 1560.000000 0.000129 0.002752 0.004820 -4319 1 0.000264 1560.000000 -0.000410 0.002048 0.001298 -4320 1 0.000195 1560.000000 -0.002130 0.002357 0.007015 -4321 1 0.000200 1560.000000 -0.001080 0.003007 0.004346 -4322 1 0.000234 1560.000000 -0.000368 0.003510 0.006674 -4323 1 0.000212 1560.000000 0.000204 0.002841 0.008238 -4324 1 0.000243 1560.000000 0.002298 0.000616 0.009766 -4325 1 0.000285 1560.000000 -0.001482 -0.002631 0.003715 -4326 1 0.000221 1560.000000 -0.000225 0.002483 0.002934 -4327 1 0.000279 1560.000000 -0.003077 -0.000406 0.002077 -4328 1 0.000193 1560.000000 0.000040 0.002708 0.001590 -4329 1 0.000208 1560.000000 0.000497 0.001586 0.003341 -4330 1 0.000220 1560.000000 0.000544 0.003201 0.005466 -4331 1 0.000231 1560.000000 0.002402 -0.001627 0.000283 -4332 1 0.000244 1560.000000 -0.002587 0.002583 0.005609 -4333 1 0.000218 1560.000000 -0.001558 -0.002199 0.002521 -4334 1 0.000228 1560.000000 -0.000735 -0.000500 0.002041 -4335 1 0.000227 1560.000000 0.002128 0.001345 0.001119 -4336 1 0.000197 1560.000000 -0.000344 -0.003696 0.005689 -4337 1 0.000251 1560.000000 0.000568 -0.001709 0.000473 -4338 1 0.000286 1560.000000 0.000291 0.000036 0.002493 -4339 1 0.000215 1560.000000 -0.002835 -0.002340 0.003406 -4340 1 0.000218 1560.000000 0.000214 -0.002300 0.009001 -4341 1 0.000199 1560.000000 -0.000843 -0.000664 0.003287 -4342 1 0.000223 1560.000000 0.000313 0.001895 0.001179 -4343 1 0.000246 1560.000000 -0.000846 0.003516 0.008822 -4344 1 0.000209 1560.000000 0.001229 0.001217 0.003196 -4345 1 0.000252 1560.000000 0.001351 -0.002857 0.004934 -4346 1 0.000195 1560.000000 0.000562 0.001913 0.009365 -4347 1 0.000217 1560.000000 -0.001524 -0.000705 0.008540 -4348 1 0.000210 1560.000000 -0.002799 -0.001731 0.001774 -4349 1 0.000214 1560.000000 0.001931 -0.001764 0.006401 -4350 1 0.000269 1560.000000 -0.002085 -0.002128 0.002039 -4351 1 0.000222 1560.000000 -0.000964 0.001322 0.004970 -4352 1 0.000221 1560.000000 -0.002826 -0.001463 0.003422 -4353 1 0.000235 1560.000000 -0.003473 0.000991 0.004065 -4354 1 0.000201 1560.000000 0.000409 -0.000821 0.003904 -4355 1 0.000263 1560.000000 0.001876 -0.002544 0.000293 -4356 1 0.000275 1560.000000 0.002788 0.002468 0.004506 -4357 1 0.000213 1560.000000 -0.002585 0.001606 0.003386 -4358 1 0.000216 1560.000000 0.001508 -0.001276 0.001528 -4359 1 0.000219 1560.000000 -0.000671 0.000767 0.007887 -4360 1 0.000258 1560.000000 0.001381 -0.002883 0.000242 -4361 1 0.000251 1560.000000 0.000168 -0.003690 0.001198 -4362 1 0.000226 1560.000000 0.002830 -0.001425 0.009224 -4363 1 0.000216 1560.000000 -0.001108 0.001482 0.007401 -4364 1 0.000282 1560.000000 0.000159 -0.000908 0.008858 -4365 1 0.000212 1560.000000 -0.001637 -0.000617 0.005976 -4366 1 0.000288 1560.000000 -0.000792 -0.003362 0.007897 -4367 1 0.000255 1560.000000 -0.002232 -0.002415 0.000767 -4368 1 0.000229 1560.000000 0.001535 -0.000237 0.004094 -4369 1 0.000220 1560.000000 0.000894 0.002274 0.007086 -4370 1 0.000254 1560.000000 -0.000800 0.000121 0.001670 -4371 1 0.000196 1560.000000 0.002237 -0.002590 0.005068 -4372 1 0.000208 1560.000000 -0.000176 -0.001210 0.006568 -4373 1 0.000234 1560.000000 -0.001371 -0.003038 0.000743 -4374 1 0.000273 1560.000000 0.000429 0.000520 0.008926 -4375 1 0.000211 1560.000000 -0.003801 0.000584 0.007856 -4376 1 0.000227 1560.000000 -0.002198 0.001532 0.005763 -4377 1 0.000198 1560.000000 0.000882 0.003027 0.004427 -4378 1 0.000233 1560.000000 0.001027 -0.002041 0.007605 -4379 1 0.000250 1560.000000 -0.003106 -0.001121 0.008315 -4380 1 0.000199 1560.000000 0.000696 0.000371 0.007664 -4381 1 0.000277 1560.000000 -0.003361 0.000139 0.009063 -4382 1 0.000230 1560.000000 -0.000350 0.002365 0.001963 -4383 1 0.000273 1560.000000 0.001882 -0.000224 0.003319 -4384 1 0.000238 1560.000000 -0.002268 -0.000467 0.000136 -4385 1 0.000266 1560.000000 0.001345 0.000967 0.003856 -4386 1 0.000279 1560.000000 0.001088 0.000484 0.002589 -4387 1 0.000264 1560.000000 0.000357 0.000660 0.000843 -4388 1 0.000253 1560.000000 0.002443 0.001115 0.002747 -4389 1 0.000260 1560.000000 -0.001034 0.000569 0.003202 -4390 1 0.000195 1560.000000 -0.002340 -0.000202 0.008889 -4391 1 0.000193 1560.000000 0.000588 0.001002 0.007505 -4392 1 0.000197 1560.000000 0.001874 0.000430 0.000406 -4393 1 0.000224 1560.000000 -0.000118 -0.000132 0.004688 -4394 1 0.000213 1560.000000 -0.000963 -0.002782 0.002017 -4395 1 0.000242 1560.000000 0.000967 -0.002013 0.008045 -4396 1 0.000269 1560.000000 0.001738 -0.000568 0.003790 -4397 1 0.000228 1560.000000 -0.000802 0.000126 0.008785 -4398 1 0.000272 1560.000000 0.000133 0.002368 0.002467 -4399 1 0.000210 1560.000000 0.003152 0.001572 0.009710 -4400 1 0.000264 1560.000000 0.001303 0.000093 0.005782 -4401 1 0.000223 1560.000000 -0.001732 0.000761 0.006367 -4402 1 0.000209 1560.000000 0.000155 -0.000806 0.009397 -4403 1 0.000264 1560.000000 0.001675 0.001748 0.009751 -4404 1 0.000207 1560.000000 0.001678 -0.000720 0.007465 -4405 1 0.000195 1560.000000 0.002645 -0.001531 0.001125 -4406 1 0.000231 1560.000000 -0.001975 -0.001019 0.002404 -4407 1 0.000252 1560.000000 0.003557 0.000344 0.009420 -4408 1 0.000277 1560.000000 0.001769 0.002157 0.004265 -4409 1 0.000214 1560.000000 -0.000241 0.000510 0.001929 -4410 1 0.000204 1560.000000 -0.000337 -0.001298 0.006282 -4411 1 0.000209 1560.000000 -0.000472 -0.001562 0.003587 -4412 1 0.000228 1560.000000 0.000240 0.000401 0.003346 -4413 1 0.000211 1560.000000 0.003309 -0.000096 0.004630 -4414 1 0.000264 1560.000000 0.002989 -0.000422 0.000193 -4415 1 0.000207 1560.000000 0.000922 0.001942 0.002742 -4416 1 0.000239 1560.000000 0.000586 -0.001367 0.003361 -4417 1 0.000201 1560.000000 -0.000121 0.003470 0.006198 -4418 1 0.000254 1560.000000 -0.000471 0.002916 0.002450 -4419 1 0.000194 1560.000000 -0.001238 0.002575 0.007938 -4420 1 0.000221 1560.000000 -0.001962 -0.001192 0.001004 -4421 1 0.000238 1560.000000 0.000559 0.000875 0.004343 -4422 1 0.000209 1560.000000 0.000981 -0.001843 0.009367 -4423 1 0.000214 1560.000000 0.000285 -0.002695 0.000689 -4424 1 0.000215 1560.000000 0.003573 -0.000454 0.007661 -4425 1 0.000284 1560.000000 0.001328 0.000412 0.002422 -4426 1 0.000210 1560.000000 -0.000543 0.000434 0.001322 -4427 1 0.000207 1560.000000 -0.002336 0.002723 0.003418 -4428 1 0.000250 1560.000000 -0.002554 -0.000829 0.006374 -4429 1 0.000237 1560.000000 0.001515 0.000176 0.005905 -4430 1 0.000216 1560.000000 -0.000071 -0.001682 0.007910 -4431 1 0.000225 1560.000000 -0.002187 -0.001340 0.003910 -4432 1 0.000263 1560.000000 -0.003006 -0.000286 0.002622 -4433 1 0.000281 1560.000000 -0.001282 -0.001844 0.001297 -4434 1 0.000201 1560.000000 0.002402 0.001499 0.002663 -4435 1 0.000196 1560.000000 0.000391 0.000905 0.003126 -4436 1 0.000220 1560.000000 -0.002371 0.001124 0.004635 -4437 1 0.000236 1560.000000 -0.000114 -0.002612 0.000688 -4438 1 0.000253 1560.000000 0.001671 -0.002318 0.009437 -4439 1 0.000238 1560.000000 0.000765 -0.000438 0.000260 -4440 1 0.000196 1560.000000 0.001900 -0.001126 0.004747 -4441 1 0.000193 1560.000000 -0.003456 0.001393 0.003565 -4442 1 0.000197 1560.000000 0.000579 0.000452 0.006210 -4443 1 0.000223 1560.000000 -0.002850 -0.000354 0.003241 -4444 1 0.000267 1560.000000 0.001503 -0.001993 0.004190 -4445 1 0.000226 1560.000000 0.000255 0.000089 0.001037 -4446 1 0.000211 1560.000000 0.002500 0.002689 0.008841 -4447 1 0.000281 1560.000000 0.001808 0.002047 0.006210 -4448 1 0.000275 1560.000000 -0.000650 -0.002708 0.002410 -4449 1 0.000194 1560.000000 -0.003425 -0.000514 0.003481 -4450 1 0.000246 1560.000000 0.000839 0.002344 0.006576 -4451 1 0.000246 1560.000000 -0.000318 0.000841 0.005072 -4452 1 0.000256 1560.000000 -0.001974 0.001806 0.005987 -4453 1 0.000254 1560.000000 -0.000719 -0.002742 0.003650 -4454 1 0.000204 1560.000000 -0.002402 -0.000190 0.006470 -4455 1 0.000193 1560.000000 0.003504 -0.001588 0.008825 -4456 1 0.000208 1560.000000 0.001051 -0.000198 0.004798 -4457 1 0.000281 1560.000000 -0.002111 0.001483 0.009570 -4458 1 0.000201 1560.000000 0.001066 -0.000680 0.004655 -4459 1 0.000260 1560.000000 0.000780 -0.003637 0.003807 -4460 1 0.000224 1560.000000 0.001418 -0.002383 0.003878 -4461 1 0.000206 1560.000000 0.001292 0.000958 0.000543 -4462 1 0.000225 1560.000000 0.000293 0.002314 0.008804 -4463 1 0.000214 1560.000000 -0.001005 0.000836 0.007371 -4464 1 0.000214 1560.000000 0.000611 0.000780 0.002883 -4465 1 0.000262 1560.000000 -0.002777 -0.001451 0.008971 -4466 1 0.000207 1560.000000 0.001515 0.001307 0.003029 -4467 1 0.000253 1560.000000 0.000884 -0.001820 0.005528 -4468 1 0.000231 1560.000000 -0.001282 -0.000828 0.008570 -4469 1 0.000269 1560.000000 -0.000217 0.001762 0.008572 -4470 1 0.000267 1560.000000 -0.000447 0.001300 0.006527 -4471 1 0.000274 1560.000000 -0.003368 -0.000576 0.006362 -4472 1 0.000220 1560.000000 -0.001705 -0.001913 0.005698 -4473 1 0.000253 1560.000000 0.001081 0.002897 0.005819 -4474 1 0.000225 1560.000000 -0.002567 0.001845 0.002631 -4475 1 0.000217 1560.000000 -0.002339 -0.002174 0.004861 -4476 1 0.000264 1560.000000 -0.002334 -0.000854 0.008258 -4477 1 0.000222 1560.000000 0.000969 -0.001060 0.002652 -4478 1 0.000207 1560.000000 -0.001077 0.002114 0.008691 -4479 1 0.000247 1560.000000 0.001381 0.001630 0.004610 -4480 1 0.000197 1560.000000 0.003077 -0.001854 0.005431 -4481 1 0.000223 1560.000000 0.000167 -0.000779 0.008385 -4482 1 0.000233 1560.000000 0.003077 -0.000844 0.006807 -4483 1 0.000223 1560.000000 0.003438 -0.001514 0.004725 -4484 1 0.000260 1560.000000 -0.001345 0.000270 0.008235 -4485 1 0.000206 1560.000000 -0.002271 -0.002691 0.009678 -4486 1 0.000234 1560.000000 -0.002697 0.002692 0.004510 -4487 1 0.000203 1560.000000 -0.002226 0.002771 0.005387 -4488 1 0.000196 1560.000000 0.002760 0.001782 0.000257 -4489 1 0.000236 1560.000000 -0.003816 0.000410 0.008618 -4490 1 0.000269 1560.000000 0.000890 -0.000428 0.000492 -4491 1 0.000216 1560.000000 -0.001309 -0.000197 0.005072 -4492 1 0.000198 1560.000000 -0.000053 -0.000715 0.005803 -4493 1 0.000202 1560.000000 0.002677 0.001141 0.004238 -4494 1 0.000264 1560.000000 0.001319 0.002278 0.007898 -4495 1 0.000240 1560.000000 -0.002068 0.002958 0.000150 -4496 1 0.000280 1560.000000 0.001103 -0.000893 0.009321 -4497 1 0.000210 1560.000000 0.001571 -0.002267 0.005258 -4498 1 0.000276 1560.000000 0.000524 -0.001468 0.009651 -4499 1 0.000197 1560.000000 -0.000151 0.001983 0.003070 -4500 1 0.000230 1560.000000 -0.000050 -0.000625 0.009238 -4501 1 0.000286 1560.000000 -0.002716 0.000787 0.001822 -4502 1 0.000216 1560.000000 -0.000951 -0.000706 0.006420 -4503 1 0.000209 1560.000000 -0.000717 0.000196 0.008228 -4504 1 0.000234 1560.000000 -0.001690 -0.001541 0.006279 -4505 1 0.000215 1560.000000 0.000541 0.000445 0.005380 -4506 1 0.000244 1560.000000 -0.002519 0.002421 0.003661 -4507 1 0.000207 1560.000000 0.000509 0.001168 0.003593 -4508 1 0.000200 1560.000000 0.003060 -0.001311 0.009519 -4509 1 0.000232 1560.000000 0.001125 0.001705 0.004920 -4510 1 0.000281 1560.000000 -0.002235 -0.002239 0.008823 -4511 1 0.000197 1560.000000 0.000141 -0.001493 0.001227 -4512 1 0.000225 1560.000000 0.002717 0.001076 0.002074 -4513 1 0.000233 1560.000000 0.000364 -0.002685 0.002517 -4514 1 0.000250 1560.000000 0.002077 0.000930 0.006988 -4515 1 0.000225 1560.000000 0.002233 -0.001079 0.007861 -4516 1 0.000288 1560.000000 -0.000403 -0.002849 0.007040 -4517 1 0.000244 1560.000000 0.000411 -0.002405 0.007801 -4518 1 0.000245 1560.000000 -0.003708 -0.000686 0.001274 -4519 1 0.000272 1560.000000 -0.000508 -0.002308 0.008580 -4520 1 0.000206 1560.000000 0.001437 -0.000488 0.009803 -4521 1 0.000207 1560.000000 -0.001864 -0.001941 0.002302 -4522 1 0.000245 1560.000000 -0.001088 0.000328 0.001315 -4523 1 0.000238 1560.000000 -0.001810 -0.002392 0.008666 -4524 1 0.000271 1560.000000 -0.001580 -0.002583 0.006892 -4525 1 0.000206 1560.000000 0.000575 -0.001162 0.009389 -4526 1 0.000245 1560.000000 -0.000831 0.001535 0.004225 -4527 1 0.000280 1560.000000 -0.000826 0.001780 0.007598 -4528 1 0.000247 1560.000000 -0.000880 -0.002288 0.009111 -4529 1 0.000231 1560.000000 -0.002067 0.001128 0.009268 -4530 1 0.000261 1560.000000 0.002554 -0.001228 0.000785 -4531 1 0.000277 1560.000000 0.001421 -0.003497 0.002660 -4532 1 0.000224 1560.000000 0.001363 0.000151 0.002558 -4533 1 0.000214 1560.000000 -0.003522 0.001232 0.006663 -4534 1 0.000199 1560.000000 -0.002504 -0.002011 0.001761 -4535 1 0.000215 1560.000000 -0.000076 0.002372 0.009307 -4536 1 0.000256 1560.000000 0.000788 -0.002903 0.003222 -4537 1 0.000247 1560.000000 -0.002408 -0.001541 0.003162 -4538 1 0.000248 1560.000000 -0.001514 -0.001840 0.001904 -4539 1 0.000211 1560.000000 0.003396 -0.001057 0.005014 -4540 1 0.000227 1560.000000 0.001466 -0.001955 0.009109 -4541 1 0.000205 1560.000000 -0.000670 -0.000777 0.005198 -4542 1 0.000243 1560.000000 0.001490 0.003008 0.003546 -4543 1 0.000222 1560.000000 -0.002818 0.002604 0.006986 -4544 1 0.000219 1560.000000 0.001685 0.000513 0.001626 -4545 1 0.000225 1560.000000 -0.001887 -0.002187 0.008589 -4546 1 0.000244 1560.000000 0.002139 0.002024 0.002084 -4547 1 0.000215 1560.000000 0.002352 0.000667 0.007229 -4548 1 0.000202 1560.000000 -0.000717 -0.000332 0.008405 -4549 1 0.000261 1560.000000 0.001483 0.001985 0.001736 -4550 1 0.000261 1560.000000 -0.001851 0.000283 0.003679 -4551 1 0.000202 1560.000000 0.000099 -0.001023 0.003921 -4552 1 0.000272 1560.000000 -0.000718 0.000724 0.009170 -4553 1 0.000194 1560.000000 -0.001213 0.000188 0.006519 -4554 1 0.000196 1560.000000 0.000227 0.001916 0.002294 -4555 1 0.000194 1560.000000 -0.000535 0.003069 0.001970 -4556 1 0.000212 1560.000000 -0.001578 0.001418 0.005307 -4557 1 0.000201 1560.000000 -0.000822 0.001216 0.006161 -4558 1 0.000232 1560.000000 -0.000174 -0.003822 0.007955 -4559 1 0.000214 1560.000000 -0.002546 -0.000760 0.009289 -4560 1 0.000232 1560.000000 -0.001758 0.001618 0.009818 -4561 1 0.000243 1560.000000 -0.000819 -0.001292 0.002598 -4562 1 0.000239 1560.000000 -0.000625 0.001951 0.000268 -4563 1 0.000209 1560.000000 0.000395 0.002068 0.007084 -4564 1 0.000285 1560.000000 -0.003035 0.000584 0.004196 -4565 1 0.000218 1560.000000 0.000276 -0.001464 0.006752 -4566 1 0.000264 1560.000000 0.000238 -0.002911 0.005072 -4567 1 0.000278 1560.000000 0.003796 0.000022 0.006016 -4568 1 0.000268 1560.000000 0.000622 -0.003656 0.004020 -4569 1 0.000200 1560.000000 0.002991 -0.000895 0.005318 -4570 1 0.000201 1560.000000 0.003063 -0.001147 0.004029 -4571 1 0.000228 1560.000000 0.002905 0.000121 0.002831 -4572 1 0.000267 1560.000000 -0.001995 -0.003161 0.000971 -4573 1 0.000247 1560.000000 0.001320 -0.001438 0.001628 -4574 1 0.000213 1560.000000 0.003339 0.001878 0.002392 -4575 1 0.000285 1560.000000 -0.002883 0.001473 0.001331 -4576 1 0.000253 1560.000000 -0.001554 0.000971 0.002120 -4577 1 0.000222 1560.000000 0.000038 0.001956 0.005868 -4578 1 0.000200 1560.000000 -0.000726 0.003326 0.007564 -4579 1 0.000253 1560.000000 -0.002634 0.001435 0.002763 -4580 1 0.000227 1560.000000 -0.000986 0.000700 0.004004 -4581 1 0.000236 1560.000000 0.002103 0.001682 0.002468 -4582 1 0.000268 1560.000000 -0.001729 0.002798 0.001399 -4583 1 0.000284 1560.000000 -0.001436 0.000979 0.001785 -4584 1 0.000237 1560.000000 0.003005 0.001010 0.002401 -4585 1 0.000267 1560.000000 -0.001165 0.000738 0.007718 -4586 1 0.000223 1560.000000 0.000984 0.003270 0.009544 -4587 1 0.000258 1560.000000 -0.003194 -0.001387 0.003622 -4588 1 0.000196 1560.000000 0.001650 0.003431 0.001592 -4589 1 0.000245 1560.000000 -0.000183 -0.002735 0.004289 -4590 1 0.000208 1560.000000 0.002835 -0.001642 0.002453 -4591 1 0.000217 1560.000000 -0.000174 -0.002659 0.000399 -4592 1 0.000273 1560.000000 0.000676 -0.003157 0.001554 -4593 1 0.000202 1560.000000 0.000226 -0.002353 0.000961 -4594 1 0.000267 1560.000000 -0.002301 0.001215 0.002816 -4595 1 0.000241 1560.000000 0.003082 0.000522 0.009141 -4596 1 0.000286 1560.000000 0.003248 -0.001248 0.003081 -4597 1 0.000250 1560.000000 -0.000583 -0.000408 0.002735 -4598 1 0.000243 1560.000000 -0.001984 0.001328 0.007499 -4599 1 0.000200 1560.000000 0.001395 0.003080 0.009368 -4600 1 0.000281 1560.000000 -0.001074 -0.001925 0.009071 -4601 1 0.000247 1560.000000 -0.001198 0.003401 0.000846 -4602 1 0.000219 1560.000000 -0.001031 0.000210 0.001986 -4603 1 0.000199 1560.000000 -0.000108 0.000520 0.006277 -4604 1 0.000193 1560.000000 -0.000137 0.000123 0.000112 -4605 1 0.000234 1560.000000 -0.001321 -0.001314 0.008175 -4606 1 0.000206 1560.000000 -0.003162 -0.001262 0.005844 -4607 1 0.000202 1560.000000 0.003569 0.000975 0.008186 -4608 1 0.000197 1560.000000 0.001853 -0.001055 0.002604 -4609 1 0.000221 1560.000000 0.001260 -0.000751 0.003330 -4610 1 0.000215 1560.000000 -0.001222 -0.001900 0.002879 -4611 1 0.000195 1560.000000 0.000969 -0.000600 0.008813 -4612 1 0.000212 1560.000000 0.000756 0.001839 0.004654 -4613 1 0.000202 1560.000000 -0.001249 0.001195 0.007850 -4614 1 0.000197 1560.000000 0.000206 -0.001115 0.002137 -4615 1 0.000272 1560.000000 -0.002919 0.001784 0.009819 -4616 1 0.000212 1560.000000 0.000282 -0.000714 0.003450 -4617 1 0.000242 1560.000000 0.000137 0.000772 0.001646 -4618 1 0.000268 1560.000000 0.000915 -0.002745 0.005537 -4619 1 0.000225 1560.000000 -0.002993 0.001000 0.005542 -4620 1 0.000252 1560.000000 -0.001454 -0.000481 0.003225 -4621 1 0.000210 1560.000000 -0.002738 -0.001268 0.003365 -4622 1 0.000197 1560.000000 0.001681 0.001669 0.003006 -4623 1 0.000269 1560.000000 -0.001532 0.001567 0.003704 -4624 1 0.000242 1560.000000 -0.001368 -0.000987 0.003506 -4625 1 0.000206 1560.000000 -0.001261 0.000968 0.003318 -4626 1 0.000223 1560.000000 -0.001544 0.001985 0.002118 -4627 1 0.000246 1560.000000 0.000065 0.000839 0.009594 -4628 1 0.000224 1560.000000 -0.002747 0.000734 0.001557 -4629 1 0.000220 1560.000000 -0.001460 0.003110 0.007505 -4630 1 0.000211 1560.000000 -0.000870 0.000398 0.007365 -4631 1 0.000239 1560.000000 -0.002685 0.002140 0.008777 -4632 1 0.000271 1560.000000 0.001509 -0.002320 0.009148 -4633 1 0.000234 1560.000000 -0.000374 -0.001277 0.005522 -4634 1 0.000200 1560.000000 -0.000150 -0.000849 0.005009 -4635 1 0.000198 1560.000000 -0.000022 0.000231 0.009451 -4636 1 0.000223 1560.000000 0.002564 -0.002128 0.004025 -4637 1 0.000224 1560.000000 0.000843 0.000732 0.000845 -4638 1 0.000221 1560.000000 -0.000186 -0.000409 0.004797 -4639 1 0.000230 1560.000000 0.001287 -0.003309 0.006803 -4640 1 0.000272 1560.000000 0.000508 -0.001872 0.005317 -4641 1 0.000260 1560.000000 -0.000541 0.001239 0.002877 -4642 1 0.000203 1560.000000 -0.000772 0.001658 0.001669 -4643 1 0.000210 1560.000000 -0.000354 0.002978 0.006974 -4644 1 0.000225 1560.000000 -0.001938 0.001819 0.000382 -4645 1 0.000278 1560.000000 0.000824 0.000794 0.004282 -4646 1 0.000219 1560.000000 0.002500 0.002372 0.005055 -4647 1 0.000195 1560.000000 0.001210 -0.002931 0.005300 -4648 1 0.000282 1560.000000 0.001577 -0.002360 0.008815 -4649 1 0.000226 1560.000000 0.000089 -0.000359 0.001056 -4650 1 0.000243 1560.000000 0.000807 -0.003682 0.000612 -4651 1 0.000197 1560.000000 -0.000785 -0.002020 0.002631 -4652 1 0.000201 1560.000000 0.002839 -0.001086 0.006057 -4653 1 0.000275 1560.000000 -0.003429 -0.001233 0.007249 -4654 1 0.000273 1560.000000 -0.003227 0.001630 0.009630 -4655 1 0.000283 1560.000000 0.001615 -0.002976 0.005610 -4656 1 0.000211 1560.000000 0.001523 -0.001036 0.001695 -4657 1 0.000258 1560.000000 0.003526 0.000759 0.004060 -4658 1 0.000217 1560.000000 0.001712 -0.001929 0.000706 -4659 1 0.000195 1560.000000 -0.002704 0.000721 0.006327 -4660 1 0.000214 1560.000000 0.002045 0.001832 0.009192 -4661 1 0.000221 1560.000000 -0.001145 0.002330 0.008389 -4662 1 0.000250 1560.000000 -0.001289 0.000945 0.008936 -4663 1 0.000226 1560.000000 0.001144 -0.001444 0.005952 -4664 1 0.000280 1560.000000 -0.002131 0.000035 0.003383 -4665 1 0.000273 1560.000000 0.003246 -0.000834 0.007679 -4666 1 0.000216 1560.000000 0.002031 -0.000067 0.006542 -4667 1 0.000217 1560.000000 0.000545 0.002047 0.007246 -4668 1 0.000287 1560.000000 0.002870 0.001596 0.004644 -4669 1 0.000201 1560.000000 0.000783 -0.001249 0.006664 -4670 1 0.000207 1560.000000 -0.000170 -0.002014 0.004247 -4671 1 0.000261 1560.000000 -0.002298 0.002440 0.001884 -4672 1 0.000211 1560.000000 -0.003252 -0.000603 0.008531 -4673 1 0.000205 1560.000000 0.003300 0.000916 0.007000 -4674 1 0.000265 1560.000000 0.000851 0.001701 0.000698 -4675 1 0.000210 1560.000000 -0.002456 0.000406 0.002267 -4676 1 0.000263 1560.000000 -0.001561 -0.002972 0.002300 -4677 1 0.000251 1560.000000 -0.002547 -0.001823 0.007428 -4678 1 0.000220 1560.000000 -0.002761 0.000253 0.009652 -4679 1 0.000252 1560.000000 0.001406 -0.003452 0.001081 -4680 1 0.000254 1560.000000 -0.000894 -0.001303 0.008167 -4681 1 0.000202 1560.000000 0.002982 0.001066 0.007962 -4682 1 0.000266 1560.000000 -0.002881 -0.001942 0.001623 -4683 1 0.000276 1560.000000 -0.000524 0.000994 0.002472 -4684 1 0.000258 1560.000000 -0.000893 0.000066 0.008472 -4685 1 0.000258 1560.000000 -0.001292 -0.000659 0.004083 -4686 1 0.000273 1560.000000 -0.002305 0.002105 0.005865 -4687 1 0.000208 1560.000000 0.001061 0.001339 0.006305 -4688 1 0.000211 1560.000000 0.000489 0.000231 0.000132 -4689 1 0.000222 1560.000000 -0.000332 0.001132 0.001260 -4690 1 0.000287 1560.000000 -0.000796 0.000222 0.005684 -4691 1 0.000241 1560.000000 -0.000133 0.002214 0.006252 -4692 1 0.000233 1560.000000 -0.002246 -0.000068 0.001213 -4693 1 0.000276 1560.000000 0.000024 0.000394 0.005041 -4694 1 0.000279 1560.000000 0.000570 0.001761 0.002041 -4695 1 0.000240 1560.000000 0.000311 -0.001077 0.006783 -4696 1 0.000258 1560.000000 -0.000725 -0.002655 0.007030 -4697 1 0.000273 1560.000000 -0.002135 -0.001473 0.001801 -4698 1 0.000264 1560.000000 -0.003148 -0.001771 0.004665 -4699 1 0.000288 1560.000000 0.002258 -0.000615 0.008196 -4700 1 0.000192 1560.000000 -0.000100 0.001215 0.002794 -4701 1 0.000251 1560.000000 0.001780 0.002999 0.002949 -4702 1 0.000244 1560.000000 0.001363 -0.000230 0.004841 -4703 1 0.000213 1560.000000 -0.000494 -0.000081 0.001244 -4704 1 0.000238 1560.000000 0.003325 0.001709 0.004968 -4705 1 0.000209 1560.000000 0.000423 0.003492 0.007750 -4706 1 0.000203 1560.000000 0.002816 -0.002434 0.001051 -4707 1 0.000239 1560.000000 -0.001187 0.002236 0.002575 -4708 1 0.000237 1560.000000 -0.000946 -0.002950 0.003402 -4709 1 0.000196 1560.000000 -0.000877 0.000099 0.007714 -4710 1 0.000238 1560.000000 -0.000037 0.000449 0.009534 -4711 1 0.000281 1560.000000 0.000715 -0.000202 0.006305 -4712 1 0.000219 1560.000000 -0.003433 0.000587 0.006932 -4713 1 0.000217 1560.000000 -0.002307 -0.000738 0.003168 -4714 1 0.000222 1560.000000 -0.001666 0.001766 0.003913 -4715 1 0.000219 1560.000000 -0.001093 -0.003042 0.001987 -4716 1 0.000228 1560.000000 -0.000848 0.000095 0.002204 -4717 1 0.000225 1560.000000 0.001204 -0.001403 0.006512 -4718 1 0.000218 1560.000000 -0.000958 -0.001735 0.000280 -4719 1 0.000203 1560.000000 0.000268 0.000498 0.001809 -4720 1 0.000200 1560.000000 0.001530 0.001803 0.001918 -4721 1 0.000257 1560.000000 -0.003202 -0.001710 0.005656 -4722 1 0.000247 1560.000000 -0.001529 -0.001026 0.008988 -4723 1 0.000242 1560.000000 -0.001880 0.002504 0.002290 -4724 1 0.000216 1560.000000 -0.001529 0.002408 0.000835 -4725 1 0.000195 1560.000000 0.000853 0.000316 0.003526 -4726 1 0.000212 1560.000000 0.003111 0.002273 0.003550 -4727 1 0.000283 1560.000000 -0.002589 0.001982 0.006478 -4728 1 0.000253 1560.000000 -0.001515 -0.002141 0.006896 -4729 1 0.000247 1560.000000 0.002028 -0.001455 0.006150 -4730 1 0.000208 1560.000000 -0.001095 -0.001220 0.001041 -4731 1 0.000238 1560.000000 -0.000373 -0.002321 0.001650 -4732 1 0.000282 1560.000000 -0.002511 0.002084 0.000691 -4733 1 0.000251 1560.000000 -0.002897 0.000773 0.007453 -4734 1 0.000197 1560.000000 -0.001380 0.002579 0.005712 -4735 1 0.000207 1560.000000 0.001911 -0.003253 0.006404 -4736 1 0.000279 1560.000000 0.000138 0.001386 0.008904 -4737 1 0.000234 1560.000000 -0.003187 -0.000924 0.002022 -4738 1 0.000220 1560.000000 0.000168 0.000193 0.002854 -4739 1 0.000194 1560.000000 -0.000919 0.002252 0.009201 -4740 1 0.000265 1560.000000 -0.000478 0.003514 0.006191 -4741 1 0.000210 1560.000000 -0.000543 0.000733 0.008307 -4742 1 0.000283 1560.000000 0.001590 -0.000781 0.003587 -4743 1 0.000229 1560.000000 0.002619 -0.002370 0.004358 -4744 1 0.000213 1560.000000 0.000343 0.001714 0.009733 -4745 1 0.000200 1560.000000 -0.002579 0.001580 0.000734 -4746 1 0.000203 1560.000000 -0.001380 0.000567 0.004443 -4747 1 0.000228 1560.000000 0.003187 0.001355 0.006315 -4748 1 0.000233 1560.000000 0.000371 0.002282 0.002675 -4749 1 0.000202 1560.000000 0.001462 0.000981 0.006239 -4750 1 0.000258 1560.000000 -0.001605 -0.001866 0.009267 -4751 1 0.000213 1560.000000 0.001011 -0.002838 0.008479 -4752 1 0.000217 1560.000000 0.000594 -0.002205 0.008175 -4753 1 0.000211 1560.000000 0.001441 -0.001285 0.009319 -4754 1 0.000196 1560.000000 -0.001602 -0.000916 0.001480 -4755 1 0.000277 1560.000000 0.000662 -0.001576 0.003712 -4756 1 0.000275 1560.000000 -0.002774 -0.002260 0.001186 -4757 1 0.000220 1560.000000 -0.001526 -0.001700 0.007733 -4758 1 0.000209 1560.000000 0.000559 0.001472 0.000563 -4759 1 0.000213 1560.000000 0.003420 0.000954 0.002729 -4760 1 0.000212 1560.000000 -0.000104 0.003626 0.001424 -4761 1 0.000197 1560.000000 -0.002624 0.001004 0.005945 -4762 1 0.000198 1560.000000 0.001352 -0.001651 0.009350 -4763 1 0.000263 1560.000000 0.000958 0.001850 0.005082 -4764 1 0.000286 1560.000000 -0.002650 -0.000587 0.007670 -4765 1 0.000218 1560.000000 -0.000969 0.002797 0.001326 -4766 1 0.000254 1560.000000 0.000022 0.002867 0.003604 -4767 1 0.000277 1560.000000 -0.002260 -0.000725 0.007012 -4768 1 0.000203 1560.000000 0.000717 0.001824 0.004079 -4769 1 0.000207 1560.000000 -0.000341 0.000086 0.007257 -4770 1 0.000233 1560.000000 0.000847 -0.001137 0.001929 -4771 1 0.000267 1560.000000 -0.001900 -0.000957 0.009248 -4772 1 0.000259 1560.000000 -0.000019 0.000925 0.006051 -4773 1 0.000249 1560.000000 0.000622 -0.000984 0.008510 -4774 1 0.000256 1560.000000 0.001121 0.000377 0.003542 -4775 1 0.000224 1560.000000 0.001849 0.001588 0.006803 -4776 1 0.000206 1560.000000 0.000543 0.002988 0.007593 -4777 1 0.000288 1560.000000 -0.002585 0.000976 0.004194 -4778 1 0.000288 1560.000000 0.001978 -0.000905 0.004480 -4779 1 0.000279 1560.000000 0.000770 0.002619 0.001646 -4780 1 0.000205 1560.000000 -0.001832 0.002018 0.002087 -4781 1 0.000247 1560.000000 -0.000421 -0.001119 0.009412 -4782 1 0.000194 1560.000000 -0.000027 0.001909 0.009128 -4783 1 0.000206 1560.000000 -0.000770 0.002041 0.009647 -4784 1 0.000236 1560.000000 0.000328 -0.002889 0.003825 -4785 1 0.000215 1560.000000 0.000349 -0.000319 0.004251 -4786 1 0.000208 1560.000000 0.001523 -0.002884 0.002174 -4787 1 0.000268 1560.000000 -0.001710 0.003145 0.005190 -4788 1 0.000286 1560.000000 0.002680 -0.000195 0.008225 -4789 1 0.000240 1560.000000 0.000474 0.000180 0.006491 -4790 1 0.000252 1560.000000 -0.000485 -0.001724 0.007553 -4791 1 0.000208 1560.000000 -0.001369 0.002996 0.006532 -4792 1 0.000230 1560.000000 0.001855 0.001296 0.002634 -4793 1 0.000219 1560.000000 0.001469 -0.002988 0.002497 -4794 1 0.000288 1560.000000 0.001215 0.002496 0.009286 -4795 1 0.000224 1560.000000 -0.000560 -0.002907 0.003031 -4796 1 0.000228 1560.000000 0.003642 -0.000018 0.007735 -4797 1 0.000230 1560.000000 0.003425 -0.001609 0.004206 -4798 1 0.000275 1560.000000 0.002153 -0.003111 0.009330 -4799 1 0.000284 1560.000000 -0.000345 -0.000748 0.009532 -4800 1 0.000198 1560.000000 0.000839 -0.000881 0.000418 -4801 1 0.000237 1560.000000 -0.002737 -0.001122 0.006064 -4802 1 0.000251 1560.000000 0.002920 -0.002476 0.004485 -4803 1 0.000262 1560.000000 0.002231 0.002668 0.009780 -4804 1 0.000241 1560.000000 0.000031 -0.001168 0.009775 -4805 1 0.000236 1560.000000 -0.002222 -0.000415 0.004248 -4806 1 0.000222 1560.000000 0.002249 -0.000505 0.004634 -4807 1 0.000275 1560.000000 0.000834 0.002485 0.000618 -4808 1 0.000232 1560.000000 0.003338 0.000243 0.002723 -4809 1 0.000195 1560.000000 -0.001958 0.002269 0.007454 -4810 1 0.000273 1560.000000 0.000965 0.003273 0.005460 -4811 1 0.000272 1560.000000 0.000078 -0.001213 0.006457 -4812 1 0.000247 1560.000000 0.000833 -0.002296 0.008365 -4813 1 0.000220 1560.000000 0.001061 0.000589 0.003973 -4814 1 0.000253 1560.000000 -0.001005 0.000645 0.006787 -4815 1 0.000235 1560.000000 -0.002318 -0.000252 0.005016 -4816 1 0.000251 1560.000000 0.002306 -0.001822 0.008336 -4817 1 0.000193 1560.000000 0.003597 -0.000754 0.001000 -4818 1 0.000253 1560.000000 0.002443 0.000216 0.009429 -4819 1 0.000198 1560.000000 -0.002397 0.000139 0.003756 -4820 1 0.000202 1560.000000 0.003605 -0.000449 0.000533 -4821 1 0.000218 1560.000000 0.000545 -0.002308 0.001356 -4822 1 0.000195 1560.000000 0.000627 0.001923 0.003755 -4823 1 0.000241 1560.000000 0.002001 -0.002016 0.002444 -4824 1 0.000208 1560.000000 0.000317 0.002453 0.004584 -4825 1 0.000267 1560.000000 -0.000707 -0.003417 0.006767 -4826 1 0.000212 1560.000000 0.000440 -0.000914 0.002117 -4827 1 0.000218 1560.000000 -0.000799 -0.002829 0.006400 -4828 1 0.000202 1560.000000 -0.000383 0.001440 0.004587 -4829 1 0.000268 1560.000000 -0.000510 -0.002110 0.002795 -4830 1 0.000249 1560.000000 0.002077 0.000366 0.001221 -4831 1 0.000219 1560.000000 -0.000259 -0.000548 0.002137 -4832 1 0.000223 1560.000000 -0.000664 -0.000908 0.007389 -4833 1 0.000265 1560.000000 0.001614 -0.000406 0.004819 -4834 1 0.000205 1560.000000 -0.002900 -0.002028 0.003626 -4835 1 0.000288 1560.000000 0.002783 -0.001266 0.005525 -4836 1 0.000271 1560.000000 -0.001064 0.001622 0.000548 -4837 1 0.000229 1560.000000 0.003253 -0.000206 0.001337 -4838 1 0.000193 1560.000000 0.001521 0.002627 0.004442 -4839 1 0.000213 1560.000000 -0.000126 -0.000667 0.003605 -4840 1 0.000210 1560.000000 0.000245 0.003515 0.004194 -4841 1 0.000213 1560.000000 -0.002739 -0.001786 0.001280 -4842 1 0.000221 1560.000000 -0.001564 0.002386 0.002362 -4843 1 0.000280 1560.000000 -0.001579 0.001570 0.004114 -4844 1 0.000244 1560.000000 -0.000600 -0.001987 0.006389 -4845 1 0.000208 1560.000000 0.001862 -0.000568 0.008686 -4846 1 0.000279 1560.000000 0.002743 -0.002489 0.002618 -4847 1 0.000237 1560.000000 0.002153 -0.001493 0.003239 -4848 1 0.000242 1560.000000 -0.002125 0.001996 0.007620 -4849 1 0.000194 1560.000000 -0.000596 0.003012 0.009622 -4850 1 0.000199 1560.000000 -0.000616 -0.000139 0.009247 -4851 1 0.000266 1560.000000 0.001483 0.000809 0.004166 -4852 1 0.000231 1560.000000 -0.002575 0.001807 0.001153 -4853 1 0.000202 1560.000000 0.000993 -0.001166 0.003884 -4854 1 0.000204 1560.000000 0.000615 -0.000439 0.001369 -4855 1 0.000212 1560.000000 0.000998 0.001235 0.002417 -4856 1 0.000226 1560.000000 0.001168 0.000991 0.005423 -4857 1 0.000232 1560.000000 -0.001622 0.000288 0.005226 -4858 1 0.000207 1560.000000 -0.001776 -0.002533 0.004931 -4859 1 0.000239 1560.000000 0.002024 0.000078 0.008429 -4860 1 0.000279 1560.000000 -0.000215 -0.000947 0.009128 -4861 1 0.000277 1560.000000 0.001142 0.002192 0.004716 -4862 1 0.000232 1560.000000 0.002879 0.001475 0.008350 -4863 1 0.000280 1560.000000 -0.003574 0.000189 0.002317 -4864 1 0.000216 1560.000000 0.000982 -0.002677 0.001353 -4865 1 0.000203 1560.000000 -0.001893 -0.002449 0.007217 -4866 1 0.000224 1560.000000 -0.000599 -0.002968 0.001541 -4867 1 0.000286 1560.000000 -0.002656 0.000906 0.009152 -4868 1 0.000200 1560.000000 0.001722 -0.002199 0.007460 -4869 1 0.000261 1560.000000 0.001393 -0.000224 0.007149 -4870 1 0.000225 1560.000000 0.002205 -0.001269 0.009265 -4871 1 0.000251 1560.000000 0.001352 -0.003451 0.000432 -4872 1 0.000261 1560.000000 -0.002839 0.001145 0.007574 -4873 1 0.000234 1560.000000 0.000858 0.001148 0.006545 -4874 1 0.000200 1560.000000 -0.003406 -0.001712 0.005926 -4875 1 0.000257 1560.000000 0.001520 0.000404 0.007275 -4876 1 0.000204 1560.000000 0.002530 -0.002372 0.005157 -4877 1 0.000211 1560.000000 0.001997 0.001679 0.005882 -4878 1 0.000221 1560.000000 -0.002431 -0.000239 0.004188 -4879 1 0.000268 1560.000000 -0.001176 0.003152 0.001059 -4880 1 0.000285 1560.000000 0.000239 0.000438 0.007977 -4881 1 0.000230 1560.000000 0.002727 -0.002176 0.001551 -4882 1 0.000260 1560.000000 -0.000228 -0.001423 0.002155 -4883 1 0.000245 1560.000000 0.002573 -0.002073 0.002355 -4884 1 0.000244 1560.000000 -0.000900 0.000650 0.007996 -4885 1 0.000198 1560.000000 0.001102 -0.001406 0.001197 -4886 1 0.000261 1560.000000 0.002195 0.000389 0.000299 -4887 1 0.000283 1560.000000 -0.003451 0.001429 0.009267 -4888 1 0.000248 1560.000000 0.003400 -0.000915 0.001187 -4889 1 0.000274 1560.000000 0.000565 0.000171 0.007546 -4890 1 0.000275 1560.000000 -0.000342 -0.000876 0.007153 -4891 1 0.000232 1560.000000 -0.001032 -0.001025 0.007619 -4892 1 0.000260 1560.000000 0.001323 0.001376 0.000210 -4893 1 0.000227 1560.000000 -0.003066 0.002088 0.004558 -4894 1 0.000202 1560.000000 0.000162 -0.002590 0.003621 -4895 1 0.000225 1560.000000 -0.001867 0.001342 0.004317 -4896 1 0.000283 1560.000000 0.000484 -0.001662 0.001985 -4897 1 0.000280 1560.000000 -0.001728 -0.000309 0.004375 -4898 1 0.000220 1560.000000 0.000081 0.002843 0.005675 -4899 1 0.000241 1560.000000 -0.002205 0.001329 0.007600 -4900 1 0.000228 1560.000000 -0.001144 -0.000083 0.002243 -4901 1 0.000224 1560.000000 0.001034 -0.001139 0.006010 -4902 1 0.000221 1560.000000 -0.000055 -0.003096 0.003251 -4903 1 0.000210 1560.000000 0.000705 0.000727 0.003717 -4904 1 0.000221 1560.000000 0.002679 0.000338 0.003474 -4905 1 0.000192 1560.000000 -0.001929 -0.000573 0.005184 -4906 1 0.000219 1560.000000 0.000295 -0.001489 0.006340 -4907 1 0.000233 1560.000000 0.001092 0.002752 0.008118 -4908 1 0.000195 1560.000000 0.000895 0.000349 0.007829 -4909 1 0.000239 1560.000000 0.001514 -0.002216 0.005572 -4910 1 0.000233 1560.000000 0.001087 0.000106 0.005628 -4911 1 0.000254 1560.000000 0.000840 0.000812 0.006629 -4912 1 0.000217 1560.000000 0.001591 0.001509 0.002156 -4913 1 0.000192 1560.000000 -0.001420 0.000802 0.004354 -4914 1 0.000229 1560.000000 -0.000336 0.000263 0.002295 -4915 1 0.000195 1560.000000 0.001609 -0.001698 0.005046 -4916 1 0.000253 1560.000000 0.002545 -0.002882 0.001889 -4917 1 0.000231 1560.000000 0.001274 -0.000791 0.008555 -4918 1 0.000217 1560.000000 -0.001509 0.000551 0.001081 -4919 1 0.000246 1560.000000 0.000419 0.000050 0.003794 -4920 1 0.000200 1560.000000 -0.000089 0.000995 0.001093 -4921 1 0.000195 1560.000000 0.000915 -0.000098 0.002650 -4922 1 0.000193 1560.000000 0.000432 0.000481 0.006075 -4923 1 0.000226 1560.000000 -0.001315 0.000278 0.008512 -4924 1 0.000271 1560.000000 -0.001467 0.001814 0.009837 -4925 1 0.000213 1560.000000 0.002071 0.002018 0.008995 -4926 1 0.000208 1560.000000 0.003029 0.001336 0.006630 -4927 1 0.000231 1560.000000 0.002135 0.000599 0.003664 -4928 1 0.000265 1560.000000 -0.001355 -0.000090 0.004786 -4929 1 0.000243 1560.000000 -0.002208 0.003022 0.008820 -4930 1 0.000203 1560.000000 0.000083 -0.000452 0.009553 -4931 1 0.000204 1560.000000 0.002228 0.002834 0.008694 -4932 1 0.000284 1560.000000 -0.000763 0.001291 0.007933 -4933 1 0.000217 1560.000000 -0.000461 -0.000621 0.005434 -4934 1 0.000250 1560.000000 -0.001913 0.001604 0.005203 -4935 1 0.000194 1560.000000 -0.000474 -0.001206 0.006098 -4936 1 0.000197 1560.000000 -0.000352 0.000029 0.001408 -4937 1 0.000256 1560.000000 -0.000625 0.003076 0.005339 -4938 1 0.000268 1560.000000 0.001687 -0.000969 0.009254 -4939 1 0.000248 1560.000000 -0.000469 0.001015 0.002140 -4940 1 0.000250 1560.000000 0.003694 0.000705 0.006566 -4941 1 0.000222 1560.000000 0.000151 0.000229 0.006334 -4942 1 0.000201 1560.000000 0.001026 0.000715 0.007303 -4943 1 0.000221 1560.000000 0.001612 0.000341 0.006934 -4944 1 0.000276 1560.000000 0.001325 -0.001031 0.002152 -4945 1 0.000269 1560.000000 0.000426 0.003066 0.006407 -4946 1 0.000202 1560.000000 0.001388 -0.001980 0.003586 -4947 1 0.000202 1560.000000 -0.001382 0.000971 0.005566 -4948 1 0.000196 1560.000000 -0.002279 -0.000992 0.008808 -4949 1 0.000237 1560.000000 -0.000475 -0.002777 0.002840 -4950 1 0.000274 1560.000000 0.001817 0.002868 0.004013 -4951 1 0.000240 1560.000000 -0.003560 0.000548 0.004839 -4952 1 0.000216 1560.000000 0.001552 -0.000416 0.003448 -4953 1 0.000200 1560.000000 0.002946 -0.001072 0.004546 -4954 1 0.000200 1560.000000 0.000515 -0.000669 0.001989 -4955 1 0.000210 1560.000000 0.001616 0.003259 0.004825 -4956 1 0.000271 1560.000000 0.001088 -0.002705 0.000190 -4957 1 0.000234 1560.000000 -0.001386 -0.001089 0.007399 -4958 1 0.000226 1560.000000 0.000718 0.001421 0.005093 -4959 1 0.000285 1560.000000 -0.001560 -0.001157 0.006173 -4960 1 0.000234 1560.000000 0.002821 -0.000141 0.001144 -4961 1 0.000242 1560.000000 0.002212 0.000779 0.004460 -4962 1 0.000205 1560.000000 -0.000393 0.000760 0.002173 -4963 1 0.000202 1560.000000 0.000528 -0.001859 0.003426 -4964 1 0.000278 1560.000000 0.001038 0.001294 0.004837 -4965 1 0.000201 1560.000000 -0.002593 0.000090 0.000294 -4966 1 0.000239 1560.000000 -0.001037 -0.003627 0.004626 -4967 1 0.000271 1560.000000 -0.000570 0.001502 0.008808 -4968 1 0.000263 1560.000000 0.001916 -0.000565 0.005066 -4969 1 0.000230 1560.000000 -0.001396 0.003588 0.009750 -4970 1 0.000237 1560.000000 0.000064 0.002902 0.003136 -4971 1 0.000221 1560.000000 0.003104 -0.001126 0.004315 -4972 1 0.000213 1560.000000 -0.002944 -0.000112 0.007919 -4973 1 0.000244 1560.000000 0.000813 0.000408 0.005740 -4974 1 0.000197 1560.000000 -0.000863 -0.003230 0.006363 -4975 1 0.000269 1560.000000 -0.002645 0.001329 0.006640 -4976 1 0.000211 1560.000000 0.003633 -0.000248 0.007394 -4977 1 0.000206 1560.000000 0.000853 -0.002681 0.004351 -4978 1 0.000225 1560.000000 -0.002675 -0.001756 0.007717 -4979 1 0.000250 1560.000000 -0.001109 0.001023 0.007778 -4980 1 0.000198 1560.000000 -0.002876 -0.001836 0.008353 -4981 1 0.000200 1560.000000 -0.001854 0.000933 0.005784 -4982 1 0.000246 1560.000000 -0.001260 0.001597 0.007015 -4983 1 0.000214 1560.000000 0.001095 -0.003369 0.007100 -4984 1 0.000233 1560.000000 0.000972 -0.002621 0.004734 -4985 1 0.000243 1560.000000 -0.002513 -0.000583 0.001550 -4986 1 0.000276 1560.000000 0.000112 0.003802 0.000620 -4987 1 0.000229 1560.000000 -0.003545 -0.000236 0.006881 -4988 1 0.000268 1560.000000 0.003012 -0.002386 0.009713 -4989 1 0.000235 1560.000000 -0.000639 0.002053 0.005522 -4990 1 0.000222 1560.000000 0.000495 0.001193 0.007034 -4991 1 0.000215 1560.000000 0.002306 0.000323 0.001842 -4992 1 0.000243 1560.000000 -0.000830 -0.000668 0.009827 -4993 1 0.000246 1560.000000 -0.003424 -0.001603 0.006729 -4994 1 0.000255 1560.000000 0.003341 0.000950 0.005304 -4995 1 0.000234 1560.000000 0.002285 0.002980 0.004868 -4996 1 0.000264 1560.000000 -0.000939 0.000354 0.007063 -4997 1 0.000199 1560.000000 -0.000508 0.003627 0.009462 -4998 1 0.000249 1560.000000 0.000080 0.002252 0.003113 -4999 1 0.000216 1560.000000 -0.003519 0.000305 0.007606 -5000 1 0.000271 1560.000000 0.003480 0.001422 0.007117 -5001 1 0.000236 1560.000000 0.000262 -0.002496 0.001574 -5002 1 0.000208 1560.000000 -0.003446 0.000303 0.003170 -5003 1 0.000263 1560.000000 0.000155 -0.002289 0.008696 -5004 1 0.000232 1560.000000 -0.002012 0.001310 0.007262 -5005 1 0.000204 1560.000000 -0.000934 0.002609 0.007014 -5006 1 0.000206 1560.000000 0.002124 0.000418 0.008239 -5007 1 0.000243 1560.000000 0.000891 -0.003189 0.009640 -5008 1 0.000277 1560.000000 0.002009 -0.001347 0.000565 -5009 1 0.000222 1560.000000 0.000894 0.003708 0.005775 -5010 1 0.000274 1560.000000 -0.000798 -0.003126 0.000703 -5011 1 0.000228 1560.000000 0.000304 0.000476 0.005817 -5012 1 0.000269 1560.000000 -0.002145 -0.002635 0.000427 -5013 1 0.000216 1560.000000 0.001305 0.003541 0.006196 -5014 1 0.000198 1560.000000 0.003504 -0.000232 0.005857 -5015 1 0.000255 1560.000000 -0.002622 0.001428 0.006345 -5016 1 0.000264 1560.000000 0.000363 0.003755 0.000310 -5017 1 0.000243 1560.000000 0.002434 0.000172 0.002309 -5018 1 0.000215 1560.000000 -0.001488 -0.002965 0.000395 -5019 1 0.000214 1560.000000 -0.002489 -0.001577 0.007732 -5020 1 0.000245 1560.000000 -0.001398 -0.002901 0.009283 -5021 1 0.000231 1560.000000 -0.001603 -0.000620 0.002394 -5022 1 0.000218 1560.000000 0.003514 -0.001209 0.006966 -5023 1 0.000197 1560.000000 0.001137 -0.003063 0.009492 -5024 1 0.000283 1560.000000 -0.001188 -0.001387 0.003616 -5025 1 0.000215 1560.000000 -0.002672 -0.001853 0.003122 -5026 1 0.000237 1560.000000 0.003300 -0.001504 0.000366 -5027 1 0.000265 1560.000000 0.001635 -0.001266 0.009764 -5028 1 0.000211 1560.000000 -0.001285 0.002620 0.001743 -5029 1 0.000250 1560.000000 -0.000183 -0.003785 0.000558 -5030 1 0.000223 1560.000000 -0.001741 0.003045 0.003585 -5031 1 0.000217 1560.000000 -0.002456 -0.002899 0.009210 -5032 1 0.000237 1560.000000 -0.001006 0.002253 0.007292 -5033 1 0.000197 1560.000000 0.001923 0.003321 0.005323 -5034 1 0.000233 1560.000000 -0.001262 0.002614 0.007094 -5035 1 0.000212 1560.000000 -0.000280 -0.000648 0.005905 -5036 1 0.000241 1560.000000 0.002681 -0.001755 0.004752 -5037 1 0.000214 1560.000000 -0.002570 0.001159 0.000298 -5038 1 0.000209 1560.000000 -0.001166 -0.003191 0.006336 -5039 1 0.000218 1560.000000 0.002677 -0.002257 0.009418 -5040 1 0.000204 1560.000000 0.003106 0.000508 0.002632 -5041 1 0.000199 1560.000000 -0.003117 -0.001572 0.009543 -5042 1 0.000239 1560.000000 0.001798 -0.000345 0.008493 -5043 1 0.000199 1560.000000 0.002952 -0.001293 0.003738 -5044 1 0.000221 1560.000000 -0.001498 -0.002362 0.002223 -5045 1 0.000243 1560.000000 -0.003491 -0.000453 0.003280 -5046 1 0.000242 1560.000000 -0.002979 0.001092 0.003670 -5047 1 0.000199 1560.000000 -0.000776 -0.001942 0.003540 -5048 1 0.000270 1560.000000 -0.000242 0.001747 0.001647 -5049 1 0.000221 1560.000000 0.001599 0.003151 0.002473 -5050 1 0.000288 1560.000000 0.002144 -0.001136 0.008320 -5051 1 0.000197 1560.000000 0.001940 0.002889 0.006478 -5052 1 0.000198 1560.000000 -0.000912 -0.002003 0.000107 -5053 1 0.000219 1560.000000 0.001331 -0.000316 0.009300 -5054 1 0.000206 1560.000000 0.000580 0.000193 0.001786 -5055 1 0.000269 1560.000000 0.002199 -0.000177 0.002714 -5056 1 0.000204 1560.000000 0.000371 0.002834 0.005191 -5057 1 0.000256 1560.000000 -0.000397 -0.000872 0.001580 -5058 1 0.000271 1560.000000 -0.001699 -0.003011 0.007837 -5059 1 0.000206 1560.000000 -0.000526 -0.000523 0.008461 -5060 1 0.000222 1560.000000 -0.003653 -0.000414 0.000115 -5061 1 0.000197 1560.000000 -0.002467 0.001227 0.003402 -5062 1 0.000202 1560.000000 0.000454 0.002241 0.001919 -5063 1 0.000209 1560.000000 -0.002499 0.000138 0.003274 -5064 1 0.000284 1560.000000 -0.000223 -0.001415 0.009275 -5065 1 0.000228 1560.000000 -0.003291 0.001950 0.003971 -5066 1 0.000244 1560.000000 0.002274 -0.002096 0.001986 -5067 1 0.000286 1560.000000 -0.000033 -0.002879 0.002649 -5068 1 0.000200 1560.000000 -0.002002 0.000047 0.004725 -5069 1 0.000197 1560.000000 -0.000431 0.000242 0.007055 -5070 1 0.000219 1560.000000 0.001611 0.000606 0.003583 -5071 1 0.000194 1560.000000 0.000225 -0.003824 0.005994 -5072 1 0.000223 1560.000000 -0.000175 0.002809 0.006827 -5073 1 0.000197 1560.000000 -0.001536 -0.000680 0.003121 -5074 1 0.000223 1560.000000 0.001036 0.000276 0.000929 -5075 1 0.000202 1560.000000 -0.002090 0.003182 0.005284 -5076 1 0.000259 1560.000000 -0.001382 -0.000177 0.003337 -5077 1 0.000229 1560.000000 0.000664 -0.001282 0.003565 -5078 1 0.000203 1560.000000 -0.002952 -0.000862 0.009719 -5079 1 0.000215 1560.000000 0.000064 -0.003312 0.004109 -5080 1 0.000279 1560.000000 0.001010 0.000849 0.002790 -5081 1 0.000225 1560.000000 0.000816 0.001162 0.006879 -5082 1 0.000202 1560.000000 0.003595 -0.001227 0.009286 -5083 1 0.000265 1560.000000 0.002205 -0.000553 0.005870 -5084 1 0.000206 1560.000000 0.001748 0.000096 0.003053 -5085 1 0.000263 1560.000000 -0.000436 -0.000904 0.006076 -5086 1 0.000208 1560.000000 0.003187 0.000872 0.003732 -5087 1 0.000197 1560.000000 0.000515 -0.002905 0.003655 -5088 1 0.000220 1560.000000 0.001009 -0.003538 0.003206 -5089 1 0.000220 1560.000000 -0.001364 0.002465 0.008525 -5090 1 0.000222 1560.000000 0.002466 -0.002255 0.000179 -5091 1 0.000196 1560.000000 0.003517 -0.001210 0.006560 -5092 1 0.000254 1560.000000 0.002129 -0.003118 0.002997 -5093 1 0.000213 1560.000000 0.001410 0.001206 0.005840 -5094 1 0.000234 1560.000000 0.002649 -0.001377 0.002500 -5095 1 0.000203 1560.000000 0.002478 -0.000668 0.006453 -5096 1 0.000212 1560.000000 -0.000501 -0.001705 0.005068 -5097 1 0.000197 1560.000000 -0.000520 -0.003108 0.003370 -5098 1 0.000247 1560.000000 -0.003189 0.001423 0.006227 -5099 1 0.000218 1560.000000 0.001820 0.000918 0.004623 -5100 1 0.000232 1560.000000 0.001243 0.002068 0.003918 -5101 1 0.000221 1560.000000 -0.002526 -0.002196 0.002629 -5102 1 0.000225 1560.000000 -0.001489 0.002248 0.005205 -5103 1 0.000271 1560.000000 -0.000361 0.002758 0.004676 -5104 1 0.000252 1560.000000 0.000103 0.000596 0.006977 -5105 1 0.000248 1560.000000 -0.000228 -0.000800 0.006557 -5106 1 0.000226 1560.000000 0.000535 0.002866 0.005474 -5107 1 0.000243 1560.000000 -0.000059 0.000989 0.004639 -5108 1 0.000210 1560.000000 -0.000378 0.000657 0.000712 -5109 1 0.000208 1560.000000 0.000886 0.002657 0.009273 -5110 1 0.000279 1560.000000 -0.001844 -0.003256 0.005685 -5111 1 0.000213 1560.000000 -0.000777 0.002536 0.004440 -5112 1 0.000214 1560.000000 0.002391 0.002462 0.004446 -5113 1 0.000256 1560.000000 0.001718 0.003127 0.005491 -5114 1 0.000256 1560.000000 -0.002149 -0.001444 0.007968 -5115 1 0.000250 1560.000000 -0.002672 0.000235 0.005383 -5116 1 0.000284 1560.000000 0.001252 -0.002134 0.006650 -5117 1 0.000256 1560.000000 0.002643 0.000802 0.003996 -5118 1 0.000223 1560.000000 0.000183 0.001551 0.004683 -5119 1 0.000210 1560.000000 0.001987 0.003128 0.004241 -5120 1 0.000239 1560.000000 0.000446 -0.003451 0.007800 -5121 1 0.000266 1560.000000 -0.001670 -0.002577 0.003135 -5122 1 0.000267 1560.000000 0.001623 0.002252 0.001322 -5123 1 0.000222 1560.000000 -0.001740 0.001072 0.000131 -5124 1 0.000214 1560.000000 0.001113 0.000897 0.004287 -5125 1 0.000203 1560.000000 -0.000417 -0.002629 0.004142 -5126 1 0.000267 1560.000000 -0.000269 0.002617 0.005438 -5127 1 0.000246 1560.000000 -0.002895 0.002199 0.001573 -5128 1 0.000237 1560.000000 0.001604 0.002864 0.008723 -5129 1 0.000219 1560.000000 0.002375 0.001134 0.000992 -5130 1 0.000225 1560.000000 -0.000080 0.002641 0.009613 -5131 1 0.000266 1560.000000 0.001307 0.001200 0.000407 -5132 1 0.000241 1560.000000 -0.000001 0.000856 0.008718 -5133 1 0.000222 1560.000000 -0.000288 0.001416 0.008260 -5134 1 0.000282 1560.000000 -0.002689 -0.002546 0.006946 -5135 1 0.000256 1560.000000 0.000242 -0.000924 0.002664 -5136 1 0.000193 1560.000000 0.003634 -0.001101 0.003346 -5137 1 0.000229 1560.000000 -0.000750 -0.003684 0.006850 -5138 1 0.000245 1560.000000 -0.001084 0.001277 0.004175 -5139 1 0.000194 1560.000000 -0.003032 -0.001127 0.007208 -5140 1 0.000220 1560.000000 0.002072 -0.001174 0.009803 -5141 1 0.000250 1560.000000 -0.000975 0.001488 0.009638 -5142 1 0.000260 1560.000000 0.002332 0.000435 0.005846 -5143 1 0.000237 1560.000000 0.002299 -0.001841 0.008912 -5144 1 0.000283 1560.000000 0.000921 0.002721 0.003914 -5145 1 0.000211 1560.000000 -0.001471 0.001863 0.000985 -5146 1 0.000196 1560.000000 0.000355 -0.002508 0.009089 -5147 1 0.000280 1560.000000 -0.001569 0.003323 0.007226 -5148 1 0.000269 1560.000000 -0.000859 0.001375 0.000423 -5149 1 0.000195 1560.000000 0.000938 -0.001078 0.000462 -5150 1 0.000257 1560.000000 -0.001715 0.000700 0.003667 -5151 1 0.000236 1560.000000 0.000681 -0.003738 0.006972 -5152 1 0.000213 1560.000000 -0.000383 0.002470 0.003750 -5153 1 0.000210 1560.000000 -0.000012 0.001204 0.002172 -5154 1 0.000280 1560.000000 -0.000207 0.000860 0.007373 -5155 1 0.000205 1560.000000 0.000146 -0.002624 0.006296 -5156 1 0.000214 1560.000000 -0.002115 -0.001837 0.008321 -5157 1 0.000222 1560.000000 0.002711 0.001480 0.007158 -5158 1 0.000282 1560.000000 0.001759 0.003425 0.006252 -5159 1 0.000271 1560.000000 -0.001774 -0.001795 0.008315 -5160 1 0.000280 1560.000000 0.000020 0.002912 0.009422 -5161 1 0.000197 1560.000000 0.002848 0.001696 0.001460 -5162 1 0.000286 1560.000000 -0.001370 0.002351 0.009097 -5163 1 0.000261 1560.000000 0.002012 -0.001147 0.008586 -5164 1 0.000256 1560.000000 0.001338 0.000626 0.003511 -5165 1 0.000216 1560.000000 -0.003354 0.001445 0.002366 -5166 1 0.000215 1560.000000 0.001332 -0.002251 0.001752 -5167 1 0.000207 1560.000000 -0.001041 -0.002505 0.004257 -5168 1 0.000220 1560.000000 -0.000769 -0.000272 0.002053 -5169 1 0.000265 1560.000000 0.000869 -0.001513 0.005697 -5170 1 0.000192 1560.000000 0.001023 -0.001216 0.008769 -5171 1 0.000217 1560.000000 -0.002138 -0.001726 0.006926 -5172 1 0.000237 1560.000000 -0.001933 -0.002919 0.003286 -5173 1 0.000209 1560.000000 0.000075 0.002365 0.007666 -5174 1 0.000199 1560.000000 0.000873 -0.002230 0.004387 -5175 1 0.000225 1560.000000 -0.001591 -0.003480 0.005678 -5176 1 0.000269 1560.000000 0.000891 -0.001708 0.006501 -5177 1 0.000265 1560.000000 -0.001773 -0.000183 0.007836 -5178 1 0.000234 1560.000000 0.003250 -0.001465 0.006703 -5179 1 0.000283 1560.000000 -0.001511 -0.002077 0.003339 -5180 1 0.000203 1560.000000 -0.002368 0.000987 0.008799 -5181 1 0.000247 1560.000000 -0.001505 -0.000428 0.000754 -5182 1 0.000288 1560.000000 0.001822 -0.001993 0.001176 -5183 1 0.000243 1560.000000 0.002858 0.002426 0.003692 -5184 1 0.000231 1560.000000 0.001145 -0.000983 0.003172 -5185 1 0.000280 1560.000000 -0.001642 -0.000790 0.004525 -5186 1 0.000263 1560.000000 0.003741 -0.000562 0.009286 -5187 1 0.000205 1560.000000 0.003452 0.000807 0.001211 -5188 1 0.000239 1560.000000 0.002049 0.000668 0.000142 -5189 1 0.000255 1560.000000 -0.000250 0.001729 0.005344 -5190 1 0.000234 1560.000000 0.001964 0.000248 0.009344 -5191 1 0.000216 1560.000000 0.001152 -0.002830 0.008046 -5192 1 0.000227 1560.000000 0.001402 -0.000166 0.004523 -5193 1 0.000208 1560.000000 -0.000934 0.001255 0.003282 -5194 1 0.000261 1560.000000 0.001798 0.000018 0.007115 -5195 1 0.000236 1560.000000 0.000870 0.002889 0.006264 -5196 1 0.000227 1560.000000 -0.002252 -0.001879 0.009523 -5197 1 0.000197 1560.000000 -0.001465 -0.003301 0.004576 -5198 1 0.000230 1560.000000 0.001754 0.000411 0.001261 -5199 1 0.000249 1560.000000 -0.002159 0.002889 0.006309 -5200 1 0.000202 1560.000000 -0.003569 0.000491 0.009544 -5201 1 0.000225 1560.000000 -0.000560 -0.001752 0.005687 -5202 1 0.000237 1560.000000 0.002659 -0.000885 0.006885 -5203 1 0.000210 1560.000000 0.000933 0.000676 0.000345 -5204 1 0.000193 1560.000000 -0.000996 0.001071 0.001066 -5205 1 0.000224 1560.000000 -0.001504 -0.000421 0.002087 -5206 1 0.000207 1560.000000 -0.000033 -0.000664 0.004893 -5207 1 0.000269 1560.000000 0.001313 -0.002520 0.005818 -5208 1 0.000239 1560.000000 -0.002698 -0.000301 0.004785 -5209 1 0.000225 1560.000000 0.001416 -0.003271 0.007079 -5210 1 0.000267 1560.000000 0.000447 -0.003609 0.005362 -5211 1 0.000206 1560.000000 0.002441 -0.002694 0.002127 -5212 1 0.000205 1560.000000 -0.001055 0.002881 0.002676 -5213 1 0.000213 1560.000000 -0.000794 -0.003526 0.002119 -5214 1 0.000208 1560.000000 -0.000416 0.003548 0.000890 -5215 1 0.000280 1560.000000 0.001993 -0.002854 0.007954 -5216 1 0.000198 1560.000000 0.000507 -0.003119 0.002752 -5217 1 0.000210 1560.000000 -0.001800 0.002527 0.003004 -5218 1 0.000215 1560.000000 -0.000261 0.002543 0.001266 -5219 1 0.000271 1560.000000 -0.001810 -0.002156 0.006175 -5220 1 0.000234 1560.000000 0.001029 0.001767 0.002912 -5221 1 0.000193 1560.000000 0.000943 0.001256 0.000813 -5222 1 0.000235 1560.000000 0.003146 0.001315 0.003129 -5223 1 0.000223 1560.000000 -0.000986 0.000714 0.004372 -5224 1 0.000205 1560.000000 -0.001526 0.000659 0.008582 -5225 1 0.000201 1560.000000 -0.001100 -0.003451 0.002197 -5226 1 0.000207 1560.000000 -0.000206 0.000762 0.009760 -5227 1 0.000287 1560.000000 0.000922 0.002234 0.003603 -5228 1 0.000209 1560.000000 -0.000373 -0.002946 0.004199 -5229 1 0.000220 1560.000000 0.000665 -0.000424 0.009159 -5230 1 0.000219 1560.000000 0.001104 -0.000548 0.001572 -5231 1 0.000196 1560.000000 -0.001147 -0.001822 0.003349 -5232 1 0.000201 1560.000000 -0.002754 -0.000615 0.009118 -5233 1 0.000257 1560.000000 -0.002207 -0.001461 0.009810 -5234 1 0.000204 1560.000000 -0.002079 -0.001038 0.007928 -5235 1 0.000253 1560.000000 -0.002682 0.000492 0.003232 -5236 1 0.000194 1560.000000 -0.002300 0.002051 0.008110 -5237 1 0.000220 1560.000000 0.001014 0.001412 0.001043 -5238 1 0.000194 1560.000000 0.002971 -0.001488 0.001410 -5239 1 0.000193 1560.000000 0.000351 -0.001029 0.003610 -5240 1 0.000274 1560.000000 0.001828 0.002927 0.008964 -5241 1 0.000210 1560.000000 0.001683 -0.003417 0.006260 -5242 1 0.000223 1560.000000 0.000366 -0.000481 0.009451 -5243 1 0.000239 1560.000000 -0.002306 0.000052 0.002189 -5244 1 0.000201 1560.000000 0.002575 0.001873 0.007325 -5245 1 0.000203 1560.000000 0.001333 0.003276 0.001201 -5246 1 0.000273 1560.000000 -0.000651 0.003246 0.009544 -5247 1 0.000210 1560.000000 -0.001318 0.002410 0.009633 -5248 1 0.000270 1560.000000 -0.003239 0.001476 0.007378 -5249 1 0.000249 1560.000000 0.002798 0.002496 0.001423 -5250 1 0.000264 1560.000000 -0.003188 0.001121 0.008642 -5251 1 0.000221 1560.000000 0.001019 0.001523 0.002159 -5252 1 0.000225 1560.000000 0.000439 -0.001387 0.007029 -5253 1 0.000247 1560.000000 -0.001797 -0.002662 0.001604 -5254 1 0.000209 1560.000000 0.001883 -0.000283 0.007260 -5255 1 0.000196 1560.000000 -0.001193 0.000042 0.003282 -5256 1 0.000202 1560.000000 -0.002435 -0.001058 0.009372 -5257 1 0.000206 1560.000000 -0.000865 -0.000410 0.004041 -5258 1 0.000261 1560.000000 0.002896 -0.000886 0.002101 -5259 1 0.000193 1560.000000 0.000406 -0.000903 0.004417 -5260 1 0.000249 1560.000000 -0.000916 -0.002341 0.007179 -5261 1 0.000207 1560.000000 0.000859 0.001037 0.009377 -5262 1 0.000193 1560.000000 -0.000191 -0.000770 0.000223 -5263 1 0.000220 1560.000000 0.001250 -0.002268 0.005149 -5264 1 0.000218 1560.000000 -0.002607 0.000294 0.001736 -5265 1 0.000195 1560.000000 0.000965 0.001083 0.008572 -5266 1 0.000284 1560.000000 0.001753 0.000723 0.003796 -5267 1 0.000221 1560.000000 0.000290 -0.003312 0.009477 -5268 1 0.000267 1560.000000 -0.000015 0.003209 0.006178 -5269 1 0.000237 1560.000000 0.001873 0.001836 0.006666 -5270 1 0.000238 1560.000000 0.003575 0.001136 0.004416 -5271 1 0.000214 1560.000000 -0.001825 -0.000036 0.000235 -5272 1 0.000214 1560.000000 -0.000416 0.003625 0.002494 -5273 1 0.000196 1560.000000 -0.003283 0.001583 0.008181 -5274 1 0.000259 1560.000000 0.002717 -0.000048 0.007311 -5275 1 0.000249 1560.000000 0.003231 0.000576 0.004479 -5276 1 0.000270 1560.000000 0.003468 0.000494 0.006383 -5277 1 0.000245 1560.000000 0.001662 -0.000000 0.009819 -5278 1 0.000211 1560.000000 0.000547 0.001115 0.005925 -5279 1 0.000197 1560.000000 0.000085 -0.000086 0.006398 -5280 1 0.000270 1560.000000 -0.002059 -0.003247 0.002517 -5281 1 0.000247 1560.000000 0.000743 -0.001371 0.006917 -5282 1 0.000204 1560.000000 -0.000755 0.000416 0.000695 -5283 1 0.000196 1560.000000 -0.000991 -0.000920 0.008124 -5284 1 0.000195 1560.000000 -0.002936 0.000001 0.001791 -5285 1 0.000273 1560.000000 0.001286 0.000753 0.001528 -5286 1 0.000214 1560.000000 0.000749 -0.001560 0.000749 -5287 1 0.000234 1560.000000 0.002659 -0.001747 0.002299 -5288 1 0.000194 1560.000000 -0.001723 -0.000369 0.004064 -5289 1 0.000273 1560.000000 -0.000499 -0.003405 0.007583 -5290 1 0.000222 1560.000000 0.001827 0.000347 0.001472 -5291 1 0.000205 1560.000000 -0.002508 0.000049 0.006111 -5292 1 0.000215 1560.000000 0.002405 -0.002302 0.007959 -5293 1 0.000218 1560.000000 -0.001305 0.001707 0.003741 -5294 1 0.000254 1560.000000 0.003259 0.000550 0.003656 -5295 1 0.000238 1560.000000 -0.001383 0.002040 0.000767 -5296 1 0.000284 1560.000000 0.001209 -0.000039 0.003971 -5297 1 0.000286 1560.000000 0.001177 0.001292 0.003657 -5298 1 0.000194 1560.000000 -0.000281 -0.000227 0.000117 -5299 1 0.000202 1560.000000 0.000845 -0.002640 0.003588 -5300 1 0.000198 1560.000000 0.003639 0.000183 0.003378 -5301 1 0.000193 1560.000000 -0.003585 0.000242 0.001431 -5302 1 0.000264 1560.000000 -0.000671 -0.002991 0.004822 -5303 1 0.000215 1560.000000 0.001207 0.001596 0.009222 -5304 1 0.000283 1560.000000 0.000320 -0.000970 0.009136 -5305 1 0.000267 1560.000000 0.001876 0.000725 0.007069 -5306 1 0.000195 1560.000000 -0.001609 -0.003278 0.008389 -5307 1 0.000226 1560.000000 0.003534 -0.001396 0.003325 -5308 1 0.000194 1560.000000 -0.001110 0.001951 0.008423 -5309 1 0.000232 1560.000000 -0.001171 0.003208 0.001392 -5310 1 0.000256 1560.000000 0.000424 -0.003814 0.007364 -5311 1 0.000197 1560.000000 0.000624 0.003118 0.008635 -5312 1 0.000236 1560.000000 0.002694 0.001519 0.006167 -5313 1 0.000255 1560.000000 0.000820 -0.002054 0.009777 -5314 1 0.000218 1560.000000 0.000122 0.003814 0.003999 -5315 1 0.000251 1560.000000 0.002450 -0.001727 0.004889 -5316 1 0.000283 1560.000000 0.000461 -0.002266 0.001123 -5317 1 0.000208 1560.000000 0.002339 0.002298 0.001199 -5318 1 0.000232 1560.000000 0.001206 -0.003420 0.005668 -5319 1 0.000198 1560.000000 0.001421 0.001933 0.002044 -5320 1 0.000204 1560.000000 -0.001026 0.001083 0.000501 -5321 1 0.000196 1560.000000 -0.002780 0.002447 0.008222 -5322 1 0.000252 1560.000000 -0.003025 0.000925 0.009003 -5323 1 0.000243 1560.000000 0.001584 -0.002780 0.000932 -5324 1 0.000225 1560.000000 -0.002583 -0.000577 0.002562 -5325 1 0.000234 1560.000000 0.000880 -0.002555 0.003311 -5326 1 0.000275 1560.000000 0.000438 -0.000985 0.007041 -5327 1 0.000196 1560.000000 -0.001172 -0.000964 0.004116 -5328 1 0.000257 1560.000000 -0.002087 0.002858 0.005814 -5329 1 0.000282 1560.000000 -0.003505 -0.001350 0.009146 -5330 1 0.000284 1560.000000 -0.002132 -0.000337 0.009799 -5331 1 0.000206 1560.000000 -0.002122 0.000752 0.001570 -5332 1 0.000193 1560.000000 -0.000677 -0.002892 0.006722 -5333 1 0.000260 1560.000000 0.000071 0.000965 0.003075 -5334 1 0.000286 1560.000000 -0.000651 -0.001517 0.002347 -5335 1 0.000285 1560.000000 0.003193 0.001855 0.006450 -5336 1 0.000207 1560.000000 0.003021 -0.001420 0.002198 -5337 1 0.000205 1560.000000 -0.000351 -0.002501 0.005509 -5338 1 0.000267 1560.000000 0.001849 -0.002722 0.003326 -5339 1 0.000232 1560.000000 -0.000412 0.000641 0.004609 -5340 1 0.000226 1560.000000 -0.002530 -0.001056 0.005638 -5341 1 0.000266 1560.000000 0.001361 0.002040 0.005373 -5342 1 0.000260 1560.000000 0.001637 -0.001749 0.005499 -5343 1 0.000224 1560.000000 0.002857 0.000501 0.006414 -5344 1 0.000254 1560.000000 0.000138 0.000523 0.004169 -5345 1 0.000222 1560.000000 -0.000060 -0.001071 0.005066 -5346 1 0.000206 1560.000000 -0.000122 -0.003525 0.003265 -5347 1 0.000273 1560.000000 0.000881 0.003324 0.000572 -5348 1 0.000264 1560.000000 -0.001444 0.002971 0.005549 -5349 1 0.000276 1560.000000 -0.003459 -0.001657 0.001725 -5350 1 0.000193 1560.000000 0.003090 0.001164 0.001316 -5351 1 0.000255 1560.000000 -0.000261 0.001140 0.007494 -5352 1 0.000257 1560.000000 -0.001874 -0.002205 0.007266 -5353 1 0.000240 1560.000000 -0.001311 0.000666 0.009267 -5354 1 0.000201 1560.000000 0.001588 -0.000116 0.001082 -5355 1 0.000196 1560.000000 -0.000280 -0.002570 0.007191 -5356 1 0.000235 1560.000000 0.002159 0.000678 0.004212 -5357 1 0.000207 1560.000000 0.002637 -0.000150 0.006356 -5358 1 0.000193 1560.000000 -0.002341 0.000729 0.006378 -5359 1 0.000234 1560.000000 -0.002209 0.000370 0.004008 -5360 1 0.000265 1560.000000 -0.001857 0.000371 0.000658 -5361 1 0.000212 1560.000000 -0.002957 -0.000793 0.004975 -5362 1 0.000280 1560.000000 0.001713 -0.003261 0.004118 -5363 1 0.000216 1560.000000 0.000635 -0.000637 0.007134 -5364 1 0.000207 1560.000000 0.003271 -0.000866 0.005849 -5365 1 0.000196 1560.000000 -0.001543 0.002355 0.004837 -5366 1 0.000226 1560.000000 -0.001767 -0.001034 0.001360 -5367 1 0.000240 1560.000000 -0.000324 -0.000481 0.005582 -5368 1 0.000284 1560.000000 0.000625 -0.001825 0.006434 -5369 1 0.000195 1560.000000 -0.001411 -0.003492 0.001568 -5370 1 0.000214 1560.000000 0.003253 0.001217 0.000505 -5371 1 0.000241 1560.000000 0.000093 -0.003637 0.002448 -5372 1 0.000267 1560.000000 -0.000275 -0.002005 0.002473 -5373 1 0.000272 1560.000000 -0.003809 0.000219 0.004400 -5374 1 0.000199 1560.000000 -0.000873 0.002534 0.000289 -5375 1 0.000213 1560.000000 -0.000479 0.003338 0.003642 -5376 1 0.000202 1560.000000 -0.000141 -0.003366 0.005256 -5377 1 0.000245 1560.000000 0.003004 0.000727 0.000939 -5378 1 0.000263 1560.000000 0.002289 0.003101 0.002636 -5379 1 0.000202 1560.000000 0.002513 0.001273 0.000226 -5380 1 0.000207 1560.000000 0.001555 0.000049 0.001838 -5381 1 0.000238 1560.000000 0.000860 0.003102 0.001217 -5382 1 0.000214 1560.000000 0.000947 -0.001125 0.002167 -5383 1 0.000215 1560.000000 -0.002874 -0.000816 0.001789 -5384 1 0.000224 1560.000000 0.000388 0.003787 0.003817 -5385 1 0.000207 1560.000000 0.000247 0.002812 0.003789 -5386 1 0.000216 1560.000000 0.003209 -0.001436 0.001900 -5387 1 0.000197 1560.000000 0.000706 -0.000894 0.001453 -5388 1 0.000194 1560.000000 -0.000999 0.001507 0.008190 -5389 1 0.000277 1560.000000 -0.000203 0.002501 0.005694 -5390 1 0.000193 1560.000000 -0.002215 0.002291 0.009784 -5391 1 0.000252 1560.000000 0.001209 -0.002368 0.002252 -5392 1 0.000227 1560.000000 0.000827 0.001228 0.004540 -5393 1 0.000232 1560.000000 -0.002325 -0.000140 0.004441 -5394 1 0.000205 1560.000000 0.003348 -0.000465 0.000377 -5395 1 0.000258 1560.000000 -0.000803 -0.000413 0.007543 -5396 1 0.000253 1560.000000 -0.000600 0.001205 0.006910 -5397 1 0.000216 1560.000000 0.000018 0.001221 0.003704 -5398 1 0.000226 1560.000000 -0.002172 0.000488 0.008660 -5399 1 0.000246 1560.000000 0.002275 0.000403 0.008842 -5400 1 0.000199 1560.000000 0.002325 -0.002247 0.005704 -5401 1 0.000274 1560.000000 0.000981 -0.001821 0.009766 -5402 1 0.000209 1560.000000 -0.000280 -0.002857 0.005194 -5403 1 0.000240 1560.000000 -0.000324 0.000246 0.005855 -5404 1 0.000228 1560.000000 0.000217 0.002818 0.005896 -5405 1 0.000198 1560.000000 0.003364 -0.000625 0.003109 -5406 1 0.000208 1560.000000 0.000091 -0.003020 0.003969 -5407 1 0.000222 1560.000000 -0.000978 -0.000606 0.005012 -5408 1 0.000246 1560.000000 0.002376 -0.001965 0.005248 -5409 1 0.000251 1560.000000 -0.000679 -0.000590 0.001380 -5410 1 0.000201 1560.000000 0.002328 0.001060 0.009735 -5411 1 0.000209 1560.000000 -0.000465 -0.000336 0.009382 -5412 1 0.000276 1560.000000 -0.001587 0.003319 0.000719 -5413 1 0.000275 1560.000000 -0.001563 0.002514 0.004343 -5414 1 0.000228 1560.000000 0.000900 0.000404 0.009605 -5415 1 0.000215 1560.000000 0.002440 -0.000377 0.005534 -5416 1 0.000203 1560.000000 -0.003355 -0.000757 0.002735 -5417 1 0.000258 1560.000000 -0.002742 -0.000447 0.006884 -5418 1 0.000205 1560.000000 -0.002069 0.001623 0.005020 -5419 1 0.000201 1560.000000 -0.002436 -0.001137 0.009617 -5420 1 0.000201 1560.000000 -0.001415 -0.001958 0.000860 -5421 1 0.000218 1560.000000 0.003447 0.000362 0.008566 -5422 1 0.000225 1560.000000 -0.000723 -0.001615 0.005986 -5423 1 0.000257 1560.000000 -0.000083 -0.001626 0.005733 -5424 1 0.000216 1560.000000 0.002010 0.000187 0.005917 -5425 1 0.000203 1560.000000 -0.000445 0.000373 0.003564 -5426 1 0.000263 1560.000000 -0.002195 0.002154 0.001792 -5427 1 0.000266 1560.000000 -0.001712 0.001341 0.003038 -5428 1 0.000198 1560.000000 -0.000309 0.003660 0.009359 -5429 1 0.000258 1560.000000 -0.003357 -0.000355 0.008236 -5430 1 0.000197 1560.000000 0.000564 -0.000691 0.008013 -5431 1 0.000209 1560.000000 0.001156 -0.000270 0.007168 -5432 1 0.000246 1560.000000 -0.003161 0.001563 0.001554 -5433 1 0.000250 1560.000000 -0.001318 -0.003528 0.005369 -5434 1 0.000219 1560.000000 0.001296 0.000473 0.002889 -5435 1 0.000212 1560.000000 0.002258 0.001692 0.008711 -5436 1 0.000247 1560.000000 -0.001102 -0.002383 0.007004 -5437 1 0.000231 1560.000000 -0.001663 -0.002965 0.009622 -5438 1 0.000228 1560.000000 0.002393 -0.000056 0.006390 -5439 1 0.000221 1560.000000 0.000009 -0.001679 0.005225 -5440 1 0.000212 1560.000000 -0.003152 0.000378 0.000761 -5441 1 0.000216 1560.000000 0.003420 0.001214 0.005971 -5442 1 0.000276 1560.000000 0.002121 0.003134 0.001860 -5443 1 0.000227 1560.000000 -0.002112 0.000798 0.005816 -5444 1 0.000217 1560.000000 -0.001815 0.001637 0.000924 -5445 1 0.000263 1560.000000 -0.001289 -0.002762 0.002232 -5446 1 0.000216 1560.000000 0.000994 -0.002166 0.007827 -5447 1 0.000272 1560.000000 -0.001229 -0.001655 0.002646 -5448 1 0.000258 1560.000000 -0.001559 -0.001989 0.007509 -5449 1 0.000236 1560.000000 0.003199 -0.001726 0.006206 -5450 1 0.000270 1560.000000 -0.000064 0.003302 0.005187 -5451 1 0.000218 1560.000000 -0.000975 0.003034 0.000944 -5452 1 0.000208 1560.000000 -0.000475 0.002068 0.009682 -5453 1 0.000277 1560.000000 0.000024 0.002427 0.004551 -5454 1 0.000214 1560.000000 -0.002353 -0.002940 0.008656 -5455 1 0.000229 1560.000000 0.002018 0.002850 0.005542 -5456 1 0.000244 1560.000000 0.001624 0.001679 0.008456 -5457 1 0.000220 1560.000000 0.001327 -0.001281 0.006974 -5458 1 0.000243 1560.000000 0.001624 0.000165 0.003328 -5459 1 0.000266 1560.000000 -0.001446 0.000132 0.009077 -5460 1 0.000234 1560.000000 0.001797 0.001056 0.000760 -5461 1 0.000219 1560.000000 0.001491 0.001718 0.002285 -5462 1 0.000247 1560.000000 0.003421 -0.000033 0.008150 -5463 1 0.000223 1560.000000 0.000990 -0.000230 0.007753 -5464 1 0.000195 1560.000000 -0.002361 -0.000327 0.003381 -5465 1 0.000211 1560.000000 -0.002015 -0.000363 0.006676 -5466 1 0.000199 1560.000000 0.001055 0.001730 0.008831 -5467 1 0.000239 1560.000000 0.002345 0.000389 0.007217 -5468 1 0.000214 1560.000000 -0.002060 -0.000350 0.002743 -5469 1 0.000280 1560.000000 -0.001204 -0.000826 0.000595 -5470 1 0.000234 1560.000000 0.000406 -0.000001 0.000429 -5471 1 0.000261 1560.000000 -0.000986 0.003709 0.009391 -5472 1 0.000204 1560.000000 0.001065 -0.000218 0.008602 -5473 1 0.000195 1560.000000 -0.001488 -0.002097 0.006217 -5474 1 0.000262 1560.000000 -0.002326 -0.000367 0.009234 -5475 1 0.000230 1560.000000 0.002794 0.002304 0.006433 -5476 1 0.000256 1560.000000 0.001259 0.001760 0.007380 -5477 1 0.000210 1560.000000 -0.002407 0.000518 0.008998 -5478 1 0.000263 1560.000000 -0.000737 0.000295 0.001299 -5479 1 0.000256 1560.000000 0.000087 -0.000859 0.002391 -5480 1 0.000263 1560.000000 0.001081 0.002331 0.001915 -5481 1 0.000219 1560.000000 0.001620 -0.002514 0.005943 -5482 1 0.000194 1560.000000 -0.001206 -0.001575 0.001705 -5483 1 0.000207 1560.000000 0.001124 -0.000605 0.008350 -5484 1 0.000200 1560.000000 0.001082 0.000129 0.000508 -5485 1 0.000225 1560.000000 -0.000013 -0.001598 0.007142 -5486 1 0.000218 1560.000000 -0.002917 -0.000315 0.000195 -5487 1 0.000223 1560.000000 -0.000680 0.000262 0.009555 -5488 1 0.000209 1560.000000 0.000237 -0.001608 0.004654 -5489 1 0.000210 1560.000000 -0.001893 -0.002577 0.009815 -5490 1 0.000205 1560.000000 0.000969 -0.002912 0.006194 -5491 1 0.000275 1560.000000 0.000298 -0.000089 0.000652 -5492 1 0.000218 1560.000000 0.001542 0.001172 0.006041 -5493 1 0.000228 1560.000000 0.001331 -0.001209 0.005053 -5494 1 0.000240 1560.000000 0.001380 -0.000189 0.003775 -5495 1 0.000286 1560.000000 0.001791 0.001300 0.004841 -5496 1 0.000210 1560.000000 0.000492 0.003706 0.003387 -5497 1 0.000219 1560.000000 0.003404 0.001786 0.000652 -5498 1 0.000215 1560.000000 0.003784 -0.000701 0.007566 -5499 1 0.000195 1560.000000 0.002182 0.001574 0.006534 -5500 1 0.000282 1560.000000 0.003636 0.000778 0.006067 -5501 1 0.000259 1560.000000 -0.002671 -0.002056 0.004588 -5502 1 0.000205 1560.000000 -0.001084 0.002111 0.001122 -5503 1 0.000270 1560.000000 0.001755 -0.002104 0.007940 -5504 1 0.000256 1560.000000 -0.001754 0.003312 0.009527 -5505 1 0.000246 1560.000000 -0.000806 -0.001366 0.009108 -5506 1 0.000200 1560.000000 -0.003332 -0.001641 0.002485 -5507 1 0.000264 1560.000000 0.003072 0.000759 0.003323 -5508 1 0.000217 1560.000000 -0.000836 -0.001816 0.004634 -5509 1 0.000267 1560.000000 -0.000601 0.003701 0.003605 -5510 1 0.000209 1560.000000 -0.002865 -0.000841 0.009370 -5511 1 0.000246 1560.000000 0.001697 -0.002050 0.009073 -5512 1 0.000268 1560.000000 -0.000710 0.002733 0.007980 -5513 1 0.000211 1560.000000 -0.001716 -0.001246 0.006401 -5514 1 0.000213 1560.000000 -0.000932 -0.001310 0.002059 -5515 1 0.000234 1560.000000 0.001095 -0.003600 0.003932 -5516 1 0.000195 1560.000000 0.002121 0.000654 0.005698 -5517 1 0.000224 1560.000000 0.000400 -0.000269 0.002296 -5518 1 0.000241 1560.000000 -0.003361 0.000349 0.008885 -5519 1 0.000277 1560.000000 0.002447 0.002896 0.001309 -5520 1 0.000203 1560.000000 -0.002655 -0.000484 0.002005 -5521 1 0.000197 1560.000000 -0.000882 0.000775 0.004864 -5522 1 0.000223 1560.000000 -0.002115 0.000959 0.003176 -5523 1 0.000211 1560.000000 0.000392 0.002708 0.007117 -5524 1 0.000258 1560.000000 0.000736 -0.002547 0.002566 -5525 1 0.000250 1560.000000 0.003493 -0.001210 0.005228 -5526 1 0.000218 1560.000000 0.000188 -0.000087 0.008886 -5527 1 0.000210 1560.000000 0.001435 0.002433 0.002972 -5528 1 0.000253 1560.000000 0.002229 -0.000628 0.005222 -5529 1 0.000202 1560.000000 0.000507 0.001795 0.002524 -5530 1 0.000254 1560.000000 0.003101 0.002273 0.009463 -5531 1 0.000196 1560.000000 -0.000647 0.000847 0.000810 -5532 1 0.000205 1560.000000 0.002157 -0.000832 0.006170 -5533 1 0.000207 1560.000000 0.000834 -0.000418 0.003151 -5534 1 0.000193 1560.000000 0.003167 0.000239 0.001439 -5535 1 0.000192 1560.000000 0.003182 -0.000850 0.001875 -5536 1 0.000223 1560.000000 -0.002098 -0.001657 0.002894 -5537 1 0.000224 1560.000000 -0.003095 0.000750 0.004875 -5538 1 0.000249 1560.000000 0.002438 -0.000106 0.005871 -5539 1 0.000223 1560.000000 0.001289 -0.002389 0.000175 -5540 1 0.000254 1560.000000 -0.003725 0.000340 0.004849 -5541 1 0.000235 1560.000000 0.002424 -0.001268 0.007727 -5542 1 0.000210 1560.000000 0.001862 -0.000292 0.005373 -5543 1 0.000243 1560.000000 0.002354 0.002527 0.002735 -5544 1 0.000215 1560.000000 0.000777 -0.001925 0.007944 -5545 1 0.000247 1560.000000 0.002078 -0.002180 0.009727 -5546 1 0.000248 1560.000000 -0.002565 -0.000262 0.002399 -5547 1 0.000201 1560.000000 -0.000234 0.001074 0.002826 -5548 1 0.000235 1560.000000 -0.001626 -0.002011 0.008353 -5549 1 0.000242 1560.000000 0.001401 0.002698 0.004930 -5550 1 0.000207 1560.000000 -0.000331 -0.002634 0.009782 -5551 1 0.000202 1560.000000 0.001292 -0.000990 0.005196 -5552 1 0.000272 1560.000000 -0.001177 0.000371 0.005971 -5553 1 0.000225 1560.000000 0.002124 -0.001627 0.009571 -5554 1 0.000215 1560.000000 -0.001248 0.001113 0.002649 -5555 1 0.000199 1560.000000 0.003530 -0.001255 0.004531 -5556 1 0.000243 1560.000000 0.003249 0.000569 0.001331 -5557 1 0.000255 1560.000000 -0.001296 0.002788 0.006918 -5558 1 0.000222 1560.000000 -0.001240 -0.000184 0.002900 -5559 1 0.000205 1560.000000 0.003205 0.000257 0.003525 -5560 1 0.000279 1560.000000 -0.001676 -0.000873 0.000516 -5561 1 0.000284 1560.000000 -0.000740 -0.000922 0.000694 -5562 1 0.000248 1560.000000 0.000125 -0.002661 0.003141 -5563 1 0.000197 1560.000000 0.000577 0.001343 0.004117 -5564 1 0.000262 1560.000000 0.000109 0.003418 0.007542 -5565 1 0.000227 1560.000000 -0.003546 0.001087 0.008193 -5566 1 0.000224 1560.000000 0.001375 0.001768 0.005115 -5567 1 0.000220 1560.000000 0.001305 0.000373 0.008982 -5568 1 0.000244 1560.000000 0.001458 0.002835 0.001401 -5569 1 0.000209 1560.000000 -0.000446 -0.000139 0.004612 -5570 1 0.000212 1560.000000 0.001964 0.002164 0.000973 -5571 1 0.000209 1560.000000 -0.000812 -0.000207 0.008660 -5572 1 0.000238 1560.000000 -0.000823 -0.003239 0.004753 -5573 1 0.000199 1560.000000 -0.000116 0.001218 0.003328 -5574 1 0.000255 1560.000000 0.000488 0.000215 0.004123 -5575 1 0.000214 1560.000000 0.000286 0.001098 0.003730 -5576 1 0.000269 1560.000000 0.003284 0.000301 0.006214 -5577 1 0.000197 1560.000000 -0.000798 -0.003286 0.004520 -5578 1 0.000200 1560.000000 0.002967 -0.000413 0.007427 -5579 1 0.000237 1560.000000 0.002557 -0.001946 0.005703 -5580 1 0.000283 1560.000000 0.001484 -0.001499 0.005786 -5581 1 0.000262 1560.000000 0.002928 0.000766 0.008491 -5582 1 0.000227 1560.000000 0.001421 0.001719 0.008307 -5583 1 0.000224 1560.000000 -0.002467 -0.000604 0.004054 -5584 1 0.000265 1560.000000 0.002473 -0.002908 0.004586 -5585 1 0.000285 1560.000000 0.002316 0.001077 0.004493 -5586 1 0.000208 1560.000000 0.001564 0.002955 0.006033 -5587 1 0.000229 1560.000000 0.000990 -0.002761 0.000715 -5588 1 0.000242 1560.000000 -0.000526 -0.003313 0.002670 -5589 1 0.000251 1560.000000 -0.001447 0.000319 0.003159 -5590 1 0.000286 1560.000000 -0.001137 0.001315 0.006819 -5591 1 0.000223 1560.000000 -0.001977 0.001646 0.001712 -5592 1 0.000250 1560.000000 0.000589 -0.000119 0.003905 -5593 1 0.000268 1560.000000 -0.002123 -0.002799 0.008843 -5594 1 0.000227 1560.000000 0.000981 -0.000778 0.002187 -5595 1 0.000229 1560.000000 -0.000527 -0.002690 0.008449 -5596 1 0.000196 1560.000000 -0.002113 0.000472 0.005723 -5597 1 0.000248 1560.000000 0.002197 0.001149 0.001300 -5598 1 0.000225 1560.000000 -0.003632 -0.000526 0.007412 -5599 1 0.000239 1560.000000 -0.001983 0.002021 0.008415 -5600 1 0.000193 1560.000000 -0.001334 -0.002794 0.007466 -5601 1 0.000275 1560.000000 -0.001338 0.002079 0.000153 -5602 1 0.000193 1560.000000 -0.000430 0.000123 0.008584 -5603 1 0.000245 1560.000000 0.000298 0.001998 0.001456 -5604 1 0.000235 1560.000000 -0.003044 -0.000614 0.005945 -5605 1 0.000282 1560.000000 0.003076 -0.000625 0.001645 -5606 1 0.000211 1560.000000 0.002183 -0.000747 0.003057 -5607 1 0.000226 1560.000000 -0.000583 -0.001635 0.002567 -5608 1 0.000233 1560.000000 0.000289 0.001192 0.004970 -5609 1 0.000276 1560.000000 -0.001070 0.000513 0.007510 -5610 1 0.000239 1560.000000 0.001280 -0.000440 0.000598 -5611 1 0.000253 1560.000000 -0.001372 0.003427 0.002487 -5612 1 0.000212 1560.000000 -0.002946 -0.001548 0.006434 -5613 1 0.000247 1560.000000 -0.001176 0.003123 0.009080 -5614 1 0.000211 1560.000000 -0.001362 0.001223 0.008063 -5615 1 0.000194 1560.000000 -0.000582 -0.001383 0.001476 -5616 1 0.000259 1560.000000 -0.003410 -0.000338 0.008497 -5617 1 0.000257 1560.000000 -0.001305 0.000440 0.002094 -5618 1 0.000287 1560.000000 -0.001071 0.002240 0.003886 -5619 1 0.000263 1560.000000 -0.000425 -0.003082 0.002589 -5620 1 0.000228 1560.000000 -0.000881 0.001815 0.004813 -5621 1 0.000207 1560.000000 -0.001203 0.002319 0.004119 -5622 1 0.000205 1560.000000 0.000163 -0.002130 0.002478 -5623 1 0.000229 1560.000000 0.000413 0.000366 0.005124 -5624 1 0.000244 1560.000000 -0.000761 -0.002699 0.002734 -5625 1 0.000255 1560.000000 0.002939 -0.002485 0.006870 -5626 1 0.000250 1560.000000 0.000359 -0.000252 0.007737 -5627 1 0.000218 1560.000000 0.003141 -0.001875 0.002466 -5628 1 0.000210 1560.000000 0.000805 -0.000432 0.004187 -5629 1 0.000223 1560.000000 -0.000105 -0.001357 0.001272 -5630 1 0.000242 1560.000000 0.001425 0.000313 0.008227 -5631 1 0.000261 1560.000000 -0.000440 -0.001473 0.005843 -5632 1 0.000193 1560.000000 0.001638 0.000324 0.002187 -5633 1 0.000262 1560.000000 -0.002498 0.000503 0.004672 -5634 1 0.000226 1560.000000 -0.000900 0.001024 0.006395 -5635 1 0.000196 1560.000000 0.000940 0.000562 0.003645 -5636 1 0.000195 1560.000000 -0.001317 0.000057 0.001046 -5637 1 0.000226 1560.000000 0.000628 0.000200 0.005787 -5638 1 0.000195 1560.000000 -0.001808 0.000183 0.001081 -5639 1 0.000284 1560.000000 0.000553 0.001764 0.005066 -5640 1 0.000262 1560.000000 -0.001501 0.000703 0.005541 -5641 1 0.000213 1560.000000 -0.001968 -0.000389 0.008958 -5642 1 0.000285 1560.000000 0.001052 -0.000268 0.003341 -5643 1 0.000224 1560.000000 0.000955 -0.001248 0.001617 -5644 1 0.000195 1560.000000 -0.002679 0.001610 0.001100 -5645 1 0.000276 1560.000000 -0.001777 -0.000283 0.000329 -5646 1 0.000285 1560.000000 0.001638 0.002255 0.007846 -5647 1 0.000224 1560.000000 -0.002545 0.000051 0.001364 -5648 1 0.000192 1560.000000 -0.003000 0.001728 0.003796 -5649 1 0.000284 1560.000000 -0.001015 -0.003375 0.005572 -5650 1 0.000262 1560.000000 0.000749 -0.002752 0.001476 -5651 1 0.000267 1560.000000 -0.000786 -0.002390 0.007832 -5652 1 0.000193 1560.000000 0.001939 0.001636 0.008330 -5653 1 0.000211 1560.000000 0.002003 -0.002991 0.008255 -5654 1 0.000251 1560.000000 0.000183 -0.001935 0.001802 -5655 1 0.000248 1560.000000 -0.001965 0.000318 0.008152 -5656 1 0.000205 1560.000000 -0.000207 -0.001982 0.001807 -5657 1 0.000210 1560.000000 0.001802 0.001062 0.001973 -5658 1 0.000195 1560.000000 -0.000153 0.000182 0.002629 -5659 1 0.000281 1560.000000 0.002520 0.001986 0.008341 -5660 1 0.000274 1560.000000 -0.001329 0.000643 0.006206 -5661 1 0.000224 1560.000000 0.002445 -0.002176 0.002996 -5662 1 0.000266 1560.000000 0.002095 -0.001550 0.008582 -5663 1 0.000204 1560.000000 0.003274 -0.001657 0.002454 -5664 1 0.000273 1560.000000 -0.000532 0.003611 0.007416 -5665 1 0.000213 1560.000000 -0.001127 0.001785 0.007048 -5666 1 0.000230 1560.000000 -0.002114 0.000597 0.006379 -5667 1 0.000216 1560.000000 -0.002157 0.001178 0.008375 -5668 1 0.000209 1560.000000 0.002739 -0.002352 0.002888 -5669 1 0.000260 1560.000000 -0.002523 0.001152 0.002990 -5670 1 0.000229 1560.000000 0.003085 0.000431 0.005029 -5671 1 0.000209 1560.000000 0.001414 -0.001455 0.004706 -5672 1 0.000206 1560.000000 0.000441 0.000482 0.007214 -5673 1 0.000197 1560.000000 -0.002185 -0.000831 0.002784 -5674 1 0.000192 1560.000000 0.000132 -0.003572 0.009441 -5675 1 0.000249 1560.000000 -0.000550 -0.001521 0.003915 -5676 1 0.000264 1560.000000 0.001744 0.001341 0.006463 -5677 1 0.000253 1560.000000 0.001227 0.000390 0.001563 -5678 1 0.000241 1560.000000 0.001082 -0.001689 0.008638 -5679 1 0.000266 1560.000000 -0.001282 -0.000178 0.007443 -5680 1 0.000201 1560.000000 -0.002336 0.002646 0.005661 -5681 1 0.000278 1560.000000 0.001545 0.001911 0.001273 -5682 1 0.000199 1560.000000 0.001228 0.001196 0.007675 -5683 1 0.000271 1560.000000 -0.000499 -0.000518 0.007955 -5684 1 0.000241 1560.000000 0.003333 0.001459 0.009630 -5685 1 0.000235 1560.000000 0.000251 0.003484 0.006781 -5686 1 0.000218 1560.000000 -0.000352 0.001219 0.009403 -5687 1 0.000279 1560.000000 0.003800 0.000376 0.003581 -5688 1 0.000198 1560.000000 -0.001395 -0.003285 0.003057 -5689 1 0.000249 1560.000000 0.002173 -0.002240 0.000771 -5690 1 0.000216 1560.000000 0.001006 -0.001313 0.006825 -5691 1 0.000238 1560.000000 -0.002039 0.001848 0.006968 -5692 1 0.000249 1560.000000 -0.001615 0.002280 0.007895 -5693 1 0.000247 1560.000000 0.002512 -0.001116 0.002338 -5694 1 0.000235 1560.000000 0.003257 0.000027 0.001518 -5695 1 0.000227 1560.000000 0.000541 -0.001221 0.004619 -5696 1 0.000287 1560.000000 0.002537 -0.000363 0.009194 -5697 1 0.000216 1560.000000 -0.002836 -0.002494 0.005203 -5698 1 0.000288 1560.000000 0.002672 -0.001442 0.000419 -5699 1 0.000203 1560.000000 0.001815 -0.001001 0.001674 -5700 1 0.000258 1560.000000 0.000759 0.003442 0.007259 -5701 1 0.000202 1560.000000 0.002528 -0.002896 0.004830 -5702 1 0.000207 1560.000000 -0.001288 -0.000918 0.004682 -5703 1 0.000213 1560.000000 0.000205 -0.003811 0.001734 -5704 1 0.000221 1560.000000 0.000484 0.000694 0.007248 -5705 1 0.000269 1560.000000 0.001351 -0.002187 0.007645 -5706 1 0.000254 1560.000000 0.000961 0.003511 0.005937 -5707 1 0.000197 1560.000000 -0.001507 0.002761 0.005056 -5708 1 0.000222 1560.000000 -0.002226 0.003046 0.003510 -5709 1 0.000210 1560.000000 -0.000621 -0.000008 0.003647 -5710 1 0.000216 1560.000000 -0.000557 -0.000061 0.009492 -5711 1 0.000210 1560.000000 0.001224 0.002868 0.001088 -5712 1 0.000230 1560.000000 0.000805 0.000577 0.001914 -5713 1 0.000225 1560.000000 -0.001343 0.001358 0.002539 -5714 1 0.000285 1560.000000 0.000260 0.003528 0.005940 -5715 1 0.000283 1560.000000 -0.001404 -0.003304 0.008578 -5716 1 0.000227 1560.000000 0.000051 -0.003335 0.006142 -5717 1 0.000221 1560.000000 -0.002401 0.001585 0.008110 -5718 1 0.000255 1560.000000 0.001570 0.002447 0.007592 -5719 1 0.000208 1560.000000 0.001657 -0.001703 0.003494 -5720 1 0.000247 1560.000000 0.000873 0.000000 0.001351 -5721 1 0.000255 1560.000000 -0.001555 0.002973 0.000829 -5722 1 0.000237 1560.000000 -0.001351 -0.002461 0.006746 -5723 1 0.000266 1560.000000 -0.002618 0.001896 0.002895 -5724 1 0.000231 1560.000000 -0.002803 -0.001306 0.006948 -5725 1 0.000230 1560.000000 0.000768 0.003630 0.008287 -5726 1 0.000200 1560.000000 0.000866 -0.002959 0.008745 -5727 1 0.000261 1560.000000 0.000616 0.003380 0.009606 -5728 1 0.000231 1560.000000 0.001767 -0.001011 0.001337 -5729 1 0.000246 1560.000000 -0.002579 -0.001387 0.002141 -5730 1 0.000235 1560.000000 0.002771 0.000811 0.008216 -5731 1 0.000220 1560.000000 -0.000566 0.001713 0.002246 -5732 1 0.000216 1560.000000 0.002964 -0.000800 0.005598 -5733 1 0.000198 1560.000000 -0.001977 0.001162 0.003479 -5734 1 0.000279 1560.000000 0.000838 0.002572 0.005958 -5735 1 0.000280 1560.000000 0.000256 0.003710 0.008714 -5736 1 0.000265 1560.000000 -0.000833 0.003279 0.003322 -5737 1 0.000284 1560.000000 0.000700 0.003125 0.008213 -5738 1 0.000205 1560.000000 0.001286 0.001387 0.005838 -5739 1 0.000193 1560.000000 0.001653 -0.000780 0.000891 -5740 1 0.000260 1560.000000 -0.002800 -0.000489 0.004095 -5741 1 0.000217 1560.000000 -0.003433 -0.001091 0.000505 -5742 1 0.000253 1560.000000 0.000146 0.000926 0.005379 -5743 1 0.000210 1560.000000 -0.001818 0.002096 0.005591 -5744 1 0.000279 1560.000000 -0.000236 0.002268 0.007628 -5745 1 0.000209 1560.000000 -0.000927 -0.001485 0.000348 -5746 1 0.000260 1560.000000 -0.001550 -0.002656 0.004747 -5747 1 0.000254 1560.000000 -0.001370 -0.000853 0.007679 -5748 1 0.000233 1560.000000 -0.001338 0.001642 0.003517 -5749 1 0.000254 1560.000000 -0.000796 0.001186 0.002367 -5750 1 0.000262 1560.000000 -0.003280 -0.001737 0.008266 -5751 1 0.000225 1560.000000 -0.000682 -0.001164 0.006970 -5752 1 0.000196 1560.000000 0.001476 0.001058 0.003427 -5753 1 0.000272 1560.000000 -0.000082 0.001389 0.004958 -5754 1 0.000222 1560.000000 -0.001851 0.000321 0.005625 -5755 1 0.000240 1560.000000 -0.000260 -0.003382 0.006077 -5756 1 0.000279 1560.000000 0.003475 0.001594 0.000794 -5757 1 0.000221 1560.000000 -0.002991 0.001553 0.002719 -5758 1 0.000227 1560.000000 -0.001854 -0.000368 0.007504 -5759 1 0.000200 1560.000000 -0.001777 -0.003034 0.001171 -5760 1 0.000281 1560.000000 0.001302 0.003525 0.000653 -5761 1 0.000216 1560.000000 0.001199 -0.001359 0.007156 -5762 1 0.000262 1560.000000 0.002790 -0.001286 0.007235 -5763 1 0.000262 1560.000000 -0.000710 0.000996 0.006125 -5764 1 0.000238 1560.000000 0.000376 0.000457 0.002408 -5765 1 0.000263 1560.000000 0.000781 0.000782 0.008075 -5766 1 0.000258 1560.000000 0.002025 0.002554 0.000891 -5767 1 0.000212 1560.000000 0.003715 0.000650 0.005413 -5768 1 0.000202 1560.000000 0.002271 -0.003088 0.008169 -5769 1 0.000218 1560.000000 -0.002022 -0.003172 0.009369 -5770 1 0.000200 1560.000000 -0.001531 0.001239 0.008217 -5771 1 0.000250 1560.000000 0.001387 0.000139 0.004185 -5772 1 0.000197 1560.000000 -0.002930 -0.001586 0.000417 -5773 1 0.000241 1560.000000 0.001874 -0.000189 0.001825 -5774 1 0.000210 1560.000000 0.000137 0.000499 0.008537 -5775 1 0.000250 1560.000000 0.000219 -0.000575 0.006733 -5776 1 0.000272 1560.000000 -0.000964 0.002557 0.004924 -5777 1 0.000230 1560.000000 0.002229 0.001596 0.005373 -5778 1 0.000203 1560.000000 0.002047 0.001854 0.007942 -5779 1 0.000222 1560.000000 -0.001564 0.001481 0.006378 -5780 1 0.000195 1560.000000 0.002564 -0.002536 0.005374 -5781 1 0.000223 1560.000000 0.000454 0.000962 0.004044 -5782 1 0.000288 1560.000000 -0.002744 -0.000748 0.000551 -5783 1 0.000219 1560.000000 0.001184 -0.002435 0.009362 -5784 1 0.000232 1560.000000 0.002464 -0.002068 0.005945 -5785 1 0.000226 1560.000000 0.000820 0.000172 0.006986 -5786 1 0.000214 1560.000000 -0.000450 0.003286 0.005549 -5787 1 0.000202 1560.000000 -0.000217 0.000448 0.002246 -5788 1 0.000206 1560.000000 0.001845 0.000267 0.000819 -5789 1 0.000198 1560.000000 -0.002634 -0.001209 0.005405 -5790 1 0.000203 1560.000000 0.000761 0.001957 0.003606 -5791 1 0.000213 1560.000000 -0.002186 0.002731 0.002885 -5792 1 0.000288 1560.000000 -0.000583 -0.002630 0.004733 -5793 1 0.000214 1560.000000 0.002492 -0.002050 0.008653 -5794 1 0.000194 1560.000000 0.002843 -0.001071 0.007621 -5795 1 0.000278 1560.000000 -0.002984 -0.000393 0.007094 -5796 1 0.000223 1560.000000 0.002554 -0.001430 0.003289 -5797 1 0.000233 1560.000000 -0.002836 -0.001248 0.000772 -5798 1 0.000254 1560.000000 0.002510 0.002805 0.006405 -5799 1 0.000193 1560.000000 0.002895 -0.001234 0.001918 -5800 1 0.000253 1560.000000 -0.001635 0.000555 0.009497 -5801 1 0.000208 1560.000000 0.003116 -0.000661 0.002363 -5802 1 0.000221 1560.000000 -0.000864 0.002187 0.008207 -5803 1 0.000279 1560.000000 -0.000637 -0.001724 0.007934 -5804 1 0.000209 1560.000000 0.000685 0.001929 0.000128 -5805 1 0.000194 1560.000000 -0.000261 0.000188 0.004967 -5806 1 0.000196 1560.000000 0.002402 -0.001061 0.009078 -5807 1 0.000272 1560.000000 -0.003129 -0.000322 0.005717 -5808 1 0.000250 1560.000000 0.002584 -0.002204 0.006856 -5809 1 0.000205 1560.000000 -0.002937 0.000288 0.009274 -5810 1 0.000251 1560.000000 -0.002731 -0.000839 0.005509 -5811 1 0.000283 1560.000000 -0.000763 0.001074 0.008827 -5812 1 0.000229 1560.000000 -0.000695 -0.000259 0.005293 -5813 1 0.000239 1560.000000 -0.002228 -0.001128 0.000434 -5814 1 0.000200 1560.000000 0.002124 0.001469 0.003739 -5815 1 0.000245 1560.000000 0.002526 0.000261 0.007750 -5816 1 0.000205 1560.000000 -0.000134 -0.002236 0.000970 -5817 1 0.000218 1560.000000 0.000197 0.000799 0.000480 -5818 1 0.000194 1560.000000 0.000075 -0.001345 0.007997 -5819 1 0.000231 1560.000000 0.002750 -0.000990 0.001229 -5820 1 0.000220 1560.000000 -0.001774 0.002392 0.006635 -5821 1 0.000268 1560.000000 -0.002929 0.002293 0.003552 -5822 1 0.000257 1560.000000 -0.001235 0.000786 0.008504 -5823 1 0.000205 1560.000000 0.002856 0.001771 0.001990 -5824 1 0.000235 1560.000000 0.003472 -0.000585 0.002280 -5825 1 0.000241 1560.000000 -0.000308 -0.002211 0.004655 -5826 1 0.000217 1560.000000 -0.001686 0.000506 0.001898 -5827 1 0.000235 1560.000000 0.003213 -0.000368 0.006730 -5828 1 0.000222 1560.000000 -0.003294 0.001500 0.008462 -5829 1 0.000280 1560.000000 -0.000864 0.003606 0.001416 -5830 1 0.000218 1560.000000 0.000896 -0.003332 0.000262 -5831 1 0.000220 1560.000000 -0.003095 0.000410 0.006669 -5832 1 0.000239 1560.000000 -0.002061 -0.001331 0.002392 -5833 1 0.000226 1560.000000 0.000119 0.000223 0.002565 -5834 1 0.000213 1560.000000 0.000024 0.002322 0.006773 -5835 1 0.000202 1560.000000 0.001482 -0.002482 0.007821 -5836 1 0.000268 1560.000000 -0.001910 -0.003310 0.007633 -5837 1 0.000200 1560.000000 0.000937 -0.002467 0.009422 -5838 1 0.000263 1560.000000 0.001566 -0.001071 0.003492 -5839 1 0.000213 1560.000000 0.003242 0.000034 0.001279 -5840 1 0.000203 1560.000000 0.001839 0.000493 0.003568 -5841 1 0.000265 1560.000000 0.003153 -0.000861 0.001257 -5842 1 0.000229 1560.000000 -0.001054 0.001481 0.009091 -5843 1 0.000263 1560.000000 -0.002724 0.000030 0.001087 -5844 1 0.000234 1560.000000 0.000228 -0.001442 0.001030 -5845 1 0.000205 1560.000000 0.002855 0.002056 0.007085 -5846 1 0.000226 1560.000000 -0.000106 -0.002027 0.007769 -5847 1 0.000201 1560.000000 -0.000257 0.001965 0.009188 -5848 1 0.000232 1560.000000 0.000500 0.002252 0.008522 -5849 1 0.000272 1560.000000 0.002826 -0.001127 0.005228 -5850 1 0.000201 1560.000000 0.001979 0.002703 0.004807 -5851 1 0.000203 1560.000000 0.000621 0.000508 0.000371 -5852 1 0.000238 1560.000000 0.001605 -0.000843 0.000124 -5853 1 0.000208 1560.000000 0.001383 0.002682 0.005445 -5854 1 0.000223 1560.000000 0.001115 -0.003021 0.001757 -5855 1 0.000284 1560.000000 -0.002773 0.000149 0.007318 -5856 1 0.000199 1560.000000 0.001890 -0.000078 0.003658 -5857 1 0.000209 1560.000000 0.001197 0.001615 0.000156 -5858 1 0.000203 1560.000000 0.001849 -0.001428 0.009710 -5859 1 0.000204 1560.000000 0.002555 -0.001961 0.005469 -5860 1 0.000206 1560.000000 -0.003072 0.002002 0.007418 -5861 1 0.000208 1560.000000 0.001107 0.000176 0.001148 -5862 1 0.000213 1560.000000 0.003033 -0.000577 0.003969 -5863 1 0.000225 1560.000000 -0.001173 -0.000038 0.007037 -5864 1 0.000258 1560.000000 -0.001234 0.002384 0.002327 -5865 1 0.000266 1560.000000 0.001305 -0.001181 0.000495 -5866 1 0.000194 1560.000000 -0.000994 0.003585 0.002686 -5867 1 0.000238 1560.000000 -0.001076 -0.000199 0.006580 -5868 1 0.000193 1560.000000 0.001311 0.000802 0.005019 -5869 1 0.000221 1560.000000 -0.002099 0.002794 0.008675 -5870 1 0.000212 1560.000000 0.002557 0.000525 0.006983 -5871 1 0.000275 1560.000000 0.002583 -0.001926 0.009623 -5872 1 0.000204 1560.000000 0.001022 -0.003089 0.003324 -5873 1 0.000210 1560.000000 0.000103 -0.002890 0.006019 -5874 1 0.000200 1560.000000 0.001872 0.002892 0.000728 -5875 1 0.000274 1560.000000 0.000111 -0.001219 0.009381 -5876 1 0.000275 1560.000000 -0.001043 -0.001911 0.004078 -5877 1 0.000243 1560.000000 0.000349 -0.002219 0.006327 -5878 1 0.000205 1560.000000 0.002895 -0.001249 0.004404 -5879 1 0.000206 1560.000000 -0.002511 -0.002797 0.009718 -5880 1 0.000225 1560.000000 -0.003502 0.000484 0.003874 -5881 1 0.000219 1560.000000 0.002119 -0.000840 0.003251 -5882 1 0.000257 1560.000000 -0.000234 0.001396 0.002710 -5883 1 0.000213 1560.000000 0.000669 -0.000569 0.008430 -5884 1 0.000246 1560.000000 0.001137 0.003484 0.003878 -5885 1 0.000221 1560.000000 -0.002204 0.000874 0.009473 -5886 1 0.000237 1560.000000 0.002427 0.000732 0.002230 -5887 1 0.000261 1560.000000 -0.001490 -0.002303 0.004721 -5888 1 0.000222 1560.000000 -0.001268 -0.001494 0.009126 -5889 1 0.000242 1560.000000 -0.003201 -0.000949 0.009680 -5890 1 0.000251 1560.000000 -0.000487 -0.002566 0.002632 -5891 1 0.000275 1560.000000 0.001802 -0.002229 0.006643 -5892 1 0.000204 1560.000000 0.000948 0.002987 0.002844 -5893 1 0.000233 1560.000000 -0.000610 0.000411 0.007315 -5894 1 0.000218 1560.000000 -0.002695 0.001555 0.009363 -5895 1 0.000242 1560.000000 -0.000163 -0.003016 0.000786 -5896 1 0.000222 1560.000000 0.000200 -0.002533 0.009627 -5897 1 0.000286 1560.000000 -0.001145 -0.001027 0.009455 -5898 1 0.000243 1560.000000 -0.000466 0.003340 0.005820 -5899 1 0.000192 1560.000000 0.001184 -0.000811 0.001767 -5900 1 0.000269 1560.000000 -0.003715 -0.000943 0.000331 -5901 1 0.000205 1560.000000 -0.002764 0.001454 0.007986 -5902 1 0.000202 1560.000000 0.002563 0.000006 0.004795 -5903 1 0.000196 1560.000000 -0.000835 -0.002094 0.005392 -5904 1 0.000227 1560.000000 -0.000871 0.003373 0.005824 -5905 1 0.000203 1560.000000 -0.001119 -0.002487 0.007608 -5906 1 0.000198 1560.000000 0.000631 -0.000616 0.000920 -5907 1 0.000213 1560.000000 -0.003450 -0.001244 0.005621 -5908 1 0.000233 1560.000000 -0.000612 -0.003719 0.002596 -5909 1 0.000260 1560.000000 0.003045 -0.001113 0.006990 -5910 1 0.000228 1560.000000 -0.000570 0.001574 0.001485 -5911 1 0.000208 1560.000000 -0.001083 -0.002089 0.006054 -5912 1 0.000235 1560.000000 0.003324 -0.001046 0.008309 -5913 1 0.000202 1560.000000 -0.002025 -0.001612 0.002652 -5914 1 0.000283 1560.000000 -0.000035 -0.003697 0.007170 -5915 1 0.000263 1560.000000 -0.003353 -0.001867 0.006300 -5916 1 0.000278 1560.000000 -0.001878 -0.000890 0.007017 -5917 1 0.000192 1560.000000 0.001589 0.001916 0.004142 -5918 1 0.000225 1560.000000 -0.001265 0.001819 0.005518 -5919 1 0.000230 1560.000000 0.002190 0.001175 0.002064 -5920 1 0.000267 1560.000000 -0.001381 -0.000941 0.008226 -5921 1 0.000274 1560.000000 -0.000252 -0.001470 0.004965 -5922 1 0.000252 1560.000000 -0.002671 -0.002552 0.008887 -5923 1 0.000226 1560.000000 -0.002225 0.000118 0.003923 -5924 1 0.000268 1560.000000 0.001808 -0.002618 0.004249 -5925 1 0.000257 1560.000000 0.000934 -0.002173 0.000475 -5926 1 0.000204 1560.000000 0.002644 0.001030 0.002665 -5927 1 0.000224 1560.000000 0.002439 0.002340 0.006631 -5928 1 0.000221 1560.000000 -0.001674 -0.002200 0.007925 -5929 1 0.000228 1560.000000 0.002061 -0.000258 0.008027 -5930 1 0.000229 1560.000000 -0.000120 -0.002093 0.000672 -5931 1 0.000206 1560.000000 -0.002911 -0.000010 0.008594 -5932 1 0.000254 1560.000000 -0.001603 -0.001147 0.001500 -5933 1 0.000264 1560.000000 0.000771 -0.003649 0.002711 -5934 1 0.000283 1560.000000 0.003181 0.001248 0.005348 -5935 1 0.000275 1560.000000 -0.000025 0.003299 0.001540 -5936 1 0.000245 1560.000000 -0.003212 -0.001234 0.002810 -5937 1 0.000208 1560.000000 -0.003061 0.000962 0.003887 -5938 1 0.000214 1560.000000 0.001593 -0.002844 0.000431 -5939 1 0.000196 1560.000000 0.002079 0.001638 0.006936 -5940 1 0.000268 1560.000000 0.003382 0.000255 0.005251 -5941 1 0.000202 1560.000000 -0.001515 -0.001510 0.004392 -5942 1 0.000240 1560.000000 0.000237 -0.003624 0.000718 -5943 1 0.000211 1560.000000 -0.002346 0.001911 0.002194 -5944 1 0.000247 1560.000000 -0.001497 -0.003121 0.006313 -5945 1 0.000250 1560.000000 -0.000793 0.001111 0.009711 -5946 1 0.000234 1560.000000 0.001318 0.002984 0.002674 -5947 1 0.000255 1560.000000 -0.000940 0.001863 0.009596 -5948 1 0.000270 1560.000000 -0.001420 0.002087 0.008003 -5949 1 0.000225 1560.000000 -0.002994 -0.001956 0.003022 -5950 1 0.000233 1560.000000 0.001023 -0.001233 0.005699 -5951 1 0.000207 1560.000000 -0.001984 -0.000341 0.001266 -5952 1 0.000194 1560.000000 0.002584 -0.001057 0.005790 -5953 1 0.000280 1560.000000 0.000008 0.001003 0.007691 -5954 1 0.000220 1560.000000 -0.000279 -0.001361 0.000539 -5955 1 0.000200 1560.000000 0.002653 -0.000492 0.000612 -5956 1 0.000220 1560.000000 -0.000606 0.000546 0.002407 -5957 1 0.000253 1560.000000 0.002350 -0.002417 0.007122 -5958 1 0.000237 1560.000000 -0.003786 0.000300 0.003569 -5959 1 0.000218 1560.000000 0.001829 0.002379 0.000647 -5960 1 0.000231 1560.000000 0.002569 0.002762 0.001990 -5961 1 0.000243 1560.000000 0.001944 0.000237 0.008842 -5962 1 0.000198 1560.000000 0.003198 0.001471 0.008692 -5963 1 0.000240 1560.000000 0.001942 0.000457 0.002767 -5964 1 0.000195 1560.000000 0.002732 -0.001886 0.001339 -5965 1 0.000227 1560.000000 -0.002078 0.003096 0.006960 -5966 1 0.000285 1560.000000 -0.002362 -0.000354 0.007370 -5967 1 0.000222 1560.000000 -0.000338 -0.000357 0.005102 -5968 1 0.000211 1560.000000 -0.001430 -0.001864 0.008852 -5969 1 0.000211 1560.000000 0.001385 -0.003434 0.003474 -5970 1 0.000231 1560.000000 0.001020 0.002120 0.001768 -5971 1 0.000249 1560.000000 0.001518 0.001999 0.000706 -5972 1 0.000274 1560.000000 0.001721 -0.000883 0.006508 -5973 1 0.000233 1560.000000 -0.001703 0.001054 0.007157 -5974 1 0.000246 1560.000000 -0.003332 -0.000260 0.009360 -5975 1 0.000193 1560.000000 -0.003444 0.000459 0.005232 -5976 1 0.000258 1560.000000 0.000170 0.002917 0.008573 -5977 1 0.000208 1560.000000 0.000334 -0.003470 0.002132 -5978 1 0.000268 1560.000000 0.002289 0.000216 0.005438 -5979 1 0.000215 1560.000000 -0.000167 0.002999 0.003099 -5980 1 0.000202 1560.000000 0.000756 0.000861 0.004756 -5981 1 0.000256 1560.000000 0.001109 -0.001419 0.002379 -5982 1 0.000213 1560.000000 -0.000896 0.002101 0.005573 -5983 1 0.000215 1560.000000 -0.000567 -0.002754 0.009664 -5984 1 0.000197 1560.000000 -0.000578 0.000811 0.000582 -5985 1 0.000288 1560.000000 0.003116 0.001642 0.006759 -5986 1 0.000214 1560.000000 -0.000656 -0.002816 0.003897 -5987 1 0.000192 1560.000000 -0.002774 -0.000486 0.005732 -5988 1 0.000205 1560.000000 -0.001171 -0.000756 0.002522 -5989 1 0.000244 1560.000000 0.002812 0.002245 0.008083 -5990 1 0.000210 1560.000000 -0.001918 -0.000312 0.005746 -5991 1 0.000217 1560.000000 -0.001494 -0.002630 0.001502 -5992 1 0.000220 1560.000000 -0.002919 0.001020 0.006650 -5993 1 0.000284 1560.000000 0.001797 0.003031 0.006000 -5994 1 0.000219 1560.000000 0.002505 0.002203 0.007961 -5995 1 0.000202 1560.000000 -0.000759 0.000806 0.005647 -5996 1 0.000276 1560.000000 -0.003064 -0.000041 0.000279 -5997 1 0.000216 1560.000000 -0.000955 0.000886 0.003881 -5998 1 0.000248 1560.000000 -0.000786 0.001379 0.008621 -5999 1 0.000208 1560.000000 -0.000593 -0.003782 0.005892 -6000 1 0.000205 1560.000000 -0.001979 0.002100 0.001879 -6001 1 0.000195 1560.000000 -0.001177 -0.003526 0.008415 -6002 1 0.000194 1560.000000 -0.000115 0.002210 0.008303 -6003 1 0.000233 1560.000000 0.001847 -0.001442 0.004050 -6004 1 0.000205 1560.000000 0.003019 -0.001810 0.006099 -6005 1 0.000229 1560.000000 -0.003573 0.001193 0.005692 -6006 1 0.000281 1560.000000 0.000297 0.002060 0.008266 -6007 1 0.000232 1560.000000 0.000721 -0.003566 0.009143 -6008 1 0.000219 1560.000000 -0.003316 -0.000147 0.005063 -6009 1 0.000208 1560.000000 0.000611 -0.003267 0.003187 -6010 1 0.000250 1560.000000 -0.002517 -0.000307 0.008463 -6011 1 0.000261 1560.000000 -0.003244 -0.000287 0.008800 -6012 1 0.000211 1560.000000 -0.001370 -0.001010 0.009717 -6013 1 0.000232 1560.000000 0.000847 -0.003568 0.005679 -6014 1 0.000232 1560.000000 -0.000397 0.002110 0.004327 -6015 1 0.000200 1560.000000 -0.001945 -0.001901 0.000995 -6016 1 0.000194 1560.000000 0.001072 0.000365 0.000364 -6017 1 0.000265 1560.000000 0.000361 -0.002884 0.000181 -6018 1 0.000276 1560.000000 0.002612 -0.002496 0.003497 -6019 1 0.000212 1560.000000 -0.002281 0.003043 0.002272 -6020 1 0.000250 1560.000000 0.000655 0.000576 0.004473 -6021 1 0.000272 1560.000000 -0.001791 0.002179 0.008327 -6022 1 0.000286 1560.000000 0.000779 0.003729 0.008897 -6023 1 0.000209 1560.000000 -0.000115 -0.001856 0.003384 -6024 1 0.000242 1560.000000 -0.000120 0.001495 0.001027 -6025 1 0.000219 1560.000000 0.002433 -0.001769 0.002564 -6026 1 0.000257 1560.000000 -0.000248 0.002008 0.005461 -6027 1 0.000230 1560.000000 0.002316 -0.002259 0.008196 -6028 1 0.000199 1560.000000 -0.000846 0.003179 0.007275 -6029 1 0.000204 1560.000000 -0.003229 -0.000757 0.000647 -6030 1 0.000198 1560.000000 0.002277 -0.000646 0.006219 -6031 1 0.000211 1560.000000 -0.001651 0.000493 0.002882 -6032 1 0.000224 1560.000000 -0.001126 0.001122 0.006625 -6033 1 0.000267 1560.000000 0.000568 0.002535 0.003572 -6034 1 0.000239 1560.000000 -0.002146 -0.001661 0.009546 -6035 1 0.000223 1560.000000 0.001237 0.002024 0.001151 -6036 1 0.000218 1560.000000 0.000294 0.002876 0.000538 -6037 1 0.000241 1560.000000 -0.002098 -0.002237 0.007047 -6038 1 0.000205 1560.000000 -0.000423 -0.003112 0.007410 -6039 1 0.000212 1560.000000 0.001830 -0.000697 0.002976 -6040 1 0.000275 1560.000000 -0.000211 -0.003125 0.007022 -6041 1 0.000226 1560.000000 -0.003404 0.000536 0.008124 -6042 1 0.000287 1560.000000 0.002278 -0.003050 0.006845 -6043 1 0.000218 1560.000000 0.003251 -0.001776 0.002689 -6044 1 0.000268 1560.000000 0.003774 0.000419 0.004764 -6045 1 0.000221 1560.000000 0.002260 0.001705 0.006742 -6046 1 0.000200 1560.000000 -0.001022 -0.001682 0.001251 -6047 1 0.000222 1560.000000 0.000584 -0.003128 0.009241 -6048 1 0.000228 1560.000000 -0.000883 -0.000772 0.003650 -6049 1 0.000197 1560.000000 0.003039 -0.001234 0.001664 -6050 1 0.000205 1560.000000 0.001007 0.000349 0.005328 -6051 1 0.000251 1560.000000 -0.001800 0.002203 0.004490 -6052 1 0.000245 1560.000000 0.002109 0.000223 0.003897 -6053 1 0.000236 1560.000000 0.000880 0.003021 0.000421 -6054 1 0.000247 1560.000000 0.001723 0.003249 0.005139 -6055 1 0.000227 1560.000000 -0.002021 0.000496 0.000373 -6056 1 0.000197 1560.000000 0.001629 -0.000334 0.007224 -6057 1 0.000194 1560.000000 0.003570 -0.001362 0.000152 -6058 1 0.000217 1560.000000 0.000851 0.003038 0.009689 -6059 1 0.000208 1560.000000 0.003089 0.002096 0.004367 -6060 1 0.000213 1560.000000 -0.000719 0.000308 0.005984 -6061 1 0.000213 1560.000000 0.002006 -0.002193 0.006994 -6062 1 0.000267 1560.000000 -0.000479 0.000347 0.001025 -6063 1 0.000223 1560.000000 -0.000165 -0.001159 0.006802 -6064 1 0.000195 1560.000000 -0.001770 -0.000100 0.008363 -6065 1 0.000221 1560.000000 -0.002222 -0.000485 0.006220 -6066 1 0.000236 1560.000000 0.000600 -0.002864 0.000349 -6067 1 0.000241 1560.000000 0.001616 0.002377 0.000734 -6068 1 0.000235 1560.000000 -0.001850 -0.002751 0.005764 -6069 1 0.000222 1560.000000 -0.002996 0.000480 0.007175 -6070 1 0.000214 1560.000000 0.001062 -0.001619 0.009337 -6071 1 0.000247 1560.000000 0.001127 0.000242 0.007373 -6072 1 0.000220 1560.000000 0.002200 -0.000456 0.007741 -6073 1 0.000239 1560.000000 -0.001012 0.002921 0.007205 -6074 1 0.000274 1560.000000 -0.003209 0.001439 0.002929 -6075 1 0.000229 1560.000000 -0.001581 -0.000745 0.006345 -6076 1 0.000213 1560.000000 0.001089 0.001501 0.003088 -6077 1 0.000249 1560.000000 0.002508 0.002882 0.006119 -6078 1 0.000279 1560.000000 0.001960 0.000023 0.009087 -6079 1 0.000229 1560.000000 -0.002393 0.002810 0.003045 -6080 1 0.000229 1560.000000 -0.002474 0.000512 0.006471 -6081 1 0.000203 1560.000000 0.002350 -0.000432 0.004410 -6082 1 0.000197 1560.000000 -0.000687 -0.003070 0.005101 -6083 1 0.000208 1560.000000 0.000356 0.000742 0.007889 -6084 1 0.000197 1560.000000 0.001805 0.002242 0.008059 -6085 1 0.000218 1560.000000 -0.001024 0.000457 0.003478 -6086 1 0.000242 1560.000000 -0.002742 -0.000716 0.008516 -6087 1 0.000229 1560.000000 0.001974 -0.002936 0.002227 -6088 1 0.000218 1560.000000 -0.002471 0.000648 0.005915 -6089 1 0.000217 1560.000000 -0.001375 -0.000486 0.005252 -6090 1 0.000195 1560.000000 0.002038 -0.000063 0.005840 -6091 1 0.000213 1560.000000 -0.002800 -0.000997 0.000367 -6092 1 0.000207 1560.000000 0.000221 -0.002540 0.008271 -6093 1 0.000230 1560.000000 0.002845 -0.000258 0.006844 -6094 1 0.000236 1560.000000 -0.003430 0.001036 0.002540 -6095 1 0.000210 1560.000000 0.002931 -0.001527 0.007601 -6096 1 0.000242 1560.000000 -0.003021 -0.000553 0.008701 -6097 1 0.000253 1560.000000 -0.002437 0.002016 0.006236 -6098 1 0.000275 1560.000000 -0.001431 0.002739 0.003267 -6099 1 0.000233 1560.000000 -0.002660 0.002010 0.002262 -6100 1 0.000207 1560.000000 -0.001774 -0.002138 0.002220 -6101 1 0.000245 1560.000000 0.003412 0.001516 0.002575 -6102 1 0.000258 1560.000000 -0.003367 0.001403 0.001788 -6103 1 0.000260 1560.000000 -0.001297 0.000637 0.008153 -6104 1 0.000248 1560.000000 0.000241 0.001008 0.002440 -6105 1 0.000200 1560.000000 0.000075 -0.000541 0.000472 -6106 1 0.000194 1560.000000 -0.001650 -0.002924 0.002604 -6107 1 0.000218 1560.000000 0.000709 0.000945 0.002286 -6108 1 0.000200 1560.000000 -0.002043 -0.001907 0.008720 -6109 1 0.000193 1560.000000 -0.001424 -0.001032 0.004051 -6110 1 0.000217 1560.000000 -0.001346 -0.002179 0.001951 -6111 1 0.000263 1560.000000 0.001815 0.003219 0.001626 -6112 1 0.000241 1560.000000 -0.001396 0.001863 0.002871 -6113 1 0.000246 1560.000000 -0.002963 0.000348 0.003810 -6114 1 0.000201 1560.000000 0.001049 0.002323 0.008945 -6115 1 0.000231 1560.000000 -0.001593 0.001130 0.001569 -6116 1 0.000251 1560.000000 -0.000943 0.002219 0.006899 -6117 1 0.000197 1560.000000 0.002894 -0.000390 0.005322 -6118 1 0.000212 1560.000000 -0.001090 0.002794 0.006683 -6119 1 0.000227 1560.000000 -0.001185 -0.002619 0.006090 -6120 1 0.000207 1560.000000 -0.002764 -0.001123 0.007122 -6121 1 0.000257 1560.000000 0.001890 -0.000819 0.009594 -6122 1 0.000233 1560.000000 0.001439 -0.001325 0.004256 -6123 1 0.000241 1560.000000 -0.002980 0.001149 0.004342 -6124 1 0.000236 1560.000000 -0.002113 0.000551 0.009710 -6125 1 0.000270 1560.000000 0.000126 0.001411 0.009399 -6126 1 0.000252 1560.000000 0.000790 0.000173 0.002286 -6127 1 0.000216 1560.000000 0.002599 0.000486 0.009061 -6128 1 0.000232 1560.000000 0.000117 -0.001638 0.005916 -6129 1 0.000241 1560.000000 0.003451 -0.000952 0.004593 -6130 1 0.000231 1560.000000 0.001772 0.001244 0.000909 -6131 1 0.000199 1560.000000 0.001565 -0.003166 0.006590 -6132 1 0.000231 1560.000000 -0.000991 0.003082 0.007682 -6133 1 0.000213 1560.000000 -0.001153 -0.000813 0.005161 -6134 1 0.000233 1560.000000 -0.003144 0.001853 0.002797 -6135 1 0.000213 1560.000000 0.000986 0.002925 0.008736 -6136 1 0.000196 1560.000000 -0.002684 -0.001681 0.009160 -6137 1 0.000285 1560.000000 0.001289 0.001688 0.006454 -6138 1 0.000257 1560.000000 0.000473 0.001025 0.001527 -6139 1 0.000234 1560.000000 0.001551 -0.000339 0.000524 -6140 1 0.000199 1560.000000 0.001105 -0.002007 0.005670 -6141 1 0.000228 1560.000000 -0.001411 -0.003092 0.009621 -6142 1 0.000236 1560.000000 0.001353 0.000250 0.001005 -6143 1 0.000264 1560.000000 -0.002118 -0.000998 0.003154 -6144 1 0.000248 1560.000000 -0.001140 -0.002217 0.009290 -6145 1 0.000234 1560.000000 0.000442 0.002608 0.002507 -6146 1 0.000208 1560.000000 -0.001976 -0.002665 0.009578 -6147 1 0.000228 1560.000000 -0.003469 -0.000621 0.002383 -6148 1 0.000197 1560.000000 0.001213 -0.002935 0.000942 -6149 1 0.000206 1560.000000 -0.001242 -0.001099 0.002424 -6150 1 0.000249 1560.000000 0.000538 0.003143 0.001651 -6151 1 0.000212 1560.000000 0.000948 -0.000480 0.006269 -6152 1 0.000243 1560.000000 0.002865 0.002122 0.007839 -6153 1 0.000264 1560.000000 0.002928 -0.000173 0.005734 -6154 1 0.000229 1560.000000 0.002611 -0.000201 0.008907 -6155 1 0.000210 1560.000000 0.002033 -0.001582 0.001949 -6156 1 0.000209 1560.000000 0.003438 -0.001098 0.008596 -6157 1 0.000219 1560.000000 0.002177 0.000017 0.008949 -6158 1 0.000201 1560.000000 -0.000062 0.003229 0.000366 -6159 1 0.000225 1560.000000 0.000450 -0.000002 0.005227 -6160 1 0.000229 1560.000000 -0.002416 0.000235 0.002003 -6161 1 0.000196 1560.000000 0.003147 -0.001213 0.001413 -6162 1 0.000244 1560.000000 -0.000328 -0.000657 0.006332 -6163 1 0.000263 1560.000000 -0.000246 -0.000672 0.001701 -6164 1 0.000261 1560.000000 -0.002368 0.000946 0.007822 -6165 1 0.000264 1560.000000 -0.001701 -0.003265 0.004338 -6166 1 0.000215 1560.000000 0.000603 0.000065 0.009756 -6167 1 0.000192 1560.000000 0.002792 -0.001835 0.008886 -6168 1 0.000220 1560.000000 0.001629 -0.001118 0.006261 -6169 1 0.000230 1560.000000 0.003726 0.000763 0.009398 -6170 1 0.000209 1560.000000 -0.000218 0.002397 0.000924 -6171 1 0.000242 1560.000000 0.002986 0.000663 0.008918 -6172 1 0.000288 1560.000000 -0.001783 0.002056 0.000283 -6173 1 0.000220 1560.000000 0.002238 -0.002840 0.004883 -6174 1 0.000221 1560.000000 -0.001015 -0.003653 0.007569 -6175 1 0.000219 1560.000000 0.001606 -0.001610 0.002705 -6176 1 0.000246 1560.000000 -0.000803 -0.003058 0.000129 -6177 1 0.000205 1560.000000 0.001775 -0.002590 0.006996 -6178 1 0.000211 1560.000000 -0.000264 0.000158 0.000621 -6179 1 0.000195 1560.000000 -0.001263 -0.000531 0.005824 -6180 1 0.000208 1560.000000 0.000169 0.000675 0.003920 -6181 1 0.000279 1560.000000 0.001184 0.001357 0.005391 -6182 1 0.000265 1560.000000 0.001017 -0.001460 0.009794 -6183 1 0.000267 1560.000000 0.002356 -0.000458 0.006094 -6184 1 0.000215 1560.000000 -0.000954 0.000046 0.009736 -6185 1 0.000200 1560.000000 0.002600 -0.001452 0.000730 -6186 1 0.000199 1560.000000 -0.001981 0.002466 0.009301 -6187 1 0.000277 1560.000000 -0.001167 0.003607 0.002963 -6188 1 0.000198 1560.000000 -0.000667 -0.001964 0.000728 -6189 1 0.000232 1560.000000 0.001399 -0.000600 0.009021 -6190 1 0.000257 1560.000000 -0.003045 0.000178 0.007361 -6191 1 0.000260 1560.000000 -0.003627 0.000039 0.005909 -6192 1 0.000200 1560.000000 0.000608 0.002545 0.005018 -6193 1 0.000219 1560.000000 -0.001833 -0.002477 0.006077 -6194 1 0.000224 1560.000000 -0.002872 0.000222 0.001974 -6195 1 0.000242 1560.000000 -0.001026 -0.000448 0.009185 -6196 1 0.000225 1560.000000 0.002497 0.001987 0.008672 -6197 1 0.000230 1560.000000 -0.000585 0.000784 0.000259 -6198 1 0.000216 1560.000000 0.000227 0.000668 0.005550 -6199 1 0.000225 1560.000000 -0.001509 -0.001241 0.008684 -6200 1 0.000229 1560.000000 0.001625 -0.003118 0.009625 -6201 1 0.000196 1560.000000 0.002527 0.000047 0.001855 -6202 1 0.000237 1560.000000 -0.002975 -0.001620 0.006046 -6203 1 0.000239 1560.000000 0.000767 0.001477 0.009650 -6204 1 0.000207 1560.000000 -0.001785 -0.001583 0.007927 -6205 1 0.000277 1560.000000 0.002300 -0.001520 0.005956 -6206 1 0.000213 1560.000000 -0.003169 0.000018 0.003871 -6207 1 0.000227 1560.000000 0.000258 -0.000762 0.004744 -6208 1 0.000203 1560.000000 -0.000636 -0.002145 0.008334 -6209 1 0.000219 1560.000000 -0.003581 0.001198 0.002974 -6210 1 0.000201 1560.000000 -0.002401 -0.000762 0.002471 -6211 1 0.000266 1560.000000 -0.000293 -0.001291 0.007462 -6212 1 0.000208 1560.000000 -0.003791 -0.000189 0.007845 -6213 1 0.000217 1560.000000 -0.000311 -0.003291 0.001657 -6214 1 0.000205 1560.000000 -0.002608 0.000661 0.008393 -6215 1 0.000222 1560.000000 0.001065 0.002916 0.007960 -6216 1 0.000230 1560.000000 -0.003331 0.001148 0.005001 -6217 1 0.000219 1560.000000 -0.003059 0.000356 0.003448 -6218 1 0.000238 1560.000000 0.000735 -0.001079 0.007637 -6219 1 0.000219 1560.000000 -0.001580 -0.002263 0.006691 -6220 1 0.000201 1560.000000 0.000108 -0.002518 0.008840 -6221 1 0.000211 1560.000000 0.000006 -0.000475 0.007038 -6222 1 0.000213 1560.000000 0.003103 0.001150 0.003376 -6223 1 0.000227 1560.000000 -0.000143 -0.002004 0.002970 -6224 1 0.000202 1560.000000 -0.003328 -0.000085 0.008429 -6225 1 0.000230 1560.000000 0.001922 -0.000748 0.009053 -6226 1 0.000219 1560.000000 -0.001306 -0.003350 0.000456 -6227 1 0.000219 1560.000000 -0.000635 -0.000738 0.009365 -6228 1 0.000265 1560.000000 -0.002260 -0.001061 0.002926 -6229 1 0.000263 1560.000000 -0.002600 -0.000627 0.001241 -6230 1 0.000200 1560.000000 -0.001307 -0.000185 0.008006 -6231 1 0.000266 1560.000000 0.000036 -0.003207 0.009806 -6232 1 0.000219 1560.000000 -0.002130 -0.002527 0.005643 -6233 1 0.000215 1560.000000 0.000023 0.000324 0.005463 -6234 1 0.000206 1560.000000 0.002684 -0.001022 0.004778 -6235 1 0.000245 1560.000000 0.001748 -0.003360 0.006771 -6236 1 0.000209 1560.000000 0.001873 -0.001113 0.005957 -6237 1 0.000272 1560.000000 0.000822 -0.003349 0.003316 -6238 1 0.000202 1560.000000 -0.002685 -0.002097 0.003103 -6239 1 0.000195 1560.000000 -0.000030 -0.001716 0.003818 -6240 1 0.000193 1560.000000 -0.003431 0.000067 0.001089 -6241 1 0.000233 1560.000000 0.000792 0.001780 0.009779 -6242 1 0.000238 1560.000000 0.001965 0.000769 0.006151 -6243 1 0.000243 1560.000000 -0.000146 0.003056 0.004242 -6244 1 0.000193 1560.000000 0.003051 0.001611 0.000125 -6245 1 0.000270 1560.000000 0.001470 -0.001077 0.000202 -6246 1 0.000237 1560.000000 -0.000500 0.003755 0.007999 -6247 1 0.000250 1560.000000 -0.002865 0.001542 0.007129 -6248 1 0.000251 1560.000000 -0.000573 0.001969 0.004897 -6249 1 0.000261 1560.000000 -0.003560 0.001428 0.000590 -6250 1 0.000200 1560.000000 -0.001211 -0.003168 0.007564 -6251 1 0.000254 1560.000000 -0.002766 -0.000203 0.007634 -6252 1 0.000203 1560.000000 0.002563 0.001965 0.003145 -6253 1 0.000196 1560.000000 -0.001116 0.001627 0.005512 -6254 1 0.000244 1560.000000 -0.000849 0.001250 0.004004 -6255 1 0.000226 1560.000000 -0.002273 -0.002238 0.002299 -6256 1 0.000276 1560.000000 -0.001947 0.003207 0.006681 -6257 1 0.000242 1560.000000 -0.002427 0.000826 0.000505 -6258 1 0.000252 1560.000000 -0.003544 -0.001428 0.008379 -6259 1 0.000225 1560.000000 0.002926 0.000354 0.001773 -6260 1 0.000230 1560.000000 -0.001275 -0.001445 0.004795 -6261 1 0.000239 1560.000000 0.001551 0.001910 0.006859 -6262 1 0.000244 1560.000000 0.002913 -0.000679 0.001442 -6263 1 0.000256 1560.000000 -0.000442 -0.002077 0.006884 -6264 1 0.000199 1560.000000 0.001081 -0.002011 0.000172 -6265 1 0.000208 1560.000000 -0.003111 -0.001736 0.009248 -6266 1 0.000198 1560.000000 0.000839 0.002773 0.002114 -6267 1 0.000268 1560.000000 0.002151 0.001340 0.000542 -6268 1 0.000196 1560.000000 -0.001167 -0.000581 0.004859 -6269 1 0.000229 1560.000000 -0.001388 0.002238 0.003820 -6270 1 0.000224 1560.000000 0.000724 -0.001463 0.004573 -6271 1 0.000268 1560.000000 -0.000130 -0.003045 0.005115 -6272 1 0.000204 1560.000000 -0.001437 -0.000791 0.008746 -6273 1 0.000200 1560.000000 0.003647 -0.000963 0.004172 -6274 1 0.000276 1560.000000 0.002613 -0.002705 0.007283 -6275 1 0.000280 1560.000000 -0.002363 0.001592 0.006259 -6276 1 0.000242 1560.000000 -0.000810 0.001950 0.001684 -6277 1 0.000217 1560.000000 0.003520 0.000354 0.003272 -6278 1 0.000238 1560.000000 -0.002494 -0.000614 0.007321 -6279 1 0.000263 1560.000000 0.003473 -0.001130 0.009471 -6280 1 0.000196 1560.000000 -0.000295 0.001557 0.007469 -6281 1 0.000232 1560.000000 0.000493 -0.003396 0.001992 -6282 1 0.000221 1560.000000 0.001423 0.001880 0.006116 -6283 1 0.000208 1560.000000 0.002826 -0.002465 0.009416 -6284 1 0.000230 1560.000000 -0.002541 0.000214 0.007735 -6285 1 0.000214 1560.000000 -0.001499 -0.003473 0.000518 -6286 1 0.000259 1560.000000 -0.000829 -0.001734 0.008982 -6287 1 0.000214 1560.000000 0.000619 -0.001848 0.009124 -6288 1 0.000284 1560.000000 -0.002963 -0.002101 0.005981 -6289 1 0.000204 1560.000000 -0.001164 0.000418 0.009505 -6290 1 0.000264 1560.000000 0.000598 -0.001879 0.005022 -6291 1 0.000209 1560.000000 0.003004 0.000120 0.000473 -6292 1 0.000199 1560.000000 0.001316 0.001141 0.006103 -6293 1 0.000254 1560.000000 -0.003523 0.000006 0.000132 -6294 1 0.000197 1560.000000 0.003694 -0.001071 0.007563 -6295 1 0.000274 1560.000000 -0.000492 0.001529 0.004011 -6296 1 0.000238 1560.000000 0.000501 -0.001056 0.001510 -6297 1 0.000212 1560.000000 -0.001040 -0.002203 0.006870 -6298 1 0.000216 1560.000000 -0.001582 0.001229 0.000631 -6299 1 0.000243 1560.000000 0.001150 -0.001732 0.003155 -6300 1 0.000206 1560.000000 -0.002641 -0.000734 0.005083 -6301 1 0.000224 1560.000000 -0.000045 -0.000552 0.005274 -6302 1 0.000220 1560.000000 -0.003355 -0.000876 0.007363 -6303 1 0.000203 1560.000000 -0.000026 0.001184 0.001857 -6304 1 0.000254 1560.000000 -0.002093 0.000806 0.008673 -6305 1 0.000276 1560.000000 0.000874 0.000729 0.009691 -6306 1 0.000288 1560.000000 0.003278 0.001530 0.006090 -6307 1 0.000254 1560.000000 0.001158 0.001835 0.008513 -6308 1 0.000207 1560.000000 -0.001968 -0.003264 0.002177 -6309 1 0.000207 1560.000000 -0.000173 -0.000384 0.006969 -6310 1 0.000209 1560.000000 -0.000289 0.002989 0.002874 -6311 1 0.000218 1560.000000 0.001209 0.000057 0.007602 -6312 1 0.000202 1560.000000 0.000140 0.001279 0.006237 -6313 1 0.000245 1560.000000 0.001658 -0.002059 0.000176 -6314 1 0.000196 1560.000000 -0.001526 -0.000778 0.000793 -6315 1 0.000227 1560.000000 -0.003341 -0.001728 0.001416 -6316 1 0.000241 1560.000000 0.003434 -0.001730 0.002221 -6317 1 0.000275 1560.000000 -0.001936 -0.001760 0.004994 -6318 1 0.000278 1560.000000 -0.000831 0.001413 0.005601 -6319 1 0.000222 1560.000000 -0.001192 -0.000029 0.008558 -6320 1 0.000194 1560.000000 0.002020 0.002526 0.005592 -6321 1 0.000234 1560.000000 -0.000880 0.002758 0.009512 -6322 1 0.000193 1560.000000 -0.001904 -0.000184 0.001854 -6323 1 0.000210 1560.000000 0.002271 0.001100 0.000802 -6324 1 0.000219 1560.000000 0.000802 0.002035 0.007274 -6325 1 0.000283 1560.000000 -0.003089 0.001408 0.003484 -6326 1 0.000201 1560.000000 0.002543 0.000372 0.000344 -6327 1 0.000266 1560.000000 0.000106 -0.002427 0.002462 -6328 1 0.000192 1560.000000 -0.002756 0.000506 0.007332 -6329 1 0.000207 1560.000000 0.001623 0.001068 0.007745 -6330 1 0.000246 1560.000000 0.001916 -0.001092 0.009166 -6331 1 0.000208 1560.000000 -0.000918 -0.002806 0.009047 -6332 1 0.000234 1560.000000 0.003070 0.001884 0.007071 -6333 1 0.000256 1560.000000 -0.002762 0.001352 0.009771 -6334 1 0.000238 1560.000000 -0.000977 0.003452 0.006603 -6335 1 0.000196 1560.000000 -0.001721 -0.001416 0.009126 -6336 1 0.000285 1560.000000 -0.002790 0.001843 0.008827 -6337 1 0.000277 1560.000000 -0.002913 -0.000565 0.002784 -6338 1 0.000220 1560.000000 -0.002142 -0.001481 0.003558 -6339 1 0.000262 1560.000000 -0.001487 -0.003347 0.007419 -6340 1 0.000204 1560.000000 0.001144 -0.003636 0.006547 -6341 1 0.000210 1560.000000 -0.000707 0.001401 0.004502 -6342 1 0.000230 1560.000000 -0.001542 -0.002480 0.002009 -6343 1 0.000243 1560.000000 0.002715 0.000604 0.002188 -6344 1 0.000265 1560.000000 0.003195 -0.000957 0.000460 -6345 1 0.000263 1560.000000 0.000966 0.000505 0.000141 -6346 1 0.000209 1560.000000 0.001535 0.001274 0.008920 -6347 1 0.000279 1560.000000 0.003111 -0.001171 0.007293 -6348 1 0.000204 1560.000000 -0.002460 0.002724 0.001985 -6349 1 0.000247 1560.000000 0.000198 -0.002229 0.007824 -6350 1 0.000245 1560.000000 0.000328 -0.000349 0.007104 -6351 1 0.000203 1560.000000 0.000755 -0.000561 0.005558 -6352 1 0.000246 1560.000000 -0.003425 0.000422 0.001508 -6353 1 0.000241 1560.000000 0.000578 0.001001 0.002730 -6354 1 0.000248 1560.000000 -0.000503 0.001248 0.008737 -6355 1 0.000226 1560.000000 0.001678 -0.001442 0.001273 -6356 1 0.000244 1560.000000 -0.002736 0.001330 0.004071 -6357 1 0.000223 1560.000000 0.002438 0.001511 0.000870 -6358 1 0.000233 1560.000000 0.001622 -0.001751 0.009385 -6359 1 0.000263 1560.000000 -0.002910 -0.001705 0.007000 -6360 1 0.000195 1560.000000 0.002193 -0.002763 0.005250 -6361 1 0.000217 1560.000000 -0.001307 0.001299 0.001098 -6362 1 0.000246 1560.000000 -0.000667 0.002599 0.000612 -6363 1 0.000287 1560.000000 -0.002309 0.001822 0.002771 -6364 1 0.000215 1560.000000 0.000998 -0.002951 0.007794 -6365 1 0.000254 1560.000000 -0.002643 0.001894 0.005981 -6366 1 0.000194 1560.000000 -0.001722 -0.000753 0.009627 -6367 1 0.000193 1560.000000 0.000335 -0.001052 0.004813 -6368 1 0.000241 1560.000000 -0.001860 -0.001880 0.004498 -6369 1 0.000244 1560.000000 -0.003264 -0.000850 0.002288 -6370 1 0.000199 1560.000000 0.001899 -0.002391 0.007934 -6371 1 0.000212 1560.000000 -0.000544 -0.001229 0.000191 -6372 1 0.000273 1560.000000 0.001591 -0.002073 0.008645 -6373 1 0.000223 1560.000000 0.000389 0.001928 0.004711 -6374 1 0.000214 1560.000000 0.002211 0.000337 0.002158 -6375 1 0.000283 1560.000000 -0.000993 -0.000168 0.009570 -6376 1 0.000223 1560.000000 0.002973 -0.000631 0.009218 -6377 1 0.000212 1560.000000 -0.002333 -0.000850 0.006779 -6378 1 0.000222 1560.000000 -0.002202 -0.002993 0.001833 -6379 1 0.000252 1560.000000 0.001165 -0.002491 0.004444 -6380 1 0.000264 1560.000000 0.000316 -0.001526 0.003862 -6381 1 0.000274 1560.000000 -0.000079 -0.002566 0.001951 -6382 1 0.000276 1560.000000 0.000289 -0.001853 0.008652 -6383 1 0.000260 1560.000000 0.001528 0.000453 0.002824 -6384 1 0.000215 1560.000000 0.001978 0.002229 0.005624 -6385 1 0.000283 1560.000000 0.000692 0.003757 0.001712 -6386 1 0.000239 1560.000000 -0.002391 -0.002254 0.006285 -6387 1 0.000226 1560.000000 -0.000497 -0.003195 0.003112 -6388 1 0.000228 1560.000000 0.002063 0.002285 0.000786 -6389 1 0.000206 1560.000000 -0.000327 0.002599 0.007643 -6390 1 0.000248 1560.000000 0.001962 0.000690 0.004739 -6391 1 0.000279 1560.000000 0.001875 -0.001245 0.002917 -6392 1 0.000266 1560.000000 0.001593 0.000480 0.009828 -6393 1 0.000228 1560.000000 -0.002855 0.000148 0.009070 -6394 1 0.000230 1560.000000 0.001230 0.003362 0.005767 -6395 1 0.000205 1560.000000 0.002958 0.001075 0.005443 -6396 1 0.000236 1560.000000 0.001444 -0.003456 0.005524 -6397 1 0.000206 1560.000000 -0.002309 0.002332 0.009532 -6398 1 0.000212 1560.000000 0.002869 -0.000655 0.003379 -6399 1 0.000246 1560.000000 0.002680 0.000166 0.001343 -6400 1 0.000282 1560.000000 -0.002646 -0.000094 0.004065 -6401 1 0.000252 1560.000000 0.001665 -0.001048 0.005705 -6402 1 0.000285 1560.000000 -0.003339 0.001206 0.006022 -6403 1 0.000214 1560.000000 -0.000230 -0.003450 0.001921 -6404 1 0.000224 1560.000000 0.000909 -0.003502 0.009276 -6405 1 0.000240 1560.000000 -0.001979 0.000366 0.005889 -6406 1 0.000197 1560.000000 -0.000327 -0.002740 0.000827 -6407 1 0.000217 1560.000000 -0.001595 -0.000487 0.006157 -6408 1 0.000224 1560.000000 -0.001541 -0.001491 0.000344 -6409 1 0.000287 1560.000000 0.003611 -0.000545 0.009756 -6410 1 0.000223 1560.000000 -0.000852 -0.000264 0.007341 -6411 1 0.000255 1560.000000 0.003225 -0.002074 0.002848 -6412 1 0.000276 1560.000000 -0.001678 0.001373 0.009556 -6413 1 0.000251 1560.000000 -0.001285 0.000860 0.002382 -6414 1 0.000218 1560.000000 -0.002541 0.000704 0.008977 -6415 1 0.000197 1560.000000 -0.002569 -0.001527 0.002556 -6416 1 0.000195 1560.000000 -0.002228 0.001925 0.004577 -6417 1 0.000212 1560.000000 0.002827 0.000531 0.008318 -6418 1 0.000230 1560.000000 -0.000699 -0.000314 0.006361 -6419 1 0.000231 1560.000000 -0.002565 0.000517 0.009590 -6420 1 0.000198 1560.000000 -0.000914 0.002692 0.009274 -6421 1 0.000238 1560.000000 -0.000245 -0.001479 0.008581 -6422 1 0.000242 1560.000000 -0.002364 0.000117 0.007348 -6423 1 0.000196 1560.000000 0.002467 -0.000257 0.004996 -6424 1 0.000219 1560.000000 -0.001564 -0.001645 0.003810 -6425 1 0.000212 1560.000000 0.001717 -0.000019 0.007936 -6426 1 0.000204 1560.000000 0.002596 0.002305 0.002624 -6427 1 0.000223 1560.000000 -0.001608 0.002742 0.003927 -6428 1 0.000240 1560.000000 -0.000862 -0.003034 0.009572 -6429 1 0.000225 1560.000000 -0.003662 0.000267 0.009233 -6430 1 0.000220 1560.000000 0.000551 0.002151 0.003772 -6431 1 0.000211 1560.000000 0.001767 -0.003302 0.005767 -6432 1 0.000194 1560.000000 0.002121 -0.001821 0.003427 -6433 1 0.000220 1560.000000 -0.000692 0.002791 0.003087 -6434 1 0.000209 1560.000000 -0.000640 -0.002999 0.008311 -6435 1 0.000242 1560.000000 -0.002500 0.000734 0.008059 -6436 1 0.000261 1560.000000 0.003489 -0.000155 0.003828 -6437 1 0.000223 1560.000000 -0.003273 0.000440 0.001870 -6438 1 0.000206 1560.000000 -0.000771 -0.000657 0.000420 -6439 1 0.000266 1560.000000 -0.001977 -0.001562 0.008394 -6440 1 0.000204 1560.000000 -0.001701 0.001833 0.007746 -6441 1 0.000277 1560.000000 -0.001273 0.002818 0.001897 -6442 1 0.000224 1560.000000 -0.001854 -0.002353 0.006932 -6443 1 0.000201 1560.000000 0.001335 -0.002648 0.004261 -6444 1 0.000238 1560.000000 -0.002027 0.001359 0.009813 -6445 1 0.000202 1560.000000 0.003109 0.000256 0.005686 -6446 1 0.000249 1560.000000 0.001602 0.001446 0.004013 -6447 1 0.000202 1560.000000 0.003460 0.001127 0.001768 -6448 1 0.000204 1560.000000 -0.001842 0.000186 0.002179 -6449 1 0.000232 1560.000000 -0.001427 0.003473 0.000353 -6450 1 0.000203 1560.000000 0.000838 0.000412 0.001095 -6451 1 0.000217 1560.000000 0.001755 -0.001605 0.006536 -6452 1 0.000249 1560.000000 -0.002763 0.000957 0.008761 -6453 1 0.000243 1560.000000 -0.000866 -0.000441 0.006124 -6454 1 0.000211 1560.000000 0.000035 0.002097 0.009809 -6455 1 0.000229 1560.000000 0.001726 0.002739 0.006331 -6456 1 0.000242 1560.000000 0.001291 -0.001012 0.006614 -6457 1 0.000233 1560.000000 0.003559 0.001400 0.006033 -6458 1 0.000287 1560.000000 0.002969 0.000486 0.002403 -6459 1 0.000240 1560.000000 0.001013 0.001967 0.008103 -6460 1 0.000203 1560.000000 -0.002545 -0.000299 0.006743 -6461 1 0.000274 1560.000000 0.001296 -0.002571 0.009758 -6462 1 0.000205 1560.000000 0.003705 0.000770 0.004764 -6463 1 0.000247 1560.000000 -0.001940 -0.000203 0.005546 -6464 1 0.000212 1560.000000 -0.002687 -0.002425 0.004104 -6465 1 0.000214 1560.000000 0.002610 0.001207 0.004908 -6466 1 0.000211 1560.000000 0.001099 0.003284 0.007602 -6467 1 0.000260 1560.000000 -0.003440 -0.000494 0.001589 -6468 1 0.000204 1560.000000 -0.000954 0.001653 0.009312 -6469 1 0.000228 1560.000000 0.000026 0.000339 0.006517 -6470 1 0.000285 1560.000000 0.002650 -0.001095 0.001779 -6471 1 0.000200 1560.000000 0.002293 0.000978 0.007919 -6472 1 0.000237 1560.000000 -0.001518 -0.002805 0.006776 -6473 1 0.000206 1560.000000 0.002554 -0.000317 0.009535 -6474 1 0.000235 1560.000000 0.000274 0.001741 0.005309 -6475 1 0.000232 1560.000000 0.000908 0.003313 0.004678 -6476 1 0.000278 1560.000000 0.000708 0.002358 0.002688 -6477 1 0.000261 1560.000000 0.000383 0.002179 0.009578 -6478 1 0.000197 1560.000000 0.000745 0.002221 0.009268 -6479 1 0.000195 1560.000000 0.000880 0.001388 0.001943 -6480 1 0.000237 1560.000000 -0.002040 0.001792 0.004591 -6481 1 0.000248 1560.000000 -0.001391 0.001632 0.000166 -6482 1 0.000209 1560.000000 0.001942 -0.000280 0.001260 -6483 1 0.000254 1560.000000 0.002312 -0.000668 0.000614 -6484 1 0.000207 1560.000000 -0.002278 0.001175 0.005859 -6485 1 0.000228 1560.000000 0.000470 -0.001237 0.006502 -6486 1 0.000221 1560.000000 -0.001102 0.000656 0.002176 -6487 1 0.000273 1560.000000 -0.001393 -0.001520 0.007953 -6488 1 0.000276 1560.000000 0.002059 -0.001954 0.000150 -6489 1 0.000197 1560.000000 -0.002050 -0.000215 0.008874 -6490 1 0.000229 1560.000000 0.001063 0.001246 0.002156 -6491 1 0.000247 1560.000000 0.000779 -0.001553 0.000334 -6492 1 0.000242 1560.000000 0.002110 -0.001504 0.002488 -6493 1 0.000242 1560.000000 -0.002241 -0.001840 0.007737 -6494 1 0.000269 1560.000000 -0.001584 -0.001410 0.005469 -6495 1 0.000204 1560.000000 0.003584 -0.001130 0.007765 -6496 1 0.000206 1560.000000 -0.001915 0.000119 0.005433 -6497 1 0.000241 1560.000000 0.003196 0.001097 0.007410 -6498 1 0.000242 1560.000000 0.001254 0.000806 0.004728 -6499 1 0.000276 1560.000000 -0.002486 0.002572 0.005026 -6500 1 0.000208 1560.000000 0.002104 -0.001206 0.005700 -6501 1 0.000214 1560.000000 -0.002911 -0.002206 0.002070 -6502 1 0.000280 1560.000000 -0.003632 0.001070 0.006255 -6503 1 0.000266 1560.000000 0.002411 0.002547 0.000763 -6504 1 0.000207 1560.000000 0.003442 0.000124 0.003326 -6505 1 0.000246 1560.000000 -0.002823 -0.000680 0.000799 -6506 1 0.000278 1560.000000 0.003207 -0.001081 0.002148 -6507 1 0.000256 1560.000000 -0.002946 0.002475 0.005752 -6508 1 0.000255 1560.000000 -0.003330 -0.000472 0.000437 -6509 1 0.000286 1560.000000 -0.000044 0.001588 0.002565 -6510 1 0.000227 1560.000000 -0.000049 -0.002601 0.005478 -6511 1 0.000202 1560.000000 0.003361 0.001305 0.003746 -6512 1 0.000219 1560.000000 -0.001686 0.000327 0.006571 -6513 1 0.000199 1560.000000 0.000601 -0.001666 0.009324 -6514 1 0.000196 1560.000000 -0.000299 0.003480 0.004157 -6515 1 0.000241 1560.000000 0.001173 -0.000866 0.000282 -6516 1 0.000206 1560.000000 -0.000661 0.000490 0.003404 -6517 1 0.000214 1560.000000 -0.002189 -0.000505 0.003246 -6518 1 0.000225 1560.000000 -0.000806 0.000308 0.003000 -6519 1 0.000219 1560.000000 0.003756 -0.000425 0.003019 -6520 1 0.000275 1560.000000 -0.001821 -0.000864 0.000867 -6521 1 0.000250 1560.000000 -0.000632 -0.000671 0.001739 -6522 1 0.000254 1560.000000 0.001107 -0.001864 0.005057 -6523 1 0.000195 1560.000000 -0.000918 -0.000724 0.003015 -6524 1 0.000255 1560.000000 0.000935 0.001105 0.000324 -6525 1 0.000261 1560.000000 -0.002450 0.001569 0.000506 -6526 1 0.000230 1560.000000 0.002695 0.001167 0.009768 -6527 1 0.000229 1560.000000 0.000380 0.002435 0.007739 -6528 1 0.000219 1560.000000 0.002064 0.002563 0.004414 -6529 1 0.000217 1560.000000 0.001333 -0.000825 0.008771 -6530 1 0.000254 1560.000000 -0.002976 0.002306 0.000205 -6531 1 0.000194 1560.000000 -0.001898 -0.000953 0.009512 -6532 1 0.000238 1560.000000 0.000122 -0.000968 0.001058 -6533 1 0.000219 1560.000000 -0.003064 0.000697 0.002414 -6534 1 0.000276 1560.000000 0.003841 0.000286 0.000956 -6535 1 0.000218 1560.000000 -0.000498 -0.003703 0.004178 -6536 1 0.000248 1560.000000 -0.000483 -0.001630 0.000404 -6537 1 0.000273 1560.000000 0.000793 0.003618 0.009685 -6538 1 0.000287 1560.000000 -0.000755 0.001665 0.000655 -6539 1 0.000195 1560.000000 -0.003209 -0.001791 0.005956 -6540 1 0.000223 1560.000000 -0.002305 0.001256 0.000679 -6541 1 0.000220 1560.000000 0.000901 0.002963 0.007798 -6542 1 0.000273 1560.000000 0.000811 -0.002208 0.008916 -6543 1 0.000239 1560.000000 -0.000622 0.000625 0.004226 -6544 1 0.000194 1560.000000 -0.001993 0.002566 0.008532 -6545 1 0.000249 1560.000000 -0.001730 -0.000449 0.005617 -6546 1 0.000212 1560.000000 -0.002451 -0.001102 0.005435 -6547 1 0.000208 1560.000000 0.001148 0.001321 0.009611 -6548 1 0.000225 1560.000000 0.001321 -0.002244 0.004898 -6549 1 0.000248 1560.000000 -0.001422 0.002401 0.005468 -6550 1 0.000287 1560.000000 -0.001661 -0.003308 0.001045 -6551 1 0.000201 1560.000000 0.000994 0.002175 0.002929 -6552 1 0.000238 1560.000000 -0.002502 -0.000957 0.001443 -6553 1 0.000254 1560.000000 -0.000699 0.000071 0.006108 -6554 1 0.000232 1560.000000 -0.001506 -0.001880 0.006840 -6555 1 0.000255 1560.000000 -0.000694 -0.000451 0.003882 -6556 1 0.000231 1560.000000 -0.002681 -0.001239 0.008881 -6557 1 0.000223 1560.000000 0.001337 -0.003110 0.004283 -6558 1 0.000196 1560.000000 0.002752 -0.000862 0.000621 -6559 1 0.000224 1560.000000 -0.003743 0.000320 0.000417 -6560 1 0.000276 1560.000000 0.001844 -0.001540 0.002694 -6561 1 0.000278 1560.000000 -0.001798 -0.002188 0.004250 -6562 1 0.000231 1560.000000 -0.003731 -0.000458 0.009689 -6563 1 0.000207 1560.000000 0.002015 0.000463 0.004353 -6564 1 0.000270 1560.000000 0.000784 0.002693 0.006676 -6565 1 0.000282 1560.000000 0.001375 0.001292 0.009750 -6566 1 0.000260 1560.000000 -0.001130 -0.000189 0.000227 -6567 1 0.000238 1560.000000 -0.003156 0.001785 0.001045 -6568 1 0.000207 1560.000000 0.000456 -0.002976 0.004058 -6569 1 0.000209 1560.000000 0.001851 -0.001890 0.002283 -6570 1 0.000226 1560.000000 0.002885 -0.001729 0.004395 -6571 1 0.000228 1560.000000 -0.000856 0.002992 0.009482 -6572 1 0.000227 1560.000000 0.002363 0.001198 0.004828 -6573 1 0.000227 1560.000000 -0.001556 -0.002504 0.002799 -6574 1 0.000199 1560.000000 -0.002420 -0.000718 0.000514 -6575 1 0.000227 1560.000000 0.001291 0.003593 0.004556 -6576 1 0.000240 1560.000000 0.000990 0.001727 0.009349 -6577 1 0.000232 1560.000000 0.000352 0.003421 0.003452 -6578 1 0.000198 1560.000000 -0.003565 -0.000792 0.007796 -6579 1 0.000273 1560.000000 -0.002186 -0.001700 0.004343 -6580 1 0.000209 1560.000000 0.000990 -0.001315 0.004469 -6581 1 0.000259 1560.000000 0.001775 -0.000836 0.005434 -6582 1 0.000242 1560.000000 0.000673 0.001302 0.009464 -6583 1 0.000244 1560.000000 -0.000430 -0.002751 0.005446 -6584 1 0.000198 1560.000000 -0.002774 0.002085 0.004718 -6585 1 0.000212 1560.000000 -0.000871 -0.000332 0.003254 -6586 1 0.000240 1560.000000 0.003167 0.000350 0.009742 -6587 1 0.000260 1560.000000 0.001882 0.002733 0.006880 -6588 1 0.000264 1560.000000 -0.000890 -0.000882 0.009650 -6589 1 0.000280 1560.000000 0.002703 0.001006 0.005902 -6590 1 0.000228 1560.000000 0.001316 -0.001354 0.009811 -6591 1 0.000202 1560.000000 -0.001553 -0.000421 0.007224 -6592 1 0.000211 1560.000000 -0.000789 0.003700 0.008250 -6593 1 0.000220 1560.000000 -0.000622 0.002863 0.005753 -6594 1 0.000198 1560.000000 0.000055 -0.000673 0.001160 -6595 1 0.000197 1560.000000 -0.000912 -0.000746 0.001958 -6596 1 0.000206 1560.000000 -0.003166 0.000279 0.006506 -6597 1 0.000214 1560.000000 -0.001740 -0.002854 0.004241 -6598 1 0.000243 1560.000000 0.001019 -0.001110 0.007462 -6599 1 0.000208 1560.000000 0.003576 -0.000406 0.008346 -6600 1 0.000245 1560.000000 0.002071 -0.000869 0.002393 -6601 1 0.000214 1560.000000 -0.002812 0.001252 0.005525 -6602 1 0.000202 1560.000000 0.003055 -0.001807 0.005167 -6603 1 0.000227 1560.000000 0.000669 -0.001168 0.005371 -6604 1 0.000238 1560.000000 -0.002372 -0.000187 0.003722 -6605 1 0.000193 1560.000000 -0.000580 -0.001830 0.004518 -6606 1 0.000281 1560.000000 -0.000556 0.003482 0.004825 -6607 1 0.000271 1560.000000 -0.000131 -0.002260 0.009674 -6608 1 0.000225 1560.000000 0.002677 0.001028 0.004473 -6609 1 0.000193 1560.000000 -0.001083 -0.000215 0.004157 -6610 1 0.000203 1560.000000 -0.002879 -0.000816 0.007228 -6611 1 0.000228 1560.000000 0.002598 0.001416 0.003005 -6612 1 0.000193 1560.000000 -0.002028 0.001512 0.008816 -6613 1 0.000258 1560.000000 0.003350 -0.000309 0.008500 -6614 1 0.000194 1560.000000 0.002243 -0.000619 0.004987 -6615 1 0.000219 1560.000000 -0.000302 -0.001295 0.003622 -6616 1 0.000266 1560.000000 0.001342 -0.001022 0.007938 -6617 1 0.000205 1560.000000 0.000317 0.002222 0.001696 -6618 1 0.000209 1560.000000 0.002749 0.000924 0.003616 -6619 1 0.000258 1560.000000 -0.001687 -0.001864 0.004146 -6620 1 0.000195 1560.000000 -0.002451 0.001370 0.008594 -6621 1 0.000233 1560.000000 0.000328 0.001210 0.003188 -6622 1 0.000217 1560.000000 -0.001936 -0.003327 0.009665 -6623 1 0.000239 1560.000000 0.000462 -0.002167 0.001994 -6624 1 0.000211 1560.000000 -0.001794 0.001956 0.000885 -6625 1 0.000198 1560.000000 -0.001675 0.001819 0.009641 -6626 1 0.000202 1560.000000 -0.001775 -0.001563 0.006036 -6627 1 0.000204 1560.000000 0.003386 -0.000636 0.005066 -6628 1 0.000201 1560.000000 0.000024 0.001118 0.006469 -6629 1 0.000198 1560.000000 0.002314 0.001696 0.000286 -6630 1 0.000236 1560.000000 0.001444 -0.002829 0.008925 -6631 1 0.000238 1560.000000 0.000288 -0.001422 0.007540 -6632 1 0.000243 1560.000000 -0.002187 0.001893 0.005293 -6633 1 0.000284 1560.000000 -0.000864 -0.002013 0.009265 -6634 1 0.000277 1560.000000 -0.000350 0.002769 0.000914 -6635 1 0.000197 1560.000000 -0.001702 0.001518 0.001426 -6636 1 0.000204 1560.000000 0.002169 -0.001217 0.009549 -6637 1 0.000258 1560.000000 -0.000125 0.001801 0.001945 -6638 1 0.000244 1560.000000 -0.002695 -0.000086 0.003333 -6639 1 0.000217 1560.000000 -0.001727 0.003435 0.006037 -6640 1 0.000200 1560.000000 0.001369 -0.000100 0.000193 -6641 1 0.000229 1560.000000 0.000546 -0.003314 0.002633 -6642 1 0.000276 1560.000000 -0.001166 -0.002054 0.004563 -6643 1 0.000222 1560.000000 0.002457 -0.000271 0.003213 -6644 1 0.000221 1560.000000 -0.001677 -0.001857 0.007803 -6645 1 0.000226 1560.000000 -0.001341 -0.002459 0.004131 -6646 1 0.000258 1560.000000 -0.000697 -0.000126 0.001657 -6647 1 0.000204 1560.000000 -0.000535 0.001065 0.000468 -6648 1 0.000214 1560.000000 0.000624 -0.001131 0.007144 -6649 1 0.000214 1560.000000 -0.001385 0.003204 0.002340 -6650 1 0.000201 1560.000000 0.001564 0.002362 0.009758 -6651 1 0.000194 1560.000000 -0.000940 -0.000460 0.006922 -6652 1 0.000213 1560.000000 -0.000897 -0.000685 0.008628 -6653 1 0.000209 1560.000000 0.001214 0.000841 0.008539 -6654 1 0.000252 1560.000000 -0.000124 0.002314 0.007234 -6655 1 0.000195 1560.000000 0.002406 -0.000643 0.007403 -6656 1 0.000221 1560.000000 -0.002053 0.002075 0.004055 -6657 1 0.000263 1560.000000 0.001128 0.001526 0.008614 -6658 1 0.000215 1560.000000 -0.000758 0.001433 0.005101 -6659 1 0.000246 1560.000000 0.002739 -0.000535 0.009510 -6660 1 0.000199 1560.000000 -0.000159 -0.000777 0.005545 -6661 1 0.000264 1560.000000 0.001299 -0.003460 0.005998 -6662 1 0.000227 1560.000000 0.000206 0.000541 0.009759 -6663 1 0.000216 1560.000000 -0.000695 -0.002975 0.009120 -6664 1 0.000193 1560.000000 -0.000274 0.003139 0.002681 -6665 1 0.000197 1560.000000 -0.001714 0.001645 0.009370 -6666 1 0.000285 1560.000000 0.002135 0.001542 0.001988 -6667 1 0.000221 1560.000000 -0.002041 0.000828 0.002949 -6668 1 0.000200 1560.000000 0.000121 0.003390 0.008508 -6669 1 0.000222 1560.000000 -0.001133 0.001680 0.001956 -6670 1 0.000229 1560.000000 0.002106 -0.003214 0.004306 -6671 1 0.000256 1560.000000 0.001844 0.000538 0.008159 -6672 1 0.000270 1560.000000 0.001792 0.001726 0.003276 -6673 1 0.000205 1560.000000 -0.000846 -0.000317 0.001783 -6674 1 0.000237 1560.000000 -0.002184 -0.002590 0.004913 -6675 1 0.000241 1560.000000 0.001686 -0.000940 0.008248 -6676 1 0.000220 1560.000000 0.000534 -0.000497 0.000179 -6677 1 0.000248 1560.000000 -0.000550 0.001335 0.009167 -6678 1 0.000267 1560.000000 0.001791 -0.001668 0.000807 -6679 1 0.000207 1560.000000 0.001937 -0.000630 0.005697 -6680 1 0.000199 1560.000000 0.000156 0.000269 0.008385 -6681 1 0.000231 1560.000000 0.001775 0.002237 0.003330 -6682 1 0.000273 1560.000000 0.001180 -0.000890 0.002353 -6683 1 0.000222 1560.000000 -0.002111 -0.001055 0.008641 -6684 1 0.000212 1560.000000 -0.000188 0.002392 0.008018 -6685 1 0.000208 1560.000000 -0.002900 0.000551 0.000888 -6686 1 0.000194 1560.000000 0.001115 -0.002341 0.008993 -6687 1 0.000216 1560.000000 0.001434 0.000805 0.008014 -6688 1 0.000203 1560.000000 0.000351 -0.002169 0.007571 -6689 1 0.000201 1560.000000 0.002203 0.003070 0.008852 -6690 1 0.000285 1560.000000 0.001832 -0.000415 0.006032 -6691 1 0.000245 1560.000000 0.000909 0.001762 0.004290 -6692 1 0.000195 1560.000000 -0.001503 0.001124 0.005140 -6693 1 0.000212 1560.000000 -0.001132 0.001128 0.007183 -6694 1 0.000204 1560.000000 0.000532 0.002424 0.004130 -6695 1 0.000194 1560.000000 -0.002094 0.000146 0.003677 -6696 1 0.000227 1560.000000 -0.002530 0.000841 0.009611 -6697 1 0.000219 1560.000000 0.000437 0.000742 0.002445 -6698 1 0.000211 1560.000000 0.001210 0.000168 0.009497 -6699 1 0.000271 1560.000000 -0.001849 -0.001545 0.005476 -6700 1 0.000240 1560.000000 -0.001436 0.002112 0.004146 -6701 1 0.000208 1560.000000 0.000254 -0.002723 0.008562 -6702 1 0.000274 1560.000000 -0.000836 -0.003357 0.003850 -6703 1 0.000205 1560.000000 0.001699 0.001245 0.006175 -6704 1 0.000199 1560.000000 -0.002037 0.003093 0.004002 -6705 1 0.000222 1560.000000 0.000941 0.000751 0.003286 -6706 1 0.000212 1560.000000 -0.003156 0.001714 0.000171 -6707 1 0.000197 1560.000000 -0.000289 0.000351 0.003277 -6708 1 0.000255 1560.000000 -0.001038 -0.001867 0.006594 -6709 1 0.000285 1560.000000 -0.000431 0.000653 0.005634 -6710 1 0.000267 1560.000000 -0.000265 -0.002235 0.003966 -6711 1 0.000277 1560.000000 0.001955 0.001446 0.005373 -6712 1 0.000288 1560.000000 -0.000515 0.000429 0.004484 -6713 1 0.000204 1560.000000 -0.001016 0.000262 0.004160 -6714 1 0.000228 1560.000000 -0.000644 -0.002918 0.005367 -6715 1 0.000238 1560.000000 -0.000371 0.000269 0.002550 -6716 1 0.000217 1560.000000 -0.000867 -0.002424 0.009658 -6717 1 0.000212 1560.000000 -0.000257 -0.001113 0.002103 -6718 1 0.000275 1560.000000 -0.001385 -0.001174 0.005132 -6719 1 0.000271 1560.000000 0.001554 -0.000433 0.007520 -6720 1 0.000281 1560.000000 0.000735 0.002802 0.008204 -6721 1 0.000207 1560.000000 0.001846 0.002808 0.009630 -6722 1 0.000275 1560.000000 0.000218 -0.002860 0.002357 -6723 1 0.000237 1560.000000 -0.001883 0.002846 0.006886 -6724 1 0.000215 1560.000000 0.000344 -0.003702 0.006888 -6725 1 0.000196 1560.000000 -0.001631 0.000182 0.008251 -6726 1 0.000281 1560.000000 -0.000296 0.001189 0.003754 -6727 1 0.000283 1560.000000 -0.001308 -0.003592 0.009461 -6728 1 0.000198 1560.000000 0.000628 -0.000018 0.007730 -6729 1 0.000218 1560.000000 -0.001270 0.002471 0.002644 -6730 1 0.000229 1560.000000 0.003103 0.002266 0.009158 -6731 1 0.000222 1560.000000 0.003647 0.000058 0.006909 -6732 1 0.000233 1560.000000 -0.003517 0.000832 0.008135 -6733 1 0.000276 1560.000000 0.000262 -0.000101 0.008558 -6734 1 0.000193 1560.000000 0.001151 -0.002915 0.003572 -6735 1 0.000248 1560.000000 -0.000841 0.000269 0.005033 -6736 1 0.000282 1560.000000 0.000235 -0.002986 0.002748 -6737 1 0.000268 1560.000000 -0.002206 0.001689 0.002465 -6738 1 0.000217 1560.000000 -0.002810 0.000729 0.004006 -6739 1 0.000259 1560.000000 0.001054 -0.001093 0.006420 -6740 1 0.000193 1560.000000 0.000101 0.002562 0.007093 -6741 1 0.000227 1560.000000 -0.002133 0.001699 0.004787 -6742 1 0.000231 1560.000000 0.000318 -0.003171 0.007436 -6743 1 0.000255 1560.000000 0.002458 -0.000824 0.001442 -6744 1 0.000196 1560.000000 -0.002468 -0.001750 0.005228 -6745 1 0.000195 1560.000000 -0.000618 0.003094 0.007966 -6746 1 0.000217 1560.000000 0.000238 -0.002527 0.004160 -6747 1 0.000217 1560.000000 -0.003513 -0.000184 0.009518 -6748 1 0.000237 1560.000000 -0.002708 0.000505 0.003543 -6749 1 0.000286 1560.000000 -0.000606 -0.000576 0.004897 -6750 1 0.000204 1560.000000 -0.000566 0.003611 0.005145 -6751 1 0.000230 1560.000000 -0.001428 0.001406 0.003483 -6752 1 0.000264 1560.000000 0.000572 0.001138 0.006712 -6753 1 0.000224 1560.000000 -0.000260 0.002283 0.005960 -6754 1 0.000202 1560.000000 -0.000357 0.000523 0.006445 -6755 1 0.000195 1560.000000 0.001784 -0.000523 0.007479 -6756 1 0.000236 1560.000000 -0.000706 0.000535 0.009650 -6757 1 0.000213 1560.000000 0.001654 -0.002680 0.003974 -6758 1 0.000213 1560.000000 -0.000240 -0.001141 0.003915 -6759 1 0.000218 1560.000000 -0.000223 -0.003667 0.002455 -6760 1 0.000265 1560.000000 0.001593 0.003351 0.008939 -6761 1 0.000271 1560.000000 0.000755 -0.001360 0.006137 -6762 1 0.000245 1560.000000 -0.001072 -0.000780 0.006192 -6763 1 0.000194 1560.000000 0.002136 0.001089 0.008353 -6764 1 0.000264 1560.000000 -0.002138 0.000251 0.004757 -6765 1 0.000241 1560.000000 -0.003676 -0.001097 0.002431 -6766 1 0.000206 1560.000000 0.003449 -0.000610 0.004356 -6767 1 0.000210 1560.000000 -0.002029 0.002156 0.008914 -6768 1 0.000243 1560.000000 0.001972 0.001246 0.000334 -6769 1 0.000284 1560.000000 -0.001093 -0.000208 0.008365 -6770 1 0.000285 1560.000000 -0.001996 0.002370 0.001333 -6771 1 0.000271 1560.000000 -0.002287 0.001554 0.000168 -6772 1 0.000266 1560.000000 0.001341 -0.000164 0.008832 -6773 1 0.000225 1560.000000 -0.000015 0.000637 0.007392 -6774 1 0.000201 1560.000000 0.000820 0.002397 0.007644 -6775 1 0.000234 1560.000000 -0.001006 0.000918 0.008356 -6776 1 0.000194 1560.000000 -0.003705 -0.000382 0.001851 -6777 1 0.000280 1560.000000 0.001101 0.003348 0.004352 -6778 1 0.000206 1560.000000 -0.001179 -0.001517 0.007772 -6779 1 0.000196 1560.000000 -0.001367 0.003014 0.005769 -6780 1 0.000217 1560.000000 0.001527 -0.001450 0.005090 -6781 1 0.000194 1560.000000 0.000975 0.000259 0.008117 -6782 1 0.000286 1560.000000 0.002264 0.002084 0.008210 -6783 1 0.000284 1560.000000 -0.003401 -0.000306 0.002728 -6784 1 0.000252 1560.000000 0.001638 0.000795 0.003104 -6785 1 0.000216 1560.000000 0.000046 -0.003383 0.007691 -6786 1 0.000217 1560.000000 -0.001899 -0.001769 0.001908 -6787 1 0.000280 1560.000000 -0.003262 0.000198 0.001699 -6788 1 0.000212 1560.000000 -0.001237 -0.002980 0.006779 -6789 1 0.000200 1560.000000 0.002013 0.000017 0.006051 -6790 1 0.000201 1560.000000 -0.002582 -0.000836 0.003864 -6791 1 0.000227 1560.000000 -0.002468 -0.002378 0.009546 -6792 1 0.000272 1560.000000 0.000287 -0.003182 0.000325 -6793 1 0.000201 1560.000000 -0.000455 0.001885 0.008064 -6794 1 0.000218 1560.000000 0.000518 -0.002811 0.001214 -6795 1 0.000197 1560.000000 0.000621 0.000218 0.000987 -6796 1 0.000221 1560.000000 0.000498 0.002823 0.006587 -6797 1 0.000200 1560.000000 -0.000110 -0.000630 0.006078 -6798 1 0.000247 1560.000000 0.003570 -0.001022 0.006804 -6799 1 0.000249 1560.000000 -0.001765 0.002975 0.004523 -6800 1 0.000194 1560.000000 -0.002834 0.002010 0.006718 -6801 1 0.000240 1560.000000 0.001338 -0.001479 0.008615 -6802 1 0.000262 1560.000000 -0.000447 0.001452 0.005692 -6803 1 0.000193 1560.000000 -0.001892 -0.000316 0.005067 -6804 1 0.000206 1560.000000 -0.000525 -0.000100 0.000124 -6805 1 0.000256 1560.000000 -0.001532 -0.001611 0.005052 -6806 1 0.000286 1560.000000 0.001814 0.001525 0.001597 -6807 1 0.000261 1560.000000 -0.001435 0.000039 0.007403 -6808 1 0.000194 1560.000000 0.002981 0.001691 0.000595 -6809 1 0.000213 1560.000000 0.001449 -0.001952 0.002957 -6810 1 0.000216 1560.000000 -0.001390 0.000363 0.005190 -6811 1 0.000242 1560.000000 -0.001761 0.003293 0.008514 -6812 1 0.000205 1560.000000 -0.002777 0.002627 0.003502 -6813 1 0.000226 1560.000000 0.001421 -0.000964 0.001304 -6814 1 0.000231 1560.000000 0.000084 -0.001665 0.002534 -6815 1 0.000231 1560.000000 0.002039 -0.000860 0.003616 -6816 1 0.000282 1560.000000 0.001702 0.001020 0.006668 -6817 1 0.000199 1560.000000 0.001974 0.002747 0.003649 -6818 1 0.000240 1560.000000 0.000178 0.001494 0.005806 -6819 1 0.000220 1560.000000 -0.002509 -0.001871 0.004504 -6820 1 0.000228 1560.000000 -0.000870 0.000503 0.000141 -6821 1 0.000216 1560.000000 0.000092 0.000006 0.003348 -6822 1 0.000208 1560.000000 0.002996 0.002354 0.005046 -6823 1 0.000197 1560.000000 0.002342 -0.002959 0.003855 -6824 1 0.000194 1560.000000 0.002494 0.001802 0.007630 -6825 1 0.000215 1560.000000 -0.000087 -0.002867 0.005786 -6826 1 0.000209 1560.000000 0.002431 -0.000074 0.002863 -6827 1 0.000222 1560.000000 0.000072 -0.002386 0.007082 -6828 1 0.000224 1560.000000 -0.000461 -0.002453 0.009470 -6829 1 0.000271 1560.000000 -0.002335 -0.002426 0.003094 -6830 1 0.000246 1560.000000 0.000506 0.002532 0.004400 -6831 1 0.000212 1560.000000 0.001973 -0.001823 0.009044 -6832 1 0.000230 1560.000000 0.003752 0.000077 0.008022 -6833 1 0.000203 1560.000000 -0.001337 0.000584 0.003241 -6834 1 0.000210 1560.000000 0.001274 0.000095 0.000813 -6835 1 0.000225 1560.000000 0.002374 -0.002874 0.002227 -6836 1 0.000277 1560.000000 -0.002624 -0.002187 0.008781 -6837 1 0.000218 1560.000000 -0.002122 0.002340 0.006581 -6838 1 0.000266 1560.000000 -0.000393 -0.001779 0.003798 -6839 1 0.000204 1560.000000 -0.001554 0.002775 0.009037 -6840 1 0.000222 1560.000000 0.001958 0.001508 0.006040 -6841 1 0.000232 1560.000000 -0.001723 -0.000459 0.004623 -6842 1 0.000242 1560.000000 -0.000845 0.000441 0.006827 -6843 1 0.000276 1560.000000 0.000117 0.002238 0.001560 -6844 1 0.000273 1560.000000 0.002721 -0.001104 0.000972 -6845 1 0.000236 1560.000000 0.000309 -0.002576 0.002241 -6846 1 0.000206 1560.000000 0.000580 -0.001897 0.002271 -6847 1 0.000238 1560.000000 0.001211 0.001131 0.006375 -6848 1 0.000194 1560.000000 -0.002232 0.003131 0.003105 -6849 1 0.000225 1560.000000 0.000806 0.000611 0.006200 -6850 1 0.000241 1560.000000 -0.003233 -0.001274 0.004758 -6851 1 0.000198 1560.000000 -0.001919 0.000678 0.005100 -6852 1 0.000203 1560.000000 0.000100 0.000106 0.007471 -6853 1 0.000282 1560.000000 -0.000743 -0.003187 0.001209 -6854 1 0.000213 1560.000000 -0.000398 -0.002352 0.000448 -6855 1 0.000275 1560.000000 0.000170 0.001310 0.004550 -6856 1 0.000211 1560.000000 -0.002847 -0.000258 0.009209 -6857 1 0.000235 1560.000000 -0.002297 0.000695 0.000873 -6858 1 0.000194 1560.000000 0.000960 0.000042 0.002096 -6859 1 0.000238 1560.000000 -0.000428 0.003410 0.004453 -6860 1 0.000233 1560.000000 0.001336 0.001579 0.006733 -6861 1 0.000225 1560.000000 -0.000920 -0.003423 0.004339 -6862 1 0.000212 1560.000000 0.000176 0.000209 0.003232 -6863 1 0.000281 1560.000000 -0.000732 -0.002373 0.001659 -6864 1 0.000205 1560.000000 0.000387 0.003530 0.004384 -6865 1 0.000222 1560.000000 0.003049 0.000472 0.004193 -6866 1 0.000258 1560.000000 -0.001901 -0.001475 0.009703 -6867 1 0.000280 1560.000000 -0.000267 0.003726 0.004566 -6868 1 0.000212 1560.000000 -0.001590 -0.001899 0.005308 -6869 1 0.000226 1560.000000 0.000841 -0.002328 0.004698 -6870 1 0.000260 1560.000000 0.000591 -0.003559 0.007417 -6871 1 0.000220 1560.000000 -0.001373 0.003089 0.009563 -6872 1 0.000239 1560.000000 0.001295 0.002512 0.001298 -6873 1 0.000244 1560.000000 0.001600 -0.000432 0.000153 -6874 1 0.000256 1560.000000 -0.000775 0.000595 0.001464 -6875 1 0.000249 1560.000000 0.001133 0.000557 0.007777 -6876 1 0.000265 1560.000000 -0.001684 -0.003447 0.004648 -6877 1 0.000210 1560.000000 0.000633 0.001286 0.008406 -6878 1 0.000197 1560.000000 -0.000110 -0.000585 0.001986 -6879 1 0.000236 1560.000000 0.003273 -0.001303 0.008225 -6880 1 0.000268 1560.000000 0.000636 0.000468 0.001377 -6881 1 0.000215 1560.000000 0.000557 -0.001215 0.006871 -6882 1 0.000224 1560.000000 -0.001803 0.000397 0.002312 -6883 1 0.000231 1560.000000 -0.001101 -0.000316 0.004979 -6884 1 0.000199 1560.000000 0.002616 0.002557 0.003080 -6885 1 0.000258 1560.000000 0.002363 -0.000352 0.007158 -6886 1 0.000214 1560.000000 0.000654 -0.000893 0.002598 -6887 1 0.000194 1560.000000 0.000052 0.000386 0.005706 -6888 1 0.000234 1560.000000 0.002493 0.001987 0.004160 -6889 1 0.000197 1560.000000 0.000459 -0.000124 0.002806 -6890 1 0.000197 1560.000000 0.001648 0.003346 0.004607 -6891 1 0.000212 1560.000000 0.001127 -0.002588 0.008883 -6892 1 0.000259 1560.000000 0.003105 -0.001518 0.006029 -6893 1 0.000196 1560.000000 -0.000663 0.003025 0.003477 -6894 1 0.000205 1560.000000 -0.001489 0.001803 0.008171 -6895 1 0.000250 1560.000000 -0.003670 0.000516 0.002024 -6896 1 0.000233 1560.000000 -0.001395 0.002505 0.005152 -6897 1 0.000233 1560.000000 0.000528 0.002230 0.004936 -6898 1 0.000214 1560.000000 0.000883 -0.002447 0.000947 -6899 1 0.000226 1560.000000 0.001448 0.000689 0.004640 -6900 1 0.000239 1560.000000 0.003324 0.001122 0.000971 -6901 1 0.000282 1560.000000 -0.002275 -0.002371 0.001685 -6902 1 0.000227 1560.000000 -0.002083 -0.000974 0.003728 -6903 1 0.000263 1560.000000 -0.000816 -0.000159 0.001205 -6904 1 0.000268 1560.000000 -0.000860 0.002699 0.006554 -6905 1 0.000221 1560.000000 -0.002794 -0.001508 0.009777 -6906 1 0.000195 1560.000000 0.001862 -0.001992 0.008634 -6907 1 0.000243 1560.000000 -0.003139 0.000689 0.003116 -6908 1 0.000268 1560.000000 0.000402 -0.000697 0.007835 -6909 1 0.000266 1560.000000 -0.002582 0.002740 0.001296 -6910 1 0.000202 1560.000000 -0.002274 -0.000026 0.004690 -6911 1 0.000209 1560.000000 -0.002769 -0.002496 0.007668 -6912 1 0.000265 1560.000000 -0.000793 0.001050 0.001261 -6913 1 0.000267 1560.000000 -0.001995 0.001478 0.006690 -6914 1 0.000271 1560.000000 0.002647 0.002190 0.004340 -6915 1 0.000276 1560.000000 -0.003274 -0.002022 0.000731 -6916 1 0.000271 1560.000000 0.002454 0.000809 0.007791 -6917 1 0.000271 1560.000000 0.000772 -0.002235 0.002882 -6918 1 0.000252 1560.000000 0.002371 -0.001869 0.007194 -6919 1 0.000211 1560.000000 -0.003633 -0.000978 0.009210 -6920 1 0.000253 1560.000000 0.001944 0.001088 0.001243 -6921 1 0.000207 1560.000000 0.000736 -0.001900 0.007362 -6922 1 0.000215 1560.000000 -0.000235 0.001505 0.001867 -6923 1 0.000209 1560.000000 -0.001619 -0.001378 0.008874 -6924 1 0.000207 1560.000000 0.002255 -0.001103 0.001274 -6925 1 0.000252 1560.000000 0.000900 -0.001926 0.003810 -6926 1 0.000220 1560.000000 0.001786 -0.002324 0.003408 -6927 1 0.000224 1560.000000 0.002294 -0.001135 0.005358 -6928 1 0.000212 1560.000000 -0.001505 -0.000509 0.001585 -6929 1 0.000203 1560.000000 0.001805 -0.000690 0.008423 -6930 1 0.000227 1560.000000 0.001709 -0.003141 0.006961 -6931 1 0.000240 1560.000000 0.000348 0.001071 0.002918 -6932 1 0.000217 1560.000000 -0.002706 -0.002503 0.001316 -6933 1 0.000251 1560.000000 -0.000564 -0.001592 0.002849 -6934 1 0.000250 1560.000000 0.001936 -0.002021 0.008300 -6935 1 0.000214 1560.000000 -0.000758 -0.001887 0.003220 -6936 1 0.000264 1560.000000 -0.002221 -0.001456 0.008441 -6937 1 0.000201 1560.000000 -0.000935 -0.001380 0.002968 -6938 1 0.000240 1560.000000 0.001759 -0.000470 0.004139 -6939 1 0.000219 1560.000000 0.000293 0.000259 0.002063 -6940 1 0.000216 1560.000000 -0.002296 0.000983 0.004942 -6941 1 0.000204 1560.000000 -0.001592 0.000073 0.007738 -6942 1 0.000262 1560.000000 -0.000768 -0.002953 0.004292 -6943 1 0.000204 1560.000000 -0.000113 -0.002344 0.002885 -6944 1 0.000265 1560.000000 0.000092 0.002705 0.000864 -6945 1 0.000197 1560.000000 0.000442 -0.000874 0.001702 -6946 1 0.000196 1560.000000 -0.002634 0.001895 0.001931 -6947 1 0.000225 1560.000000 0.001018 -0.000048 0.009679 -6948 1 0.000268 1560.000000 0.002799 0.001980 0.000635 -6949 1 0.000269 1560.000000 0.000682 0.003781 0.002863 -6950 1 0.000222 1560.000000 0.002029 -0.001284 0.005216 -6951 1 0.000209 1560.000000 0.001127 -0.003499 0.000736 -6952 1 0.000214 1560.000000 0.002835 0.001311 0.005848 -6953 1 0.000215 1560.000000 0.000638 -0.000295 0.002284 -6954 1 0.000214 1560.000000 -0.000504 -0.000324 0.001254 -6955 1 0.000252 1560.000000 -0.003778 -0.000532 0.006384 -6956 1 0.000192 1560.000000 0.000487 -0.001459 0.009366 -6957 1 0.000231 1560.000000 -0.000928 -0.002798 0.009793 -6958 1 0.000192 1560.000000 0.002239 0.001908 0.003883 -6959 1 0.000195 1560.000000 -0.000323 0.000932 0.006269 -6960 1 0.000285 1560.000000 -0.000864 0.000855 0.002477 -6961 1 0.000270 1560.000000 -0.000498 0.003092 0.009127 -6962 1 0.000213 1560.000000 0.002392 0.000917 0.000678 -6963 1 0.000246 1560.000000 -0.000976 -0.001046 0.006471 -6964 1 0.000244 1560.000000 0.000759 0.003308 0.005185 -6965 1 0.000232 1560.000000 0.000758 0.003152 0.005886 -6966 1 0.000202 1560.000000 -0.000770 -0.002229 0.002622 -6967 1 0.000209 1560.000000 0.002760 -0.000870 0.008000 -6968 1 0.000193 1560.000000 0.000922 0.002412 0.002494 -6969 1 0.000255 1560.000000 0.001615 -0.000491 0.005136 -6970 1 0.000262 1560.000000 -0.000406 -0.001927 0.000318 -6971 1 0.000252 1560.000000 0.002290 0.001262 0.002545 -6972 1 0.000196 1560.000000 -0.000801 0.000238 0.001037 -6973 1 0.000270 1560.000000 0.000653 -0.001472 0.006465 -6974 1 0.000241 1560.000000 -0.003213 -0.000318 0.007291 -6975 1 0.000253 1560.000000 0.001352 -0.002419 0.007480 -6976 1 0.000200 1560.000000 -0.000355 0.001197 0.004473 -6977 1 0.000196 1560.000000 0.002212 -0.001714 0.002178 -6978 1 0.000274 1560.000000 0.002712 -0.002476 0.006170 -6979 1 0.000225 1560.000000 0.000856 0.003548 0.007980 -6980 1 0.000210 1560.000000 -0.002510 0.000664 0.004449 -6981 1 0.000269 1560.000000 -0.000564 -0.001110 0.003899 -6982 1 0.000203 1560.000000 0.000465 -0.003144 0.000628 -6983 1 0.000201 1560.000000 0.000732 -0.001712 0.004930 -6984 1 0.000231 1560.000000 -0.001989 -0.002256 0.002993 -6985 1 0.000201 1560.000000 0.003071 0.002224 0.007797 -6986 1 0.000195 1560.000000 -0.001475 0.000949 0.005252 -6987 1 0.000199 1560.000000 0.002340 -0.001736 0.001355 -6988 1 0.000208 1560.000000 0.000991 -0.002539 0.003904 -6989 1 0.000246 1560.000000 0.001326 0.000319 0.005162 -6990 1 0.000244 1560.000000 0.002167 0.000248 0.006384 -6991 1 0.000259 1560.000000 -0.001067 -0.002515 0.002452 -6992 1 0.000197 1560.000000 0.001100 0.000211 0.000207 -6993 1 0.000217 1560.000000 0.000831 0.002517 0.002172 -6994 1 0.000242 1560.000000 0.001442 0.003219 0.006695 -6995 1 0.000209 1560.000000 -0.002686 0.000678 0.007137 -6996 1 0.000268 1560.000000 -0.002347 0.000374 0.006147 -6997 1 0.000232 1560.000000 -0.001653 0.001589 0.008429 -6998 1 0.000220 1560.000000 -0.003430 -0.000660 0.005742 -6999 1 0.000197 1560.000000 -0.000173 0.000134 0.004782 -7000 1 0.000206 1560.000000 -0.002293 0.002316 0.003875 -7001 1 0.000208 1560.000000 -0.000431 0.002266 0.006232 -7002 1 0.000221 1560.000000 -0.000091 -0.001145 0.006058 -7003 1 0.000228 1560.000000 -0.003289 -0.000811 0.009098 -7004 1 0.000225 1560.000000 0.002930 -0.000127 0.000253 -7005 1 0.000221 1560.000000 0.003418 0.000511 0.005704 -7006 1 0.000218 1560.000000 0.001620 -0.003174 0.009179 -7007 1 0.000193 1560.000000 -0.000562 0.001670 0.001824 -7008 1 0.000206 1560.000000 0.000311 0.001049 0.009360 -7009 1 0.000250 1560.000000 -0.001516 0.002111 0.003437 -7010 1 0.000244 1560.000000 0.000226 -0.001652 0.000639 -7011 1 0.000250 1560.000000 -0.002453 0.001190 0.009123 -7012 1 0.000281 1560.000000 -0.002002 -0.002496 0.001009 -7013 1 0.000258 1560.000000 -0.000954 0.000845 0.009628 -7014 1 0.000270 1560.000000 -0.003448 -0.001093 0.008344 -7015 1 0.000247 1560.000000 0.001471 -0.001596 0.000623 -7016 1 0.000222 1560.000000 0.000033 0.000475 0.004705 -7017 1 0.000230 1560.000000 0.002978 -0.001497 0.004800 -7018 1 0.000201 1560.000000 -0.001724 -0.001065 0.004221 -7019 1 0.000283 1560.000000 0.002407 0.002377 0.005507 -7020 1 0.000195 1560.000000 -0.003765 0.000804 0.002003 -7021 1 0.000287 1560.000000 -0.002218 -0.000417 0.003615 -7022 1 0.000203 1560.000000 0.000469 -0.000022 0.006393 -7023 1 0.000244 1560.000000 -0.003034 0.001253 0.005458 -7024 1 0.000266 1560.000000 0.003213 -0.000786 0.009689 -7025 1 0.000238 1560.000000 -0.002999 0.000698 0.006388 -7026 1 0.000192 1560.000000 -0.002023 0.001568 0.006398 -7027 1 0.000235 1560.000000 0.002387 0.002854 0.003201 -7028 1 0.000264 1560.000000 -0.002356 0.000959 0.007267 -7029 1 0.000235 1560.000000 0.002965 0.002346 0.001699 -7030 1 0.000196 1560.000000 -0.002900 -0.000461 0.003009 -7031 1 0.000285 1560.000000 -0.003576 -0.001024 0.009851 -7032 1 0.000268 1560.000000 -0.003275 -0.001320 0.001729 -7033 1 0.000258 1560.000000 -0.002373 0.001054 0.005492 -7034 1 0.000198 1560.000000 -0.001606 -0.000446 0.004842 -7035 1 0.000206 1560.000000 0.001317 0.000239 0.006239 -7036 1 0.000281 1560.000000 0.000297 -0.002919 0.001333 -7037 1 0.000212 1560.000000 -0.000612 -0.000327 0.008585 -7038 1 0.000199 1560.000000 0.000530 -0.002556 0.006462 -7039 1 0.000231 1560.000000 -0.002153 0.000616 0.002550 -7040 1 0.000213 1560.000000 0.000294 0.001304 0.005309 -7041 1 0.000202 1560.000000 -0.000491 0.002678 0.007449 -7042 1 0.000275 1560.000000 0.001297 -0.002771 0.005502 -7043 1 0.000213 1560.000000 -0.003094 -0.001398 0.009429 -7044 1 0.000256 1560.000000 0.001139 -0.000249 0.001385 -7045 1 0.000202 1560.000000 0.000631 0.000866 0.001837 -7046 1 0.000234 1560.000000 0.000385 0.003595 0.001032 -7047 1 0.000195 1560.000000 0.000681 0.001141 0.000514 -7048 1 0.000237 1560.000000 -0.000506 0.001326 0.005220 -7049 1 0.000195 1560.000000 -0.001220 0.002014 0.006028 -7050 1 0.000201 1560.000000 0.000470 0.002036 0.003433 -7051 1 0.000225 1560.000000 0.001483 0.002207 0.008889 -7052 1 0.000250 1560.000000 -0.003099 -0.001559 0.005446 -7053 1 0.000210 1560.000000 -0.002519 -0.002770 0.007010 -7054 1 0.000220 1560.000000 -0.002062 -0.000891 0.000462 -7055 1 0.000217 1560.000000 0.002348 0.001369 0.001081 -7056 1 0.000258 1560.000000 -0.003346 -0.000560 0.006961 -7057 1 0.000203 1560.000000 -0.000287 -0.000520 0.003558 -7058 1 0.000206 1560.000000 0.002818 0.001206 0.009265 -7059 1 0.000215 1560.000000 0.000730 -0.000999 0.002414 -7060 1 0.000243 1560.000000 -0.000722 0.000328 0.006536 -7061 1 0.000203 1560.000000 -0.003752 0.000233 0.007617 -7062 1 0.000216 1560.000000 -0.001967 0.002669 0.007292 -7063 1 0.000198 1560.000000 0.000760 -0.001120 0.000779 -7064 1 0.000200 1560.000000 -0.002104 -0.001360 0.007417 -7065 1 0.000284 1560.000000 0.003431 -0.000941 0.000208 -7066 1 0.000203 1560.000000 -0.000774 0.002647 0.002397 -7067 1 0.000201 1560.000000 0.000376 -0.000519 0.005689 -7068 1 0.000264 1560.000000 0.000208 0.003272 0.007315 -7069 1 0.000203 1560.000000 -0.001324 0.002126 0.004804 -7070 1 0.000282 1560.000000 0.001926 0.002180 0.001915 -7071 1 0.000225 1560.000000 0.001094 0.003622 0.004182 -7072 1 0.000214 1560.000000 -0.001482 0.003508 0.009471 -7073 1 0.000238 1560.000000 0.003486 0.001353 0.001011 -7074 1 0.000211 1560.000000 0.000544 -0.000753 0.004407 -7075 1 0.000209 1560.000000 -0.001192 -0.003296 0.001563 -7076 1 0.000268 1560.000000 0.001711 -0.001971 0.003481 -7077 1 0.000258 1560.000000 -0.000981 -0.002990 0.008271 -7078 1 0.000232 1560.000000 0.002782 -0.001895 0.005286 -7079 1 0.000235 1560.000000 0.001876 -0.002214 0.000816 -7080 1 0.000239 1560.000000 -0.002805 -0.002469 0.007170 -7081 1 0.000220 1560.000000 0.001652 -0.000502 0.007852 -7082 1 0.000219 1560.000000 -0.002131 -0.000211 0.001797 -7083 1 0.000225 1560.000000 -0.001575 0.003089 0.006403 -7084 1 0.000200 1560.000000 0.000634 0.003179 0.009723 -7085 1 0.000199 1560.000000 0.001067 -0.001338 0.002140 -7086 1 0.000230 1560.000000 -0.002992 -0.001908 0.000469 -7087 1 0.000247 1560.000000 0.002207 0.003112 0.005438 -7088 1 0.000254 1560.000000 0.001180 0.003339 0.000442 -7089 1 0.000272 1560.000000 -0.000922 -0.002537 0.002973 -7090 1 0.000257 1560.000000 -0.003542 -0.000532 0.002787 -7091 1 0.000221 1560.000000 -0.002682 0.001897 0.003951 -7092 1 0.000229 1560.000000 0.001969 0.001812 0.000259 -7093 1 0.000195 1560.000000 0.000284 -0.000142 0.008166 -7094 1 0.000260 1560.000000 0.000408 -0.002626 0.002904 -7095 1 0.000214 1560.000000 -0.003366 0.001832 0.006367 -7096 1 0.000221 1560.000000 -0.002527 0.001663 0.008288 -7097 1 0.000258 1560.000000 0.002958 -0.000223 0.000714 -7098 1 0.000221 1560.000000 0.001940 0.000736 0.004103 -7099 1 0.000199 1560.000000 0.002630 0.000603 0.006410 -7100 1 0.000211 1560.000000 -0.002315 0.001091 0.008062 -7101 1 0.000223 1560.000000 0.000231 0.001130 0.005911 -7102 1 0.000205 1560.000000 -0.002166 0.000592 0.002981 -7103 1 0.000248 1560.000000 0.000671 0.001704 0.006390 -7104 1 0.000197 1560.000000 -0.001338 0.000761 0.005070 -7105 1 0.000257 1560.000000 0.002330 -0.002653 0.000425 -7106 1 0.000271 1560.000000 0.000961 -0.003248 0.008588 -7107 1 0.000258 1560.000000 0.001625 -0.000495 0.001068 -7108 1 0.000233 1560.000000 0.001584 0.000903 0.001809 -7109 1 0.000255 1560.000000 0.000850 0.003634 0.003695 -7110 1 0.000230 1560.000000 0.001210 -0.000375 0.007752 -7111 1 0.000198 1560.000000 0.000296 0.000737 0.002117 -7112 1 0.000244 1560.000000 0.002494 -0.000762 0.009766 -7113 1 0.000250 1560.000000 -0.002530 -0.001249 0.008072 -7114 1 0.000263 1560.000000 0.003011 -0.002237 0.003325 -7115 1 0.000264 1560.000000 0.001024 -0.000756 0.003746 -7116 1 0.000258 1560.000000 0.001312 0.001776 0.009396 -7117 1 0.000209 1560.000000 -0.003073 0.000715 0.001670 -7118 1 0.000197 1560.000000 0.000816 0.000189 0.003699 -7119 1 0.000224 1560.000000 -0.002144 -0.000308 0.005737 -7120 1 0.000203 1560.000000 -0.000603 -0.000022 0.001962 -7121 1 0.000247 1560.000000 -0.001386 -0.001978 0.002284 -7122 1 0.000194 1560.000000 0.001146 -0.000029 0.003622 -7123 1 0.000198 1560.000000 0.001760 -0.001993 0.002637 -7124 1 0.000244 1560.000000 -0.000615 0.003377 0.006988 -7125 1 0.000225 1560.000000 -0.001791 0.001125 0.005406 -7126 1 0.000204 1560.000000 -0.000012 -0.000692 0.000704 -7127 1 0.000288 1560.000000 0.003492 0.000979 0.006278 -7128 1 0.000254 1560.000000 -0.001613 0.001676 0.003162 -7129 1 0.000215 1560.000000 0.001868 0.000489 0.007874 -7130 1 0.000257 1560.000000 0.001654 -0.001560 0.004801 -7131 1 0.000197 1560.000000 -0.000761 0.000656 0.000692 -7132 1 0.000208 1560.000000 0.000723 0.001833 0.008937 -7133 1 0.000284 1560.000000 0.002450 -0.002363 0.002299 -7134 1 0.000193 1560.000000 0.000814 -0.000261 0.007929 -7135 1 0.000201 1560.000000 0.000813 0.002196 0.008671 -7136 1 0.000216 1560.000000 0.000139 0.001301 0.004236 -7137 1 0.000281 1560.000000 0.000574 -0.003050 0.009742 -7138 1 0.000211 1560.000000 0.002589 -0.000399 0.006073 -7139 1 0.000244 1560.000000 -0.001226 0.000794 0.004801 -7140 1 0.000259 1560.000000 0.001103 0.002235 0.009768 -7141 1 0.000215 1560.000000 0.000422 -0.003479 0.000669 -7142 1 0.000282 1560.000000 0.002376 -0.002639 0.008600 -7143 1 0.000204 1560.000000 -0.001947 -0.001935 0.006332 -7144 1 0.000251 1560.000000 0.002701 0.001294 0.001021 -7145 1 0.000225 1560.000000 0.000884 -0.002205 0.001343 -7146 1 0.000235 1560.000000 0.002445 -0.002205 0.005277 -7147 1 0.000241 1560.000000 -0.002507 0.000209 0.001116 -7148 1 0.000201 1560.000000 0.000768 -0.000129 0.003190 -7149 1 0.000260 1560.000000 0.002289 0.002919 0.007827 -7150 1 0.000235 1560.000000 0.000128 -0.001223 0.002887 -7151 1 0.000235 1560.000000 0.002551 0.002830 0.005326 -7152 1 0.000211 1560.000000 -0.002629 0.000909 0.002332 -7153 1 0.000231 1560.000000 0.001990 0.002500 0.002171 -7154 1 0.000240 1560.000000 0.000672 0.001649 0.009295 -7155 1 0.000227 1560.000000 -0.000005 -0.000658 0.008847 -7156 1 0.000229 1560.000000 0.003034 -0.001386 0.009043 -7157 1 0.000193 1560.000000 -0.001151 0.000138 0.006052 -7158 1 0.000288 1560.000000 0.001227 0.001278 0.008754 -7159 1 0.000269 1560.000000 -0.000339 -0.003634 0.005958 -7160 1 0.000255 1560.000000 -0.000166 -0.000317 0.003550 -7161 1 0.000262 1560.000000 -0.001629 -0.003266 0.006938 -7162 1 0.000198 1560.000000 0.001060 0.002142 0.006900 -7163 1 0.000200 1560.000000 0.002777 -0.002358 0.009132 -7164 1 0.000278 1560.000000 -0.002057 0.002552 0.004767 -7165 1 0.000205 1560.000000 0.002408 -0.000270 0.002582 -7166 1 0.000221 1560.000000 0.001031 0.001633 0.007781 -7167 1 0.000243 1560.000000 0.003038 0.000067 0.004598 -7168 1 0.000261 1560.000000 -0.001949 0.000470 0.001108 -7169 1 0.000236 1560.000000 0.001461 0.000248 0.000346 -7170 1 0.000193 1560.000000 0.000889 0.003617 0.007414 -7171 1 0.000276 1560.000000 0.002739 0.000748 0.009556 -7172 1 0.000212 1560.000000 -0.002922 0.000122 0.007603 -7173 1 0.000211 1560.000000 -0.002726 -0.001895 0.006163 -7174 1 0.000252 1560.000000 -0.001051 -0.003000 0.004546 -7175 1 0.000259 1560.000000 -0.000332 0.002754 0.003802 -7176 1 0.000274 1560.000000 -0.001006 0.000036 0.003672 -7177 1 0.000239 1560.000000 0.001349 -0.001990 0.000395 -7178 1 0.000197 1560.000000 0.002027 -0.002502 0.000108 -7179 1 0.000239 1560.000000 -0.000704 0.002721 0.002093 -7180 1 0.000274 1560.000000 -0.000656 -0.002518 0.005067 -7181 1 0.000219 1560.000000 -0.000551 0.003686 0.004141 -7182 1 0.000258 1560.000000 -0.001737 0.001482 0.001911 -7183 1 0.000235 1560.000000 0.000789 0.000397 0.008149 -7184 1 0.000234 1560.000000 0.000387 -0.002338 0.004519 -7185 1 0.000214 1560.000000 -0.001673 0.003168 0.002999 -7186 1 0.000277 1560.000000 0.001803 -0.002263 0.001370 -7187 1 0.000223 1560.000000 0.002365 0.002882 0.008907 -7188 1 0.000193 1560.000000 0.000117 -0.003380 0.004820 -7189 1 0.000229 1560.000000 -0.000672 -0.002632 0.003000 -7190 1 0.000271 1560.000000 0.001737 0.001925 0.000416 -7191 1 0.000207 1560.000000 0.003163 -0.002025 0.001177 -7192 1 0.000273 1560.000000 0.001181 0.000692 0.007046 -7193 1 0.000237 1560.000000 0.003251 0.001755 0.005433 -7194 1 0.000193 1560.000000 0.002508 -0.000514 0.001326 -7195 1 0.000257 1560.000000 -0.000923 0.002035 0.007089 -7196 1 0.000202 1560.000000 -0.002041 -0.002007 0.002879 -7197 1 0.000227 1560.000000 0.000113 -0.000279 0.009021 -7198 1 0.000278 1560.000000 -0.001194 0.000003 0.009696 -7199 1 0.000270 1560.000000 -0.000733 0.000025 0.002940 -7200 1 0.000257 1560.000000 0.003329 0.001500 0.008113 -7201 1 0.000205 1560.000000 -0.001237 0.002396 0.008190 -7202 1 0.000262 1560.000000 -0.001553 0.000591 0.007769 -7203 1 0.000240 1560.000000 0.000492 -0.002150 0.003575 -7204 1 0.000210 1560.000000 -0.000697 0.003450 0.006765 -7205 1 0.000195 1560.000000 0.002759 -0.001871 0.008074 -7206 1 0.000247 1560.000000 -0.001019 0.001454 0.007744 -7207 1 0.000284 1560.000000 -0.000485 -0.003717 0.007645 -7208 1 0.000214 1560.000000 -0.002629 -0.000262 0.002113 -7209 1 0.000224 1560.000000 -0.002582 0.001438 0.001339 -7210 1 0.000221 1560.000000 0.001187 -0.001609 0.005343 -7211 1 0.000251 1560.000000 -0.003245 0.001190 0.003648 -7212 1 0.000194 1560.000000 0.000443 -0.001939 0.002532 -7213 1 0.000195 1560.000000 0.001861 -0.002060 0.007735 -7214 1 0.000195 1560.000000 0.002802 -0.001386 0.004986 -7215 1 0.000222 1560.000000 0.001618 -0.002628 0.003333 -7216 1 0.000228 1560.000000 0.000538 -0.002385 0.004883 -7217 1 0.000278 1560.000000 -0.000514 0.000380 0.002890 -7218 1 0.000279 1560.000000 -0.001477 0.003292 0.003086 -7219 1 0.000222 1560.000000 0.001454 -0.000593 0.008645 -7220 1 0.000257 1560.000000 -0.001126 0.003503 0.009466 -7221 1 0.000230 1560.000000 -0.003000 -0.001657 0.001235 -7222 1 0.000230 1560.000000 -0.000115 -0.003312 0.006491 -7223 1 0.000232 1560.000000 0.001606 -0.001747 0.001284 -7224 1 0.000206 1560.000000 0.001017 0.000237 0.007688 -7225 1 0.000278 1560.000000 0.000551 -0.003548 0.004784 -7226 1 0.000218 1560.000000 0.000258 0.001549 0.001446 -7227 1 0.000204 1560.000000 -0.000765 -0.000505 0.003178 -7228 1 0.000244 1560.000000 -0.001139 0.000615 0.001359 -7229 1 0.000194 1560.000000 -0.001593 -0.000519 0.009386 -7230 1 0.000247 1560.000000 0.000080 0.000569 0.000509 -7231 1 0.000217 1560.000000 0.001535 0.000707 0.009665 -7232 1 0.000239 1560.000000 0.000272 -0.001543 0.008037 -7233 1 0.000269 1560.000000 0.002458 -0.000438 0.004850 -7234 1 0.000288 1560.000000 0.001860 0.002068 0.003812 -7235 1 0.000201 1560.000000 -0.000422 -0.002450 0.006383 -7236 1 0.000208 1560.000000 0.003269 0.001502 0.005111 -7237 1 0.000275 1560.000000 -0.002461 -0.002550 0.009168 -7238 1 0.000205 1560.000000 0.000605 -0.003805 0.003175 -7239 1 0.000233 1560.000000 -0.002098 -0.002193 0.009502 -7240 1 0.000228 1560.000000 -0.003095 0.001681 0.009416 -7241 1 0.000225 1560.000000 -0.001365 0.000112 0.006332 -7242 1 0.000251 1560.000000 -0.000746 0.000583 0.008498 -7243 1 0.000271 1560.000000 0.000510 -0.001662 0.007018 -7244 1 0.000209 1560.000000 0.001117 0.001268 0.008979 -7245 1 0.000283 1560.000000 -0.001955 0.002320 0.000466 -7246 1 0.000250 1560.000000 0.000225 0.003609 0.001716 -7247 1 0.000244 1560.000000 -0.001615 -0.003401 0.006678 -7248 1 0.000195 1560.000000 0.000113 -0.003386 0.000656 -7249 1 0.000280 1560.000000 -0.001480 0.000090 0.001227 -7250 1 0.000205 1560.000000 0.003076 -0.001727 0.001364 -7251 1 0.000225 1560.000000 0.003357 -0.000450 0.005317 -7252 1 0.000209 1560.000000 -0.002523 0.002357 0.004325 -7253 1 0.000203 1560.000000 0.001082 -0.002748 0.004130 -7254 1 0.000241 1560.000000 0.002766 0.001283 0.007029 -7255 1 0.000250 1560.000000 0.001840 0.001246 0.005159 -7256 1 0.000208 1560.000000 0.000908 -0.001811 0.000743 -7257 1 0.000213 1560.000000 0.001129 0.001756 0.001012 -7258 1 0.000265 1560.000000 -0.000673 0.002506 0.001648 -7259 1 0.000196 1560.000000 0.002928 0.001335 0.005135 -7260 1 0.000256 1560.000000 0.000644 0.001618 0.002809 -7261 1 0.000199 1560.000000 -0.002136 0.002237 0.005655 -7262 1 0.000275 1560.000000 -0.001073 0.002025 0.004600 -7263 1 0.000197 1560.000000 0.001353 0.000322 0.009561 -7264 1 0.000197 1560.000000 0.000695 -0.000005 0.005718 -7265 1 0.000227 1560.000000 -0.000050 -0.002240 0.006882 -7266 1 0.000233 1560.000000 0.002564 0.000613 0.001946 -7267 1 0.000243 1560.000000 0.000148 -0.000635 0.000146 -7268 1 0.000193 1560.000000 0.000134 0.001352 0.006493 -7269 1 0.000230 1560.000000 -0.003128 0.000268 0.000485 -7270 1 0.000216 1560.000000 -0.001564 -0.003417 0.000147 -7271 1 0.000197 1560.000000 0.000253 0.000006 0.002202 -7272 1 0.000243 1560.000000 0.001388 -0.000542 0.003066 -7273 1 0.000222 1560.000000 0.000448 -0.000826 0.009820 -7274 1 0.000273 1560.000000 0.002145 -0.001797 0.007874 -7275 1 0.000277 1560.000000 0.000581 -0.001419 0.009083 -7276 1 0.000264 1560.000000 -0.001876 -0.000787 0.006613 -7277 1 0.000199 1560.000000 0.002396 0.001346 0.004476 -7278 1 0.000278 1560.000000 -0.002784 0.000766 0.005782 -7279 1 0.000249 1560.000000 0.001437 0.003180 0.005688 -7280 1 0.000229 1560.000000 -0.002561 0.002368 0.000977 -7281 1 0.000241 1560.000000 0.001571 -0.001119 0.002870 -7282 1 0.000266 1560.000000 -0.000955 0.002954 0.003557 -7283 1 0.000251 1560.000000 0.003560 -0.000532 0.002638 -7284 1 0.000227 1560.000000 0.000706 0.001921 0.008532 -7285 1 0.000275 1560.000000 -0.001896 0.001812 0.006288 -7286 1 0.000217 1560.000000 0.000171 0.003760 0.009294 -7287 1 0.000250 1560.000000 -0.002244 0.002336 0.003025 -7288 1 0.000194 1560.000000 0.000291 0.002908 0.007618 -7289 1 0.000196 1560.000000 -0.003081 -0.002159 0.005340 -7290 1 0.000192 1560.000000 0.001258 -0.003367 0.003278 -7291 1 0.000204 1560.000000 0.000613 0.002295 0.005667 -7292 1 0.000219 1560.000000 0.001945 -0.000535 0.000434 -7293 1 0.000194 1560.000000 0.003015 -0.000852 0.006445 -7294 1 0.000195 1560.000000 -0.000625 -0.003325 0.002420 -7295 1 0.000213 1560.000000 0.001946 -0.002578 0.004048 -7296 1 0.000262 1560.000000 0.000947 0.001296 0.009271 -7297 1 0.000222 1560.000000 0.002977 0.000383 0.003470 -7298 1 0.000237 1560.000000 -0.000774 0.000903 0.000611 -7299 1 0.000240 1560.000000 0.003718 0.000438 0.000623 -7300 1 0.000262 1560.000000 0.002931 0.002439 0.000714 -7301 1 0.000259 1560.000000 0.000266 -0.001634 0.004207 -7302 1 0.000198 1560.000000 0.001334 -0.001890 0.002109 -7303 1 0.000241 1560.000000 -0.002508 -0.002187 0.006511 -7304 1 0.000228 1560.000000 -0.001282 0.001817 0.008736 -7305 1 0.000251 1560.000000 -0.002625 0.001647 0.002485 -7306 1 0.000196 1560.000000 -0.001337 -0.000498 0.002581 -7307 1 0.000272 1560.000000 0.002390 -0.002760 0.004092 -7308 1 0.000275 1560.000000 -0.002838 0.001494 0.006177 -7309 1 0.000224 1560.000000 0.001333 0.000360 0.003200 -7310 1 0.000250 1560.000000 -0.002838 -0.001986 0.005041 -7311 1 0.000244 1560.000000 0.002720 0.000490 0.009621 -7312 1 0.000238 1560.000000 0.000882 0.002030 0.004417 -7313 1 0.000228 1560.000000 -0.003011 0.001443 0.002511 -7314 1 0.000284 1560.000000 0.001251 -0.001992 0.009787 -7315 1 0.000194 1560.000000 -0.001786 -0.002323 0.004712 -7316 1 0.000261 1560.000000 -0.000309 -0.003046 0.004815 -7317 1 0.000211 1560.000000 -0.001698 -0.000288 0.001913 -7318 1 0.000227 1560.000000 -0.001605 0.000744 0.000959 -7319 1 0.000204 1560.000000 -0.002906 0.002277 0.007946 -7320 1 0.000233 1560.000000 0.000155 -0.000996 0.009644 -7321 1 0.000260 1560.000000 0.002506 0.002250 0.000808 -7322 1 0.000231 1560.000000 -0.001142 -0.002390 0.006334 -7323 1 0.000219 1560.000000 0.000383 0.003626 0.009710 -7324 1 0.000204 1560.000000 0.000906 0.002839 0.007367 -7325 1 0.000195 1560.000000 0.000427 0.002484 0.005890 -7326 1 0.000255 1560.000000 -0.001276 -0.002408 0.009433 -7327 1 0.000246 1560.000000 -0.002162 -0.002260 0.001293 -7328 1 0.000254 1560.000000 -0.000888 -0.002184 0.002893 -7329 1 0.000207 1560.000000 0.002805 -0.000221 0.007565 -7330 1 0.000225 1560.000000 0.001223 -0.000401 0.002456 -7331 1 0.000263 1560.000000 -0.000735 0.002751 0.003645 -7332 1 0.000207 1560.000000 0.000796 0.001125 0.002143 -7333 1 0.000254 1560.000000 -0.000595 0.003045 0.004191 -7334 1 0.000205 1560.000000 0.000635 0.000548 0.009616 -7335 1 0.000226 1560.000000 -0.000821 0.002302 0.001089 -7336 1 0.000200 1560.000000 0.001138 -0.003152 0.009205 -7337 1 0.000195 1560.000000 -0.001539 0.002923 0.002737 -7338 1 0.000197 1560.000000 -0.001913 0.001134 0.001760 -7339 1 0.000225 1560.000000 -0.000839 0.002945 0.003921 -7340 1 0.000276 1560.000000 0.001430 0.001070 0.007394 -7341 1 0.000223 1560.000000 0.001682 0.001401 0.007431 -7342 1 0.000196 1560.000000 -0.000382 -0.000701 0.003492 -7343 1 0.000266 1560.000000 -0.003462 -0.001392 0.001973 -7344 1 0.000239 1560.000000 -0.000614 -0.003169 0.006537 -7345 1 0.000282 1560.000000 -0.002399 -0.002999 0.002525 -7346 1 0.000195 1560.000000 -0.000521 0.003290 0.008182 -7347 1 0.000195 1560.000000 0.000811 0.002499 0.001930 -7348 1 0.000194 1560.000000 -0.001226 -0.002886 0.004411 -7349 1 0.000210 1560.000000 -0.000050 -0.003333 0.000962 -7350 1 0.000232 1560.000000 -0.002940 0.001099 0.001181 -7351 1 0.000214 1560.000000 -0.000902 0.001620 0.001985 -7352 1 0.000218 1560.000000 -0.000573 -0.001829 0.006743 -7353 1 0.000209 1560.000000 0.000370 -0.001768 0.009014 -7354 1 0.000276 1560.000000 -0.001194 0.002782 0.000233 -7355 1 0.000195 1560.000000 -0.000666 0.001016 0.006468 -7356 1 0.000280 1560.000000 -0.000946 0.001248 0.009411 -7357 1 0.000198 1560.000000 -0.001491 -0.002422 0.004401 -7358 1 0.000279 1560.000000 0.000041 -0.003284 0.008928 -7359 1 0.000238 1560.000000 -0.001643 -0.001879 0.003229 -7360 1 0.000236 1560.000000 0.000819 0.000480 0.008415 -7361 1 0.000276 1560.000000 0.003043 0.002129 0.000257 -7362 1 0.000195 1560.000000 -0.001757 0.002077 0.001282 -7363 1 0.000232 1560.000000 0.001791 -0.001716 0.007932 -7364 1 0.000226 1560.000000 0.000169 -0.000349 0.001756 -7365 1 0.000286 1560.000000 0.002236 -0.000775 0.005700 -7366 1 0.000214 1560.000000 -0.000816 -0.001550 0.001648 -7367 1 0.000286 1560.000000 -0.002134 0.002874 0.004959 -7368 1 0.000193 1560.000000 0.000352 0.000016 0.005643 -7369 1 0.000285 1560.000000 -0.000850 -0.003622 0.009768 -7370 1 0.000262 1560.000000 -0.003368 -0.000494 0.009701 -7371 1 0.000194 1560.000000 -0.001719 0.001398 0.004695 -7372 1 0.000241 1560.000000 -0.001501 -0.002330 0.008276 -7373 1 0.000201 1560.000000 0.003323 0.000308 0.006858 -7374 1 0.000233 1560.000000 -0.001042 -0.000126 0.006822 -7375 1 0.000208 1560.000000 -0.001368 -0.002014 0.005783 -7376 1 0.000248 1560.000000 0.002214 0.002129 0.000588 -7377 1 0.000205 1560.000000 0.001803 -0.000352 0.000789 -7378 1 0.000238 1560.000000 0.001280 -0.000327 0.001096 -7379 1 0.000215 1560.000000 -0.002189 0.002885 0.007228 -7380 1 0.000212 1560.000000 0.001364 -0.001735 0.006217 -7381 1 0.000231 1560.000000 -0.003138 0.000175 0.003341 -7382 1 0.000195 1560.000000 0.000619 0.001637 0.004140 -7383 1 0.000214 1560.000000 0.001496 0.003072 0.004945 -7384 1 0.000250 1560.000000 0.000016 -0.002592 0.000964 -7385 1 0.000284 1560.000000 0.000203 -0.002165 0.009354 -7386 1 0.000274 1560.000000 0.002300 0.002813 0.004321 -7387 1 0.000193 1560.000000 -0.000125 0.002019 0.000166 -7388 1 0.000242 1560.000000 0.003422 0.001618 0.006806 -7389 1 0.000215 1560.000000 -0.000119 -0.001535 0.007536 -7390 1 0.000223 1560.000000 -0.000621 -0.001696 0.001662 -7391 1 0.000206 1560.000000 0.000846 -0.000045 0.008282 -7392 1 0.000198 1560.000000 -0.002184 -0.002252 0.005504 -7393 1 0.000228 1560.000000 0.002974 0.000430 0.001222 -7394 1 0.000257 1560.000000 0.001313 -0.002568 0.003564 -7395 1 0.000237 1560.000000 -0.001845 0.000120 0.003362 -7396 1 0.000230 1560.000000 -0.001831 -0.000122 0.000628 -7397 1 0.000207 1560.000000 -0.000492 0.000260 0.008239 -7398 1 0.000202 1560.000000 0.001849 -0.000231 0.003831 -7399 1 0.000235 1560.000000 -0.000146 -0.003708 0.000888 -7400 1 0.000202 1560.000000 -0.000970 0.000093 0.003364 -7401 1 0.000205 1560.000000 -0.003833 0.000082 0.007434 -7402 1 0.000224 1560.000000 0.001066 0.000791 0.007985 -7403 1 0.000193 1560.000000 -0.000041 -0.001208 0.005644 -7404 1 0.000211 1560.000000 0.002374 -0.000797 0.001015 -7405 1 0.000197 1560.000000 0.000454 -0.000103 0.006939 -7406 1 0.000196 1560.000000 0.000041 -0.000963 0.004204 -7407 1 0.000229 1560.000000 -0.001491 -0.000290 0.008345 -7408 1 0.000199 1560.000000 0.002490 -0.001084 0.008250 -7409 1 0.000210 1560.000000 -0.003233 0.000990 0.002949 -7410 1 0.000201 1560.000000 -0.001971 0.001055 0.001255 -7411 1 0.000201 1560.000000 -0.003572 -0.000995 0.005810 -7412 1 0.000222 1560.000000 -0.000110 -0.000886 0.002219 -7413 1 0.000259 1560.000000 0.000128 0.003852 0.001455 -7414 1 0.000198 1560.000000 -0.001832 -0.003103 0.008394 -7415 1 0.000205 1560.000000 0.000865 -0.003211 0.003718 -7416 1 0.000247 1560.000000 -0.000373 -0.001902 0.009826 -7417 1 0.000223 1560.000000 -0.001317 -0.001021 0.004355 -7418 1 0.000207 1560.000000 0.001138 0.003096 0.005424 -7419 1 0.000236 1560.000000 -0.000629 0.003276 0.001009 -7420 1 0.000250 1560.000000 -0.000375 -0.003340 0.001173 -7421 1 0.000213 1560.000000 -0.002564 0.000410 0.005738 -7422 1 0.000198 1560.000000 -0.002775 0.001161 0.009624 -7423 1 0.000284 1560.000000 0.000196 -0.003687 0.008783 -7424 1 0.000284 1560.000000 -0.002491 0.001102 0.000760 -7425 1 0.000210 1560.000000 -0.000523 0.002323 0.002218 -7426 1 0.000210 1560.000000 -0.002576 -0.000955 0.008538 -7427 1 0.000229 1560.000000 0.001714 -0.002915 0.000716 -7428 1 0.000259 1560.000000 -0.002845 0.000899 0.001294 -7429 1 0.000210 1560.000000 0.003121 0.000904 0.009388 -7430 1 0.000213 1560.000000 -0.000534 0.002549 0.005596 -7431 1 0.000259 1560.000000 0.002269 -0.000873 0.005302 -7432 1 0.000201 1560.000000 0.002231 0.000331 0.002428 -7433 1 0.000210 1560.000000 -0.001397 -0.001776 0.000167 -7434 1 0.000257 1560.000000 0.003039 0.001087 0.000181 -7435 1 0.000219 1560.000000 0.000576 -0.003602 0.006717 -7436 1 0.000240 1560.000000 -0.000966 0.002485 0.003572 -7437 1 0.000245 1560.000000 0.000590 0.002481 0.006563 -7438 1 0.000254 1560.000000 0.002788 -0.001924 0.002119 -7439 1 0.000268 1560.000000 0.003714 -0.000920 0.008452 -7440 1 0.000232 1560.000000 -0.000421 0.002105 0.002576 -7441 1 0.000219 1560.000000 0.001454 -0.000754 0.009724 -7442 1 0.000242 1560.000000 0.001083 0.001026 0.007041 -7443 1 0.000277 1560.000000 0.002613 -0.002102 0.001240 -7444 1 0.000228 1560.000000 -0.000662 0.003149 0.005844 -7445 1 0.000208 1560.000000 -0.001090 0.003336 0.004200 -7446 1 0.000234 1560.000000 -0.000194 0.001953 0.007874 -7447 1 0.000250 1560.000000 -0.001941 0.000916 0.005446 -7448 1 0.000209 1560.000000 0.002485 0.001429 0.003658 -7449 1 0.000212 1560.000000 -0.000497 0.000102 0.000962 -7450 1 0.000261 1560.000000 0.000487 -0.003249 0.002292 -7451 1 0.000233 1560.000000 -0.000505 0.000954 0.003489 -7452 1 0.000216 1560.000000 0.001648 0.003434 0.008703 -7453 1 0.000214 1560.000000 -0.001079 -0.001393 0.009359 -7454 1 0.000282 1560.000000 0.000523 0.001190 0.000776 -7455 1 0.000205 1560.000000 -0.001763 0.000390 0.004995 -7456 1 0.000204 1560.000000 -0.002487 -0.002794 0.005058 -7457 1 0.000207 1560.000000 0.000300 -0.003250 0.006012 -7458 1 0.000253 1560.000000 0.002116 0.002783 0.002297 -7459 1 0.000199 1560.000000 0.001853 -0.000880 0.002747 -7460 1 0.000248 1560.000000 0.001186 -0.002173 0.001955 -7461 1 0.000267 1560.000000 0.001070 0.000693 0.006733 -7462 1 0.000215 1560.000000 0.001954 -0.000559 0.005336 -7463 1 0.000199 1560.000000 0.001105 -0.000137 0.002232 -7464 1 0.000202 1560.000000 0.000519 0.000747 0.008868 -7465 1 0.000220 1560.000000 0.002801 -0.000223 0.001447 -7466 1 0.000215 1560.000000 0.001185 -0.001065 0.001744 -7467 1 0.000249 1560.000000 0.003007 -0.002312 0.001122 -7468 1 0.000193 1560.000000 -0.001606 -0.001508 0.007236 -7469 1 0.000235 1560.000000 -0.001384 -0.000163 0.001931 -7470 1 0.000221 1560.000000 -0.000398 -0.003308 0.000128 -7471 1 0.000230 1560.000000 -0.001916 0.002922 0.002856 -7472 1 0.000207 1560.000000 0.001269 0.001432 0.005153 -7473 1 0.000208 1560.000000 -0.000603 0.001829 0.006621 -7474 1 0.000238 1560.000000 0.000704 -0.002133 0.004641 -7475 1 0.000215 1560.000000 -0.001005 0.000616 0.004591 -7476 1 0.000199 1560.000000 -0.002418 -0.000922 0.009533 -7477 1 0.000220 1560.000000 -0.001812 -0.001038 0.000657 -7478 1 0.000229 1560.000000 -0.001456 0.001737 0.009561 -7479 1 0.000222 1560.000000 -0.000620 0.000728 0.003437 -7480 1 0.000207 1560.000000 0.001894 0.002313 0.004779 -7481 1 0.000214 1560.000000 -0.001017 -0.002051 0.006404 -7482 1 0.000236 1560.000000 -0.003617 0.000133 0.004591 -7483 1 0.000194 1560.000000 0.002439 0.000935 0.002488 -7484 1 0.000201 1560.000000 -0.000582 0.000192 0.001823 -7485 1 0.000285 1560.000000 0.001541 -0.000592 0.000594 -7486 1 0.000263 1560.000000 -0.000824 0.003454 0.008312 -7487 1 0.000251 1560.000000 0.003448 -0.000854 0.004313 -7488 1 0.000239 1560.000000 -0.001539 -0.001892 0.004479 -7489 1 0.000232 1560.000000 0.001549 -0.002787 0.004706 -7490 1 0.000233 1560.000000 0.000492 0.000819 0.008162 -7491 1 0.000273 1560.000000 -0.003077 -0.001500 0.006952 -7492 1 0.000217 1560.000000 0.002350 0.001046 0.001704 -7493 1 0.000234 1560.000000 -0.001890 -0.002862 0.002003 -7494 1 0.000222 1560.000000 0.001033 0.002751 0.001007 -7495 1 0.000199 1560.000000 0.003748 -0.000238 0.009720 -7496 1 0.000219 1560.000000 0.001628 0.001455 0.000564 -7497 1 0.000268 1560.000000 0.000872 -0.002244 0.007164 -7498 1 0.000238 1560.000000 -0.000156 0.003763 0.000881 -7499 1 0.000227 1560.000000 -0.000826 0.000723 0.003272 -7500 1 0.000197 1560.000000 0.001592 0.000805 0.008573 -7501 1 0.000246 1560.000000 0.002383 0.000150 0.006867 -7502 1 0.000232 1560.000000 0.003641 -0.000916 0.005769 -7503 1 0.000254 1560.000000 0.000510 -0.001917 0.007826 -7504 1 0.000262 1560.000000 -0.002518 -0.001615 0.006101 -7505 1 0.000197 1560.000000 0.000849 -0.001907 0.001527 -7506 1 0.000261 1560.000000 -0.000862 0.000580 0.003655 -7507 1 0.000220 1560.000000 -0.000441 -0.003597 0.002358 -7508 1 0.000214 1560.000000 0.001919 0.001346 0.002391 -7509 1 0.000196 1560.000000 -0.001670 0.000082 0.006310 -7510 1 0.000203 1560.000000 -0.003078 0.000159 0.003082 -7511 1 0.000193 1560.000000 0.001444 0.000196 0.009748 -7512 1 0.000208 1560.000000 0.001905 -0.002112 0.005538 -7513 1 0.000260 1560.000000 0.001251 0.002481 0.005719 -7514 1 0.000269 1560.000000 0.003432 0.001738 0.009769 -7515 1 0.000248 1560.000000 0.000232 0.002042 0.000581 -7516 1 0.000237 1560.000000 -0.003371 -0.001506 0.004523 -7517 1 0.000271 1560.000000 -0.001129 -0.002407 0.008079 -7518 1 0.000242 1560.000000 0.002797 0.001720 0.004402 -7519 1 0.000286 1560.000000 0.000797 -0.002569 0.009211 -7520 1 0.000207 1560.000000 -0.001679 0.000612 0.005403 -7521 1 0.000248 1560.000000 -0.000842 -0.002605 0.009452 -7522 1 0.000193 1560.000000 -0.000741 0.001586 0.006553 -7523 1 0.000246 1560.000000 -0.001926 -0.001688 0.007494 -7524 1 0.000198 1560.000000 -0.000633 0.001866 0.004640 -7525 1 0.000213 1560.000000 -0.001343 0.002929 0.004522 -7526 1 0.000281 1560.000000 0.000009 -0.000773 0.004591 -7527 1 0.000236 1560.000000 -0.001835 -0.003155 0.007175 -7528 1 0.000203 1560.000000 0.001401 0.000058 0.005259 -7529 1 0.000244 1560.000000 0.001900 -0.001805 0.003565 -7530 1 0.000208 1560.000000 0.000511 -0.000889 0.007394 -7531 1 0.000227 1560.000000 0.002955 0.000185 0.007268 -7532 1 0.000231 1560.000000 -0.000593 -0.001302 0.007490 -7533 1 0.000276 1560.000000 0.001089 0.001535 0.003897 -7534 1 0.000235 1560.000000 -0.002214 0.000171 0.005473 -7535 1 0.000250 1560.000000 0.000840 0.003106 0.007284 -7536 1 0.000217 1560.000000 -0.002503 -0.000751 0.002784 -7537 1 0.000229 1560.000000 0.000941 -0.001437 0.005305 -7538 1 0.000195 1560.000000 -0.002880 -0.001363 0.008123 -7539 1 0.000193 1560.000000 -0.001527 0.000718 0.000419 -7540 1 0.000214 1560.000000 0.002695 0.000101 0.008151 -7541 1 0.000210 1560.000000 -0.002230 -0.000615 0.007686 -7542 1 0.000202 1560.000000 -0.000651 0.000468 0.007761 -7543 1 0.000199 1560.000000 -0.000613 -0.003647 0.009231 -7544 1 0.000194 1560.000000 -0.001049 0.003326 0.000393 -7545 1 0.000242 1560.000000 0.001124 -0.000979 0.007666 -7546 1 0.000214 1560.000000 -0.000766 0.001506 0.007575 -7547 1 0.000247 1560.000000 0.000298 0.000340 0.001377 -7548 1 0.000262 1560.000000 0.001972 0.001627 0.002759 -7549 1 0.000236 1560.000000 -0.000746 -0.000106 0.007681 -7550 1 0.000247 1560.000000 0.000964 -0.001575 0.006168 -7551 1 0.000216 1560.000000 -0.003338 -0.000127 0.004084 -7552 1 0.000213 1560.000000 -0.000143 0.002660 0.000192 -7553 1 0.000218 1560.000000 0.000674 -0.001125 0.009573 -7554 1 0.000245 1560.000000 0.001476 0.001328 0.003292 -7555 1 0.000282 1560.000000 -0.002086 -0.002154 0.004388 -7556 1 0.000244 1560.000000 -0.001570 0.000539 0.009168 -7557 1 0.000241 1560.000000 0.002161 -0.001487 0.000296 -7558 1 0.000220 1560.000000 -0.000528 0.000460 0.000290 -7559 1 0.000196 1560.000000 0.000136 -0.003196 0.006322 -7560 1 0.000249 1560.000000 -0.000779 0.001822 0.005678 -7561 1 0.000239 1560.000000 -0.000011 -0.000922 0.008338 -7562 1 0.000232 1560.000000 -0.002133 0.001013 0.009752 -7563 1 0.000224 1560.000000 0.002102 0.002563 0.008650 -7564 1 0.000220 1560.000000 0.001562 0.000217 0.005677 -7565 1 0.000266 1560.000000 0.001823 -0.001378 0.007998 -7566 1 0.000220 1560.000000 -0.001116 0.002500 0.001335 -7567 1 0.000226 1560.000000 -0.000454 -0.000971 0.005223 -7568 1 0.000222 1560.000000 0.000430 0.002153 0.006536 -7569 1 0.000262 1560.000000 0.000786 -0.001553 0.007919 -7570 1 0.000210 1560.000000 0.002743 0.002584 0.006982 -7571 1 0.000221 1560.000000 -0.002248 -0.000569 0.000847 -7572 1 0.000193 1560.000000 -0.002780 -0.002418 0.003144 -7573 1 0.000232 1560.000000 -0.000429 0.000703 0.002970 -7574 1 0.000259 1560.000000 0.001840 -0.001279 0.003606 -7575 1 0.000248 1560.000000 -0.000427 -0.000068 0.000682 -7576 1 0.000213 1560.000000 0.003118 0.002163 0.004699 -7577 1 0.000231 1560.000000 0.001136 -0.002625 0.006181 -7578 1 0.000206 1560.000000 0.002075 -0.002486 0.004354 -7579 1 0.000209 1560.000000 0.000314 -0.000705 0.001580 -7580 1 0.000207 1560.000000 0.000645 -0.001486 0.007706 -7581 1 0.000196 1560.000000 -0.001564 -0.002026 0.002810 -7582 1 0.000256 1560.000000 0.001109 0.002040 0.006153 -7583 1 0.000217 1560.000000 0.003026 -0.001428 0.000256 -7584 1 0.000236 1560.000000 0.001275 0.002731 0.008493 -7585 1 0.000245 1560.000000 0.002192 -0.001816 0.003063 -7586 1 0.000250 1560.000000 -0.001908 0.002209 0.006761 -7587 1 0.000242 1560.000000 0.003279 0.000114 0.001924 -7588 1 0.000207 1560.000000 -0.000230 -0.001840 0.006134 -7589 1 0.000270 1560.000000 0.002587 -0.001325 0.009023 -7590 1 0.000236 1560.000000 -0.001126 -0.002190 0.001376 -7591 1 0.000260 1560.000000 0.000638 -0.002686 0.007452 -7592 1 0.000194 1560.000000 0.001931 0.002108 0.006480 -7593 1 0.000281 1560.000000 0.002183 -0.001408 0.007192 -7594 1 0.000250 1560.000000 0.000332 -0.000410 0.000737 -7595 1 0.000262 1560.000000 0.001355 -0.000609 0.002339 -7596 1 0.000235 1560.000000 0.001685 -0.002454 0.000566 -7597 1 0.000198 1560.000000 0.000274 0.003020 0.002154 -7598 1 0.000273 1560.000000 -0.002620 -0.001227 0.005036 -7599 1 0.000251 1560.000000 0.000293 -0.003039 0.001001 -7600 1 0.000232 1560.000000 0.000644 0.002505 0.006815 -7601 1 0.000243 1560.000000 -0.000185 -0.000411 0.001568 -7602 1 0.000202 1560.000000 0.002046 -0.001857 0.008770 -7603 1 0.000218 1560.000000 0.001627 0.002831 0.006653 -7604 1 0.000268 1560.000000 -0.003392 0.001707 0.001434 -7605 1 0.000203 1560.000000 -0.000786 -0.001039 0.002343 -7606 1 0.000274 1560.000000 0.003333 -0.001605 0.005053 -7607 1 0.000220 1560.000000 0.002745 0.002275 0.008669 -7608 1 0.000240 1560.000000 0.002044 0.001542 0.004003 -7609 1 0.000235 1560.000000 -0.003446 -0.000630 0.006720 -7610 1 0.000212 1560.000000 0.000130 0.002161 0.008525 -7611 1 0.000280 1560.000000 0.002829 0.000942 0.006846 -7612 1 0.000224 1560.000000 -0.001749 -0.001456 0.003072 -7613 1 0.000237 1560.000000 -0.001410 0.002614 0.008351 -7614 1 0.000250 1560.000000 0.001235 -0.000570 0.006989 -7615 1 0.000215 1560.000000 0.001443 -0.001465 0.006363 -7616 1 0.000225 1560.000000 0.000231 0.000681 0.004959 -7617 1 0.000253 1560.000000 0.003043 0.001194 0.009151 -7618 1 0.000233 1560.000000 0.001806 0.001701 0.000701 -7619 1 0.000257 1560.000000 -0.003227 0.001640 0.006410 -7620 1 0.000215 1560.000000 -0.001168 -0.002614 0.001485 -7621 1 0.000238 1560.000000 -0.001055 0.002137 0.002352 -7622 1 0.000194 1560.000000 -0.001912 0.000827 0.002018 -7623 1 0.000245 1560.000000 0.001462 0.000049 0.008630 -7624 1 0.000214 1560.000000 -0.000717 -0.002349 0.001190 -7625 1 0.000219 1560.000000 -0.001517 0.000666 0.000737 -7626 1 0.000226 1560.000000 0.000361 0.000511 0.006742 -7627 1 0.000214 1560.000000 -0.000660 0.000959 0.004796 -7628 1 0.000288 1560.000000 0.001827 -0.002304 0.004015 -7629 1 0.000215 1560.000000 -0.000867 -0.003673 0.008110 -7630 1 0.000258 1560.000000 -0.003594 -0.001058 0.003679 -7631 1 0.000206 1560.000000 0.000889 0.000423 0.002864 -7632 1 0.000277 1560.000000 0.000820 0.001417 0.006956 -7633 1 0.000239 1560.000000 0.002533 -0.002584 0.009811 -7634 1 0.000218 1560.000000 0.001498 0.000942 0.000410 -7635 1 0.000206 1560.000000 -0.001212 0.001685 0.008991 -7636 1 0.000269 1560.000000 0.000808 0.003215 0.002071 -7637 1 0.000258 1560.000000 -0.001308 -0.001546 0.004234 -7638 1 0.000201 1560.000000 0.001195 -0.001397 0.003911 -7639 1 0.000200 1560.000000 0.003151 0.001505 0.008306 -7640 1 0.000220 1560.000000 0.002244 0.000991 0.002420 -7641 1 0.000203 1560.000000 -0.002942 -0.001002 0.003499 -7642 1 0.000250 1560.000000 -0.001575 0.000858 0.005926 -7643 1 0.000214 1560.000000 0.003142 -0.000740 0.008993 -7644 1 0.000288 1560.000000 0.002062 0.000665 0.007354 -7645 1 0.000239 1560.000000 0.000974 0.000987 0.005796 -7646 1 0.000200 1560.000000 0.000216 0.001216 0.009665 -7647 1 0.000270 1560.000000 0.000598 -0.002644 0.003722 -7648 1 0.000233 1560.000000 -0.000136 0.001607 0.009429 -7649 1 0.000288 1560.000000 -0.002160 -0.003144 0.001404 -7650 1 0.000254 1560.000000 0.002612 0.000956 0.008542 -7651 1 0.000204 1560.000000 0.003259 0.000970 0.005575 -7652 1 0.000250 1560.000000 0.002620 -0.002384 0.008471 -7653 1 0.000222 1560.000000 0.000965 0.001921 0.002468 -7654 1 0.000202 1560.000000 -0.001378 0.001137 0.009777 -7655 1 0.000218 1560.000000 -0.000492 0.000978 0.006653 -7656 1 0.000225 1560.000000 0.002489 -0.002927 0.008933 -7657 1 0.000211 1560.000000 0.001281 -0.002276 0.003500 -7658 1 0.000196 1560.000000 -0.001862 0.001077 0.006132 -7659 1 0.000219 1560.000000 0.001387 -0.000011 0.003366 -7660 1 0.000212 1560.000000 -0.002374 -0.001602 0.006504 -7661 1 0.000227 1560.000000 0.000911 -0.000709 0.000268 -7662 1 0.000270 1560.000000 0.002039 -0.002288 0.006305 -7663 1 0.000200 1560.000000 0.000852 -0.003348 0.006199 -7664 1 0.000246 1560.000000 -0.002973 0.002358 0.008335 -7665 1 0.000211 1560.000000 -0.001155 0.002017 0.006912 -7666 1 0.000205 1560.000000 -0.000975 0.002948 0.001781 -7667 1 0.000195 1560.000000 -0.002718 0.001750 0.006417 -7668 1 0.000266 1560.000000 0.002967 -0.002185 0.003032 -7669 1 0.000209 1560.000000 -0.000686 0.002386 0.000522 -7670 1 0.000208 1560.000000 -0.001952 0.001990 0.009416 -7671 1 0.000225 1560.000000 0.002359 0.002244 0.009633 -7672 1 0.000277 1560.000000 -0.000804 -0.001270 0.005729 -7673 1 0.000232 1560.000000 0.002160 -0.001521 0.009203 -7674 1 0.000250 1560.000000 -0.000385 -0.001077 0.008620 -7675 1 0.000233 1560.000000 0.000747 -0.002353 0.006253 -7676 1 0.000222 1560.000000 0.001807 0.000011 0.006764 -7677 1 0.000215 1560.000000 -0.001460 0.000738 0.004548 -7678 1 0.000204 1560.000000 0.000221 0.002613 0.006746 -7679 1 0.000265 1560.000000 -0.003489 -0.000161 0.004484 -7680 1 0.000210 1560.000000 -0.001542 0.003205 0.006109 -7681 1 0.000237 1560.000000 -0.001242 -0.001529 0.003287 -7682 1 0.000208 1560.000000 -0.000813 0.001140 0.000974 -7683 1 0.000234 1560.000000 0.000616 -0.001343 0.007399 -7684 1 0.000226 1560.000000 0.002187 -0.000993 0.009023 -7685 1 0.000247 1560.000000 -0.000627 -0.001479 0.006965 -7686 1 0.000256 1560.000000 0.000451 0.003802 0.002996 -7687 1 0.000261 1560.000000 0.001802 -0.001789 0.006862 -7688 1 0.000276 1560.000000 0.001172 0.001919 0.006770 -7689 1 0.000234 1560.000000 -0.000799 -0.001602 0.000752 -7690 1 0.000223 1560.000000 -0.000351 -0.000538 0.000155 -7691 1 0.000222 1560.000000 -0.000071 0.003169 0.001796 -7692 1 0.000197 1560.000000 -0.001191 -0.001516 0.005572 -7693 1 0.000270 1560.000000 0.001598 -0.001966 0.003732 -7694 1 0.000226 1560.000000 -0.003104 -0.000337 0.009750 -7695 1 0.000202 1560.000000 -0.002148 0.001538 0.007529 -7696 1 0.000200 1560.000000 0.000161 0.003585 0.003720 -7697 1 0.000216 1560.000000 -0.002588 -0.001137 0.000628 -7698 1 0.000248 1560.000000 0.002122 -0.000077 0.004936 -7699 1 0.000233 1560.000000 -0.001736 0.000368 0.004536 -7700 1 0.000275 1560.000000 0.001363 0.003100 0.007185 -7701 1 0.000252 1560.000000 0.003165 0.000588 0.007391 -7702 1 0.000272 1560.000000 -0.002338 -0.002156 0.008288 -7703 1 0.000201 1560.000000 -0.000243 0.002785 0.009725 -7704 1 0.000201 1560.000000 -0.001401 -0.000385 0.003941 -7705 1 0.000274 1560.000000 -0.000334 0.002930 0.004049 -7706 1 0.000196 1560.000000 0.003000 -0.002087 0.001697 -7707 1 0.000210 1560.000000 0.001217 0.001226 0.001376 -7708 1 0.000235 1560.000000 -0.002856 0.002094 0.005250 -7709 1 0.000209 1560.000000 -0.001702 -0.001335 0.002809 -7710 1 0.000218 1560.000000 -0.000446 -0.001767 0.006409 -7711 1 0.000228 1560.000000 -0.001584 -0.002268 0.002966 -7712 1 0.000216 1560.000000 0.002602 -0.001323 0.009432 -7713 1 0.000215 1560.000000 0.000100 -0.000465 0.006047 -7714 1 0.000200 1560.000000 -0.000558 0.001210 0.009774 -7715 1 0.000199 1560.000000 0.002673 -0.000103 0.005003 -7716 1 0.000235 1560.000000 0.000260 0.001613 0.008423 -7717 1 0.000202 1560.000000 0.002162 0.002991 0.001156 -7718 1 0.000196 1560.000000 -0.001236 0.003541 0.004224 -7719 1 0.000218 1560.000000 -0.001836 -0.000523 0.006190 -7720 1 0.000219 1560.000000 0.001916 0.003250 0.004695 -7721 1 0.000220 1560.000000 -0.002118 0.000690 0.000686 -7722 1 0.000248 1560.000000 0.002205 -0.000106 0.004498 -7723 1 0.000246 1560.000000 -0.002964 -0.001642 0.002299 -7724 1 0.000215 1560.000000 0.000722 -0.001338 0.008513 -7725 1 0.000252 1560.000000 -0.003024 0.001042 0.006879 -7726 1 0.000208 1560.000000 -0.001251 0.001841 0.009255 -7727 1 0.000192 1560.000000 -0.002794 0.001618 0.006601 -7728 1 0.000252 1560.000000 -0.000456 -0.003654 0.000508 -7729 1 0.000215 1560.000000 0.003484 -0.001052 0.007271 -7730 1 0.000243 1560.000000 0.002467 0.001726 0.008951 -7731 1 0.000207 1560.000000 -0.000417 -0.001690 0.009581 -7732 1 0.000244 1560.000000 -0.000883 -0.003512 0.006342 -7733 1 0.000207 1560.000000 0.002358 -0.000915 0.006724 -7734 1 0.000257 1560.000000 -0.000070 -0.002526 0.007845 -7735 1 0.000214 1560.000000 0.003444 0.001132 0.002451 -7736 1 0.000280 1560.000000 -0.001426 -0.001044 0.003233 -7737 1 0.000234 1560.000000 -0.003190 0.000718 0.001420 -7738 1 0.000266 1560.000000 -0.001810 -0.000380 0.008135 -7739 1 0.000259 1560.000000 0.002116 0.002369 0.003949 -7740 1 0.000251 1560.000000 -0.002670 -0.002776 0.004149 -7741 1 0.000233 1560.000000 -0.002922 0.000938 0.004131 -7742 1 0.000234 1560.000000 -0.001173 -0.003049 0.009229 -7743 1 0.000194 1560.000000 0.002757 0.000324 0.008753 -7744 1 0.000228 1560.000000 0.000326 -0.002885 0.000583 -7745 1 0.000253 1560.000000 0.001142 0.001667 0.009580 -7746 1 0.000276 1560.000000 -0.002553 0.002826 0.000439 -7747 1 0.000270 1560.000000 0.000352 0.002772 0.000963 -7748 1 0.000279 1560.000000 -0.002052 -0.001330 0.005437 -7749 1 0.000254 1560.000000 0.001227 0.003637 0.008878 -7750 1 0.000221 1560.000000 0.003340 0.001034 0.006576 -7751 1 0.000201 1560.000000 -0.000690 0.000047 0.001279 -7752 1 0.000240 1560.000000 -0.000193 0.003824 0.007286 -7753 1 0.000249 1560.000000 0.000385 0.002054 0.009222 -7754 1 0.000243 1560.000000 -0.000502 0.000997 0.009811 -7755 1 0.000239 1560.000000 -0.002892 -0.000461 0.004934 -7756 1 0.000227 1560.000000 -0.000999 -0.002799 0.002657 -7757 1 0.000219 1560.000000 -0.002030 0.001319 0.001660 -7758 1 0.000274 1560.000000 0.000384 0.000867 0.007615 -7759 1 0.000206 1560.000000 -0.001068 0.002721 0.007718 -7760 1 0.000238 1560.000000 0.001398 0.003380 0.008648 -7761 1 0.000239 1560.000000 -0.000206 -0.001194 0.003290 -7762 1 0.000198 1560.000000 -0.002610 -0.001559 0.000117 -7763 1 0.000195 1560.000000 -0.001173 0.000679 0.009566 -7764 1 0.000192 1560.000000 -0.002323 0.002996 0.008249 -7765 1 0.000214 1560.000000 0.002723 -0.002018 0.009240 -7766 1 0.000264 1560.000000 -0.001109 -0.001773 0.001529 -7767 1 0.000288 1560.000000 0.002529 -0.000302 0.000187 -7768 1 0.000199 1560.000000 0.001950 -0.002039 0.004143 -7769 1 0.000222 1560.000000 -0.000558 0.000396 0.005714 -7770 1 0.000203 1560.000000 0.001090 -0.003430 0.007765 -7771 1 0.000278 1560.000000 -0.001721 -0.000630 0.006920 -7772 1 0.000250 1560.000000 -0.002772 -0.001031 0.001927 -7773 1 0.000234 1560.000000 -0.000779 -0.000437 0.009391 -7774 1 0.000270 1560.000000 -0.001289 -0.001999 0.008397 -7775 1 0.000226 1560.000000 0.000522 -0.003603 0.003731 -7776 1 0.000278 1560.000000 0.003665 0.001029 0.005311 -7777 1 0.000272 1560.000000 -0.002348 0.000084 0.003046 -7778 1 0.000208 1560.000000 -0.003793 -0.000205 0.007433 -7779 1 0.000278 1560.000000 -0.000808 0.003328 0.002321 -7780 1 0.000237 1560.000000 0.003354 0.000839 0.004235 -7781 1 0.000194 1560.000000 0.001703 -0.000049 0.004968 -7782 1 0.000241 1560.000000 -0.001786 -0.002463 0.001390 -7783 1 0.000244 1560.000000 -0.002735 0.000731 0.000595 -7784 1 0.000195 1560.000000 -0.001278 -0.000885 0.006066 -7785 1 0.000250 1560.000000 -0.001639 -0.000013 0.002188 -7786 1 0.000247 1560.000000 0.001743 0.002659 0.009770 -7787 1 0.000238 1560.000000 0.000434 0.000316 0.008116 -7788 1 0.000219 1560.000000 0.002990 -0.002277 0.001995 -7789 1 0.000211 1560.000000 0.001942 0.001089 0.002681 -7790 1 0.000234 1560.000000 0.000854 -0.000146 0.006654 -7791 1 0.000194 1560.000000 0.001701 0.000839 0.006463 -7792 1 0.000231 1560.000000 0.002206 0.000324 0.004863 -7793 1 0.000240 1560.000000 0.000266 0.001344 0.001903 -7794 1 0.000205 1560.000000 -0.000040 0.002027 0.001487 -7795 1 0.000241 1560.000000 -0.000264 -0.003374 0.008952 -7796 1 0.000260 1560.000000 -0.002517 -0.002906 0.007875 -7797 1 0.000193 1560.000000 -0.001592 -0.002784 0.005013 -7798 1 0.000263 1560.000000 -0.002708 0.000650 0.004228 -7799 1 0.000192 1560.000000 0.002337 -0.000170 0.006167 -7800 1 0.000233 1560.000000 0.000634 -0.003423 0.006083 -7801 1 0.000259 1560.000000 0.001143 0.002061 0.005532 -7802 1 0.000195 1560.000000 0.000863 -0.000324 0.004603 -7803 1 0.000280 1560.000000 0.001124 0.001654 0.005525 -7804 1 0.000211 1560.000000 -0.000624 0.002573 0.001062 -7805 1 0.000233 1560.000000 -0.001503 -0.000139 0.007911 -7806 1 0.000194 1560.000000 -0.000944 0.001321 0.004618 -7807 1 0.000196 1560.000000 -0.000928 -0.002671 0.006164 -7808 1 0.000277 1560.000000 0.001231 0.002353 0.003785 -7809 1 0.000234 1560.000000 0.002810 -0.001254 0.007940 -7810 1 0.000218 1560.000000 -0.002421 -0.001743 0.001262 -7811 1 0.000268 1560.000000 -0.002716 -0.001934 0.000422 -7812 1 0.000226 1560.000000 -0.000064 -0.001593 0.008163 -7813 1 0.000283 1560.000000 -0.000274 0.001987 0.008211 -7814 1 0.000218 1560.000000 0.000620 -0.001031 0.003304 -7815 1 0.000212 1560.000000 -0.003657 0.000817 0.009392 -7816 1 0.000283 1560.000000 0.003715 0.000329 0.002952 -7817 1 0.000194 1560.000000 0.000551 0.002495 0.007865 -7818 1 0.000194 1560.000000 0.000181 -0.001018 0.000236 -7819 1 0.000195 1560.000000 -0.001261 -0.001975 0.005605 -7820 1 0.000199 1560.000000 0.000057 -0.002333 0.004934 -7821 1 0.000218 1560.000000 0.001302 0.001004 0.001530 -7822 1 0.000286 1560.000000 -0.003048 0.000305 0.009695 -7823 1 0.000259 1560.000000 -0.002214 -0.001208 0.006068 -7824 1 0.000211 1560.000000 -0.000752 0.002715 0.005608 -7825 1 0.000275 1560.000000 0.000607 -0.000449 0.009568 -7826 1 0.000245 1560.000000 -0.001193 -0.002156 0.008835 -7827 1 0.000215 1560.000000 -0.000082 -0.001747 0.001944 -7828 1 0.000281 1560.000000 0.002369 -0.002294 0.004512 -7829 1 0.000255 1560.000000 0.000194 0.002206 0.006592 -7830 1 0.000241 1560.000000 0.001955 -0.001864 0.008038 -7831 1 0.000226 1560.000000 0.001644 0.000815 0.009104 -7832 1 0.000215 1560.000000 -0.002175 0.000903 0.008387 -7833 1 0.000232 1560.000000 0.001470 0.000530 0.008118 -7834 1 0.000203 1560.000000 0.001097 0.002502 0.004659 -7835 1 0.000194 1560.000000 -0.002077 -0.002342 0.008446 -7836 1 0.000251 1560.000000 0.000817 -0.003357 0.007745 -7837 1 0.000261 1560.000000 0.000191 0.000124 0.000207 -7838 1 0.000201 1560.000000 -0.000359 0.001761 0.004752 -7839 1 0.000243 1560.000000 -0.001633 -0.000888 0.006085 -7840 1 0.000243 1560.000000 -0.001029 -0.003457 0.001876 -7841 1 0.000237 1560.000000 -0.003189 -0.000849 0.001389 -7842 1 0.000209 1560.000000 -0.002076 0.000664 0.008254 -7843 1 0.000223 1560.000000 -0.002068 0.000666 0.005624 -7844 1 0.000236 1560.000000 0.000409 0.002164 0.005560 -7845 1 0.000223 1560.000000 -0.001820 -0.001211 0.009690 -7846 1 0.000250 1560.000000 0.002630 -0.002739 0.001437 -7847 1 0.000192 1560.000000 0.003112 -0.001528 0.004440 -7848 1 0.000284 1560.000000 0.001414 -0.003574 0.004323 -7849 1 0.000217 1560.000000 0.000704 0.001263 0.009100 -7850 1 0.000240 1560.000000 0.000829 -0.003531 0.001593 -7851 1 0.000199 1560.000000 0.000187 -0.000200 0.006001 -7852 1 0.000240 1560.000000 0.002932 -0.000700 0.008081 -7853 1 0.000197 1560.000000 -0.002590 0.000479 0.006719 -7854 1 0.000217 1560.000000 -0.000372 0.002923 0.006035 -7855 1 0.000267 1560.000000 -0.001333 -0.003562 0.002762 -7856 1 0.000220 1560.000000 0.001216 -0.001556 0.005678 -7857 1 0.000202 1560.000000 -0.000619 -0.003664 0.002225 -7858 1 0.000234 1560.000000 0.000208 0.001850 0.004184 -7859 1 0.000240 1560.000000 0.001839 0.001596 0.003663 -7860 1 0.000216 1560.000000 0.002460 -0.001054 0.003303 -7861 1 0.000266 1560.000000 -0.003237 0.001023 0.007415 -7862 1 0.000230 1560.000000 -0.001305 0.000368 0.005591 -7863 1 0.000206 1560.000000 -0.002831 -0.002473 0.000872 -7864 1 0.000228 1560.000000 -0.000579 0.001143 0.003612 -7865 1 0.000203 1560.000000 0.002249 -0.001998 0.002630 -7866 1 0.000197 1560.000000 0.000522 0.003653 0.000782 -7867 1 0.000206 1560.000000 -0.000873 0.001345 0.009042 -7868 1 0.000255 1560.000000 0.001828 -0.003306 0.005215 -7869 1 0.000260 1560.000000 0.002414 0.000881 0.003082 -7870 1 0.000211 1560.000000 0.003014 0.001095 0.008874 -7871 1 0.000276 1560.000000 0.001676 -0.002349 0.002559 -7872 1 0.000229 1560.000000 -0.001542 -0.002103 0.001343 -7873 1 0.000223 1560.000000 0.000039 -0.002748 0.009466 -7874 1 0.000232 1560.000000 -0.002661 0.002490 0.005342 -7875 1 0.000275 1560.000000 -0.000387 0.003723 0.003068 -7876 1 0.000192 1560.000000 0.001300 0.001353 0.002761 -7877 1 0.000193 1560.000000 0.000468 0.001425 0.009229 -7878 1 0.000204 1560.000000 0.001076 0.001275 0.008259 -7879 1 0.000208 1560.000000 -0.001257 -0.001900 0.004880 -7880 1 0.000213 1560.000000 -0.002784 0.002588 0.003948 -7881 1 0.000275 1560.000000 0.001532 0.002439 0.005458 -7882 1 0.000233 1560.000000 0.000369 -0.002094 0.007039 -7883 1 0.000201 1560.000000 0.001142 -0.003236 0.008115 -7884 1 0.000198 1560.000000 -0.000857 0.000179 0.000706 -7885 1 0.000222 1560.000000 0.002565 -0.000517 0.008519 -7886 1 0.000234 1560.000000 -0.002917 -0.002297 0.002856 -7887 1 0.000243 1560.000000 -0.000715 -0.002083 0.004936 -7888 1 0.000227 1560.000000 -0.001102 -0.000569 0.000649 -7889 1 0.000232 1560.000000 0.001064 -0.000101 0.001899 -7890 1 0.000238 1560.000000 0.002173 -0.000291 0.003003 -7891 1 0.000286 1560.000000 -0.001021 -0.003417 0.005950 -7892 1 0.000242 1560.000000 -0.000975 -0.002848 0.003008 -7893 1 0.000245 1560.000000 -0.002590 -0.001134 0.003802 -7894 1 0.000253 1560.000000 0.001840 0.003202 0.008705 -7895 1 0.000200 1560.000000 -0.002123 0.002654 0.005949 -7896 1 0.000279 1560.000000 -0.000947 -0.002333 0.006158 -7897 1 0.000207 1560.000000 -0.000111 0.002073 0.007152 -7898 1 0.000219 1560.000000 -0.001284 0.000503 0.003565 -7899 1 0.000197 1560.000000 0.000483 -0.000411 0.003109 -7900 1 0.000216 1560.000000 -0.002876 0.000972 0.004802 -7901 1 0.000258 1560.000000 0.001562 0.001057 0.003135 -7902 1 0.000249 1560.000000 -0.001378 -0.002982 0.006011 -7903 1 0.000217 1560.000000 0.001766 0.001744 0.001402 -7904 1 0.000205 1560.000000 0.001143 0.003186 0.001963 -7905 1 0.000220 1560.000000 0.002664 0.002005 0.006771 -7906 1 0.000266 1560.000000 -0.002783 -0.000135 0.006932 -7907 1 0.000203 1560.000000 -0.000224 0.002208 0.001558 -7908 1 0.000263 1560.000000 -0.001286 -0.003221 0.007008 -7909 1 0.000286 1560.000000 -0.000642 -0.000695 0.002893 -7910 1 0.000238 1560.000000 0.000554 -0.002808 0.006761 -7911 1 0.000197 1560.000000 0.001016 0.000389 0.005098 -7912 1 0.000249 1560.000000 0.003039 -0.002161 0.000276 -7913 1 0.000198 1560.000000 -0.002151 -0.000018 0.007553 -7914 1 0.000231 1560.000000 -0.000784 -0.000907 0.003476 -7915 1 0.000248 1560.000000 0.001850 -0.003224 0.007713 -7916 1 0.000207 1560.000000 -0.001770 0.002545 0.000274 -7917 1 0.000213 1560.000000 0.000297 0.002544 0.007464 -7918 1 0.000195 1560.000000 -0.003483 0.000382 0.004571 -7919 1 0.000201 1560.000000 -0.002346 0.002676 0.000419 -7920 1 0.000211 1560.000000 0.001172 0.002372 0.000125 -7921 1 0.000210 1560.000000 0.000464 -0.000861 0.006602 -7922 1 0.000223 1560.000000 0.001854 -0.002646 0.005375 -7923 1 0.000237 1560.000000 -0.000912 0.003459 0.007181 -7924 1 0.000229 1560.000000 0.001888 -0.000791 0.008787 -7925 1 0.000217 1560.000000 -0.003491 -0.000992 0.006798 -7926 1 0.000221 1560.000000 0.000716 -0.000162 0.000175 -7927 1 0.000219 1560.000000 0.003680 -0.000264 0.006367 -7928 1 0.000240 1560.000000 0.000647 -0.003590 0.009667 -7929 1 0.000253 1560.000000 0.000049 -0.001421 0.005344 -7930 1 0.000264 1560.000000 0.000901 -0.003309 0.002343 -7931 1 0.000209 1560.000000 -0.001866 0.000816 0.009451 -7932 1 0.000259 1560.000000 -0.002526 0.001904 0.008477 -7933 1 0.000268 1560.000000 0.001038 -0.002642 0.007416 -7934 1 0.000269 1560.000000 0.002377 -0.000458 0.007921 -7935 1 0.000282 1560.000000 -0.002801 0.001523 0.007498 -7936 1 0.000275 1560.000000 0.000892 0.001087 0.007621 -7937 1 0.000232 1560.000000 -0.000397 0.003367 0.000376 -7938 1 0.000207 1560.000000 -0.000670 0.003239 0.003040 -7939 1 0.000206 1560.000000 -0.002294 -0.000661 0.009405 -7940 1 0.000218 1560.000000 0.001500 -0.002641 0.008015 -7941 1 0.000273 1560.000000 -0.002366 0.001722 0.003502 -7942 1 0.000253 1560.000000 0.003309 -0.000346 0.003905 -7943 1 0.000242 1560.000000 0.000850 -0.003245 0.005021 -7944 1 0.000231 1560.000000 0.000812 0.001194 0.002656 -7945 1 0.000200 1560.000000 -0.000333 -0.002247 0.004238 -7946 1 0.000244 1560.000000 0.000224 0.001761 0.002957 -7947 1 0.000287 1560.000000 0.002178 0.000256 0.009044 -7948 1 0.000274 1560.000000 0.000447 -0.001217 0.000968 -7949 1 0.000237 1560.000000 -0.001338 -0.002036 0.004350 -7950 1 0.000248 1560.000000 -0.003035 -0.001754 0.007919 -7951 1 0.000200 1560.000000 0.000990 -0.000761 0.000468 -7952 1 0.000237 1560.000000 -0.001547 -0.002287 0.004162 -7953 1 0.000217 1560.000000 0.001415 -0.003134 0.005377 -7954 1 0.000233 1560.000000 0.001599 -0.000016 0.005587 -7955 1 0.000240 1560.000000 -0.002309 0.002943 0.004028 -7956 1 0.000195 1560.000000 0.001580 -0.000754 0.000393 -7957 1 0.000219 1560.000000 0.001785 -0.000181 0.004601 -7958 1 0.000237 1560.000000 -0.000469 0.001838 0.008668 -7959 1 0.000258 1560.000000 -0.000532 0.001796 0.005763 -7960 1 0.000272 1560.000000 0.002636 -0.000254 0.007088 -7961 1 0.000228 1560.000000 0.000114 -0.003096 0.008648 -7962 1 0.000230 1560.000000 -0.001747 0.000396 0.008614 -7963 1 0.000282 1560.000000 0.001291 0.002729 0.008839 -7964 1 0.000227 1560.000000 -0.001583 -0.002073 0.003820 -7965 1 0.000222 1560.000000 -0.001630 0.002699 0.007376 -7966 1 0.000214 1560.000000 0.003740 0.000473 0.006494 -7967 1 0.000219 1560.000000 -0.000319 -0.002097 0.003645 -7968 1 0.000239 1560.000000 -0.002948 0.000045 0.003411 -7969 1 0.000200 1560.000000 0.001430 0.003414 0.002620 -7970 1 0.000244 1560.000000 0.001721 -0.001242 0.007379 -7971 1 0.000253 1560.000000 0.000052 0.003146 0.009712 -7972 1 0.000197 1560.000000 -0.000410 0.001788 0.002583 -7973 1 0.000287 1560.000000 -0.003268 -0.000183 0.006605 -7974 1 0.000272 1560.000000 0.002116 0.002252 0.009323 -7975 1 0.000230 1560.000000 0.002079 -0.002510 0.005792 -7976 1 0.000248 1560.000000 -0.000503 0.001795 0.009687 -7977 1 0.000214 1560.000000 -0.001559 -0.000735 0.007511 -7978 1 0.000217 1560.000000 -0.002473 -0.000721 0.004263 -7979 1 0.000196 1560.000000 -0.000702 0.003715 0.000529 -7980 1 0.000276 1560.000000 0.002164 -0.002980 0.001950 -7981 1 0.000211 1560.000000 -0.001513 0.000250 0.005034 -7982 1 0.000252 1560.000000 -0.003360 -0.001375 0.004119 -7983 1 0.000195 1560.000000 0.002251 0.001729 0.009302 -7984 1 0.000229 1560.000000 -0.000263 0.001873 0.006343 -7985 1 0.000280 1560.000000 -0.001341 -0.001891 0.009314 -7986 1 0.000201 1560.000000 0.001651 -0.002541 0.005587 -7987 1 0.000227 1560.000000 -0.002364 0.000362 0.009724 -7988 1 0.000230 1560.000000 -0.000937 0.001868 0.008821 -7989 1 0.000258 1560.000000 0.001205 0.002303 0.002576 -7990 1 0.000257 1560.000000 -0.001704 -0.002705 0.001004 -7991 1 0.000260 1560.000000 0.001976 0.002451 0.005804 -7992 1 0.000206 1560.000000 0.001163 -0.001070 0.000151 -7993 1 0.000210 1560.000000 -0.002537 -0.002485 0.005021 -7994 1 0.000238 1560.000000 0.002627 0.002045 0.003958 -7995 1 0.000286 1560.000000 -0.000298 -0.003227 0.004218 -7996 1 0.000233 1560.000000 -0.001265 0.002109 0.007701 -7997 1 0.000205 1560.000000 0.000262 -0.001135 0.004159 -7998 1 0.000223 1560.000000 0.001432 -0.000694 0.007260 -7999 1 0.000278 1560.000000 -0.001481 -0.003082 0.003834 -8000 1 0.000234 1560.000000 -0.002113 -0.000875 0.004189 -8001 1 0.000196 1560.000000 -0.001584 0.001761 0.004427 -8002 1 0.000194 1560.000000 -0.002501 -0.001153 0.003316 -8003 1 0.000260 1560.000000 0.000715 -0.001111 0.008262 -8004 1 0.000220 1560.000000 -0.003537 -0.000637 0.004569 -8005 1 0.000273 1560.000000 -0.000841 0.003381 0.005210 -8006 1 0.000224 1560.000000 0.002215 0.000564 0.000467 -8007 1 0.000252 1560.000000 -0.002608 0.002390 0.008043 -8008 1 0.000284 1560.000000 0.000522 -0.001847 0.004593 -8009 1 0.000210 1560.000000 0.001562 0.002211 0.006943 -8010 1 0.000198 1560.000000 -0.000440 0.002015 0.001603 -8011 1 0.000207 1560.000000 0.000660 0.001402 0.005471 -8012 1 0.000244 1560.000000 0.000762 -0.001195 0.001242 -8013 1 0.000259 1560.000000 -0.000714 0.001993 0.002508 -8014 1 0.000208 1560.000000 0.000552 -0.003105 0.003605 -8015 1 0.000278 1560.000000 -0.002452 -0.001251 0.006999 -8016 1 0.000244 1560.000000 0.000105 0.003439 0.001286 -8017 1 0.000224 1560.000000 -0.000111 0.003619 0.004071 -8018 1 0.000198 1560.000000 -0.001448 0.002566 0.001435 -8019 1 0.000271 1560.000000 0.002693 -0.002626 0.007646 -8020 1 0.000209 1560.000000 0.000745 -0.001348 0.001967 -8021 1 0.000211 1560.000000 -0.003292 0.001028 0.001280 -8022 1 0.000213 1560.000000 -0.002790 -0.001589 0.005890 -8023 1 0.000236 1560.000000 0.001912 -0.001234 0.001320 -8024 1 0.000214 1560.000000 -0.000058 -0.000151 0.006044 -8025 1 0.000267 1560.000000 -0.001734 -0.001662 0.000498 -8026 1 0.000246 1560.000000 -0.002724 -0.000855 0.009772 -8027 1 0.000234 1560.000000 0.001578 -0.002950 0.005218 -8028 1 0.000230 1560.000000 0.002977 -0.002001 0.004833 -8029 1 0.000279 1560.000000 0.000837 -0.003281 0.002885 -8030 1 0.000268 1560.000000 -0.000470 -0.000709 0.006707 -8031 1 0.000248 1560.000000 -0.001301 -0.001697 0.005982 -8032 1 0.000193 1560.000000 0.000727 -0.003327 0.001141 -8033 1 0.000194 1560.000000 0.003612 -0.000111 0.004672 -8034 1 0.000199 1560.000000 0.002345 0.002897 0.004096 -8035 1 0.000209 1560.000000 0.001699 0.001766 0.002607 -8036 1 0.000213 1560.000000 0.002775 0.001703 0.002618 -8037 1 0.000238 1560.000000 -0.000063 0.003482 0.005846 -8038 1 0.000209 1560.000000 0.002107 0.000835 0.008591 -8039 1 0.000210 1560.000000 -0.002928 0.001153 0.009140 -8040 1 0.000200 1560.000000 -0.000793 -0.000204 0.002530 -8041 1 0.000269 1560.000000 0.001407 0.002623 0.002170 -8042 1 0.000228 1560.000000 -0.002740 -0.001987 0.008518 -8043 1 0.000213 1560.000000 0.001752 0.001732 0.005527 -8044 1 0.000276 1560.000000 -0.001501 0.002766 0.007919 -8045 1 0.000231 1560.000000 0.003086 -0.000242 0.000486 -8046 1 0.000199 1560.000000 -0.001761 -0.000777 0.003129 -8047 1 0.000225 1560.000000 -0.002017 -0.001675 0.000409 -8048 1 0.000276 1560.000000 0.000534 0.002745 0.003326 -8049 1 0.000217 1560.000000 0.000364 0.001040 0.001078 -8050 1 0.000205 1560.000000 -0.001761 0.003144 0.000908 -8051 1 0.000206 1560.000000 -0.002063 -0.001982 0.004928 -8052 1 0.000276 1560.000000 0.002775 -0.002454 0.007947 -8053 1 0.000287 1560.000000 0.000275 0.002633 0.005442 -8054 1 0.000203 1560.000000 0.002471 -0.001979 0.001583 -8055 1 0.000257 1560.000000 0.002104 0.001977 0.005414 -8056 1 0.000270 1560.000000 0.001666 0.000930 0.005763 -8057 1 0.000246 1560.000000 0.003047 -0.000483 0.005474 -8058 1 0.000194 1560.000000 -0.000200 -0.001022 0.001827 -8059 1 0.000194 1560.000000 -0.003637 0.000295 0.005452 -8060 1 0.000273 1560.000000 0.001050 0.002525 0.004974 -8061 1 0.000197 1560.000000 -0.002353 0.001223 0.004096 -8062 1 0.000215 1560.000000 -0.002025 0.000611 0.003573 -8063 1 0.000236 1560.000000 -0.000317 -0.001497 0.009786 -8064 1 0.000252 1560.000000 -0.002978 -0.000021 0.001222 -8065 1 0.000202 1560.000000 0.001751 0.001972 0.007798 -8066 1 0.000211 1560.000000 -0.003400 -0.001190 0.008601 -8067 1 0.000255 1560.000000 0.003086 -0.001084 0.007679 -8068 1 0.000254 1560.000000 -0.001627 0.002675 0.003096 -8069 1 0.000230 1560.000000 0.001837 -0.001427 0.000929 -8070 1 0.000194 1560.000000 0.000109 0.001088 0.003940 -8071 1 0.000215 1560.000000 -0.003182 0.001236 0.004481 -8072 1 0.000270 1560.000000 -0.002622 -0.001044 0.001692 -8073 1 0.000214 1560.000000 -0.000416 -0.000301 0.009123 -8074 1 0.000288 1560.000000 -0.001772 -0.000678 0.009324 -8075 1 0.000269 1560.000000 -0.002319 -0.001303 0.000989 -8076 1 0.000268 1560.000000 0.001339 -0.002562 0.003098 -8077 1 0.000256 1560.000000 0.002614 -0.001548 0.007431 -8078 1 0.000256 1560.000000 -0.003559 0.000417 0.007372 -8079 1 0.000284 1560.000000 0.001981 0.002400 0.005330 -8080 1 0.000249 1560.000000 -0.001763 -0.000674 0.001861 -8081 1 0.000267 1560.000000 0.001400 -0.001368 0.002417 -8082 1 0.000241 1560.000000 -0.002715 0.002395 0.002322 -8083 1 0.000221 1560.000000 0.002020 0.000702 0.002840 -8084 1 0.000242 1560.000000 0.001478 0.001328 0.004301 -8085 1 0.000250 1560.000000 0.002579 0.002603 0.000282 -8086 1 0.000209 1560.000000 -0.000081 -0.000044 0.007516 -8087 1 0.000264 1560.000000 -0.001724 0.000972 0.000452 -8088 1 0.000209 1560.000000 0.000091 -0.002909 0.008117 -8089 1 0.000270 1560.000000 0.001287 0.000278 0.007677 -8090 1 0.000254 1560.000000 -0.000470 0.001789 0.000802 -8091 1 0.000207 1560.000000 -0.000171 0.003281 0.001967 -8092 1 0.000280 1560.000000 0.001623 0.002962 0.004669 -8093 1 0.000268 1560.000000 -0.000685 0.002706 0.003349 -8094 1 0.000261 1560.000000 0.000641 -0.000753 0.000649 -8095 1 0.000201 1560.000000 0.002759 -0.001297 0.003323 -8096 1 0.000201 1560.000000 0.000720 -0.002498 0.008349 -8097 1 0.000214 1560.000000 0.001308 -0.001875 0.009543 -8098 1 0.000262 1560.000000 0.002039 0.001850 0.008556 -8099 1 0.000240 1560.000000 0.003722 0.000307 0.000379 -8100 1 0.000271 1560.000000 0.003677 0.000172 0.001690 -8101 1 0.000214 1560.000000 -0.001099 0.001850 0.004811 -8102 1 0.000227 1560.000000 0.002858 -0.000226 0.003201 -8103 1 0.000236 1560.000000 -0.001328 -0.001935 0.003726 -8104 1 0.000216 1560.000000 0.000814 0.000880 0.008938 -8105 1 0.000201 1560.000000 0.002443 -0.001639 0.001011 -8106 1 0.000212 1560.000000 0.002726 -0.000336 0.001003 -8107 1 0.000202 1560.000000 0.002056 -0.001379 0.006781 -8108 1 0.000204 1560.000000 -0.000254 -0.003255 0.008110 -8109 1 0.000205 1560.000000 -0.000291 -0.000415 0.008257 -8110 1 0.000195 1560.000000 0.001789 -0.000340 0.007641 -8111 1 0.000247 1560.000000 0.003368 -0.001172 0.004792 -8112 1 0.000284 1560.000000 -0.000159 -0.000767 0.006849 -8113 1 0.000215 1560.000000 -0.003668 0.000996 0.002028 -8114 1 0.000198 1560.000000 0.001481 0.003292 0.005332 -8115 1 0.000224 1560.000000 -0.002711 0.002345 0.007641 -8116 1 0.000217 1560.000000 0.001181 0.000510 0.005244 -8117 1 0.000260 1560.000000 0.000344 -0.002307 0.002184 -8118 1 0.000207 1560.000000 -0.000776 -0.000363 0.009778 -8119 1 0.000229 1560.000000 -0.000695 -0.001862 0.006077 -8120 1 0.000261 1560.000000 0.002034 0.002241 0.006075 -8121 1 0.000207 1560.000000 -0.003416 -0.001546 0.007532 -8122 1 0.000248 1560.000000 -0.001969 0.000944 0.003981 -8123 1 0.000272 1560.000000 0.001153 0.000684 0.000785 -8124 1 0.000248 1560.000000 -0.002302 -0.000573 0.005867 -8125 1 0.000257 1560.000000 0.000097 -0.002575 0.006696 -8126 1 0.000230 1560.000000 0.001928 -0.001890 0.004718 -8127 1 0.000215 1560.000000 0.000448 -0.002506 0.000854 -8128 1 0.000198 1560.000000 0.002686 -0.001722 0.000741 -8129 1 0.000242 1560.000000 0.002190 0.000808 0.000332 -8130 1 0.000276 1560.000000 -0.001146 -0.002525 0.000417 -8131 1 0.000216 1560.000000 -0.002473 0.002476 0.007736 -8132 1 0.000237 1560.000000 0.001866 -0.000403 0.004867 -8133 1 0.000231 1560.000000 -0.001656 -0.002135 0.009666 -8134 1 0.000211 1560.000000 0.001048 0.002031 0.003812 -8135 1 0.000211 1560.000000 0.001042 -0.001528 0.007548 -8136 1 0.000193 1560.000000 -0.000750 -0.003447 0.002305 -8137 1 0.000282 1560.000000 -0.001821 0.000088 0.004207 -8138 1 0.000192 1560.000000 -0.000478 0.003697 0.008276 -8139 1 0.000197 1560.000000 -0.001911 -0.001606 0.003045 -8140 1 0.000220 1560.000000 0.000803 -0.000911 0.000895 -8141 1 0.000261 1560.000000 -0.002014 0.000308 0.009762 -8142 1 0.000265 1560.000000 -0.002316 0.003045 0.002528 -8143 1 0.000197 1560.000000 0.000987 -0.001220 0.009065 -8144 1 0.000196 1560.000000 -0.002274 -0.002727 0.001811 -8145 1 0.000207 1560.000000 -0.000714 -0.001822 0.007695 -8146 1 0.000207 1560.000000 0.002096 -0.000743 0.006354 -8147 1 0.000265 1560.000000 0.001276 0.001065 0.004415 -8148 1 0.000228 1560.000000 -0.001411 -0.000547 0.004979 -8149 1 0.000202 1560.000000 0.001640 0.001630 0.001003 -8150 1 0.000218 1560.000000 -0.002429 0.000427 0.001440 -8151 1 0.000207 1560.000000 -0.000180 -0.000921 0.000612 -8152 1 0.000282 1560.000000 0.001653 0.001019 0.004929 -8153 1 0.000278 1560.000000 0.002481 -0.000455 0.008812 -8154 1 0.000255 1560.000000 -0.000486 -0.001450 0.008028 -8155 1 0.000256 1560.000000 -0.001607 -0.001546 0.002572 -8156 1 0.000274 1560.000000 -0.001730 -0.000377 0.006691 -8157 1 0.000226 1560.000000 0.001627 -0.001307 0.004095 -8158 1 0.000202 1560.000000 0.001409 0.000086 0.008170 -8159 1 0.000245 1560.000000 -0.003116 0.000555 0.001021 -8160 1 0.000258 1560.000000 -0.002459 0.000991 0.009837 -8161 1 0.000282 1560.000000 -0.002511 -0.001693 0.002055 -8162 1 0.000266 1560.000000 0.000111 0.000740 0.002495 -8163 1 0.000251 1560.000000 0.000290 0.000461 0.009268 -8164 1 0.000202 1560.000000 0.002251 0.000297 0.001619 -8165 1 0.000201 1560.000000 -0.002499 -0.000218 0.008728 -8166 1 0.000226 1560.000000 0.003529 -0.001492 0.006670 -8167 1 0.000221 1560.000000 -0.001952 0.002208 0.007890 -8168 1 0.000275 1560.000000 -0.000259 0.001179 0.000931 -8169 1 0.000226 1560.000000 -0.001809 -0.002138 0.006596 -8170 1 0.000267 1560.000000 -0.002619 0.000323 0.008993 -8171 1 0.000228 1560.000000 0.003459 -0.001693 0.004437 -8172 1 0.000193 1560.000000 0.001284 0.001099 0.006806 -8173 1 0.000268 1560.000000 0.002055 0.002461 0.000577 -8174 1 0.000193 1560.000000 -0.003340 -0.001225 0.006591 -8175 1 0.000250 1560.000000 -0.001859 0.001318 0.000730 -8176 1 0.000205 1560.000000 -0.000174 0.002819 0.006121 -8177 1 0.000199 1560.000000 0.000918 -0.000940 0.006750 -8178 1 0.000261 1560.000000 -0.000635 0.000406 0.005099 -8179 1 0.000274 1560.000000 0.000434 0.000877 0.001306 -8180 1 0.000270 1560.000000 0.002957 -0.000830 0.000506 -8181 1 0.000264 1560.000000 -0.000965 0.001343 0.006349 -8182 1 0.000245 1560.000000 -0.002197 -0.002504 0.006040 -8183 1 0.000241 1560.000000 0.000673 -0.003695 0.004375 -8184 1 0.000248 1560.000000 0.000908 0.002656 0.003059 -8185 1 0.000256 1560.000000 -0.001509 -0.000384 0.006517 -8186 1 0.000204 1560.000000 0.002144 0.003132 0.005123 -8187 1 0.000220 1560.000000 0.002911 0.000737 0.004934 -8188 1 0.000226 1560.000000 0.001291 -0.001591 0.000208 -8189 1 0.000234 1560.000000 0.000326 -0.002779 0.006180 -8190 1 0.000203 1560.000000 -0.001956 0.002592 0.007818 -8191 1 0.000277 1560.000000 0.002157 0.000283 0.006116 -8192 1 0.000203 1560.000000 0.001324 0.001602 0.003605 -8193 1 0.000206 1560.000000 0.001238 -0.000840 0.009538 -8194 1 0.000277 1560.000000 -0.003372 0.001332 0.000205 -8195 1 0.000208 1560.000000 -0.002052 -0.000473 0.007358 -8196 1 0.000224 1560.000000 -0.002889 -0.000264 0.000893 -8197 1 0.000198 1560.000000 -0.000229 0.000118 0.006973 -8198 1 0.000249 1560.000000 -0.000857 -0.000783 0.001740 -8199 1 0.000266 1560.000000 -0.003754 -0.000716 0.008599 -8200 1 0.000246 1560.000000 -0.002563 0.001219 0.005438 -8201 1 0.000205 1560.000000 -0.001095 0.001967 0.007933 -8202 1 0.000245 1560.000000 -0.000566 -0.000516 0.006403 -8203 1 0.000259 1560.000000 0.003650 0.000012 0.002320 -8204 1 0.000228 1560.000000 -0.001984 -0.000022 0.005132 -8205 1 0.000219 1560.000000 -0.000161 -0.003638 0.006676 -8206 1 0.000216 1560.000000 -0.003396 0.001750 0.002865 -8207 1 0.000276 1560.000000 -0.002429 0.002201 0.009070 -8208 1 0.000199 1560.000000 -0.002733 0.000633 0.005199 -8209 1 0.000268 1560.000000 0.001145 -0.003250 0.009788 -8210 1 0.000255 1560.000000 0.002865 -0.000021 0.004847 -8211 1 0.000217 1560.000000 -0.002328 -0.002797 0.007408 -8212 1 0.000232 1560.000000 -0.001592 0.001466 0.002451 -8213 1 0.000201 1560.000000 0.003650 0.000142 0.005706 -8214 1 0.000210 1560.000000 0.000082 -0.003108 0.009101 -8215 1 0.000216 1560.000000 0.001776 0.001229 0.009526 -8216 1 0.000199 1560.000000 -0.001960 -0.000335 0.008354 -8217 1 0.000199 1560.000000 -0.000409 -0.002231 0.000772 -8218 1 0.000225 1560.000000 0.001689 0.002543 0.000334 -8219 1 0.000235 1560.000000 0.001077 0.000661 0.008266 -8220 1 0.000249 1560.000000 0.000744 0.003515 0.001308 -8221 1 0.000201 1560.000000 0.000639 0.001490 0.005856 -8222 1 0.000255 1560.000000 -0.003421 -0.001184 0.003306 -8223 1 0.000199 1560.000000 -0.000199 -0.000094 0.008132 -8224 1 0.000266 1560.000000 0.002004 0.003037 0.008225 -8225 1 0.000206 1560.000000 0.003793 0.000538 0.005219 -8226 1 0.000248 1560.000000 0.000137 -0.002431 0.003973 -8227 1 0.000209 1560.000000 -0.000359 -0.001499 0.004510 -8228 1 0.000238 1560.000000 0.002254 -0.002918 0.001370 -8229 1 0.000230 1560.000000 0.003734 -0.000359 0.004479 -8230 1 0.000192 1560.000000 -0.000970 0.002903 0.000178 -8231 1 0.000201 1560.000000 0.002236 -0.001940 0.005810 -8232 1 0.000260 1560.000000 -0.001839 -0.000179 0.009359 -8233 1 0.000277 1560.000000 -0.002657 0.002766 0.005195 -8234 1 0.000230 1560.000000 -0.000150 -0.002317 0.001936 -8235 1 0.000217 1560.000000 -0.002191 0.002540 0.007714 -8236 1 0.000211 1560.000000 -0.001472 -0.000278 0.004661 -8237 1 0.000240 1560.000000 -0.000754 0.003778 0.002478 -8238 1 0.000235 1560.000000 -0.002595 -0.001366 0.000945 -8239 1 0.000219 1560.000000 -0.001866 -0.002453 0.000474 -8240 1 0.000228 1560.000000 -0.001853 -0.000597 0.005892 -8241 1 0.000255 1560.000000 0.001081 0.003146 0.009156 -8242 1 0.000214 1560.000000 0.001990 -0.001087 0.007689 -8243 1 0.000213 1560.000000 -0.001191 -0.003326 0.006694 -8244 1 0.000206 1560.000000 0.002299 -0.001895 0.006026 -8245 1 0.000200 1560.000000 0.000735 -0.002494 0.003054 -8246 1 0.000275 1560.000000 -0.000918 -0.001958 0.009703 -8247 1 0.000267 1560.000000 -0.001502 -0.002733 0.002625 -8248 1 0.000209 1560.000000 -0.002204 -0.002800 0.000840 -8249 1 0.000275 1560.000000 0.001488 0.002390 0.000439 -8250 1 0.000212 1560.000000 0.002868 0.001524 0.008618 -8251 1 0.000279 1560.000000 -0.002244 -0.002637 0.002884 -8252 1 0.000231 1560.000000 0.002713 -0.002300 0.005741 -8253 1 0.000194 1560.000000 0.000103 0.003823 0.003689 -8254 1 0.000203 1560.000000 0.000452 0.000948 0.003351 -8255 1 0.000194 1560.000000 0.000689 -0.003257 0.003509 -8256 1 0.000199 1560.000000 0.000567 -0.002435 0.005657 -8257 1 0.000287 1560.000000 0.001286 0.000788 0.009813 -8258 1 0.000192 1560.000000 0.002200 -0.000441 0.007292 -8259 1 0.000277 1560.000000 0.001187 0.001712 0.002400 -8260 1 0.000275 1560.000000 -0.001950 -0.001888 0.005996 -8261 1 0.000245 1560.000000 -0.002743 -0.000072 0.006490 -8262 1 0.000199 1560.000000 0.001853 -0.002129 0.009540 -8263 1 0.000283 1560.000000 0.002111 0.001035 0.000533 -8264 1 0.000211 1560.000000 0.002769 0.001573 0.008881 -8265 1 0.000197 1560.000000 0.001407 0.000637 0.006043 -8266 1 0.000200 1560.000000 0.001885 -0.000709 0.002248 -8267 1 0.000271 1560.000000 0.001973 0.002918 0.009268 -8268 1 0.000250 1560.000000 -0.001385 0.000961 0.003837 -8269 1 0.000219 1560.000000 0.000108 0.001769 0.003750 -8270 1 0.000252 1560.000000 0.000139 0.002515 0.003298 -8271 1 0.000239 1560.000000 0.001015 0.003699 0.002371 -8272 1 0.000197 1560.000000 -0.000638 0.001709 0.004888 -8273 1 0.000235 1560.000000 0.001910 0.000717 0.006551 -8274 1 0.000287 1560.000000 -0.002661 0.002466 0.001570 -8275 1 0.000286 1560.000000 0.003701 -0.000524 0.006788 -8276 1 0.000278 1560.000000 -0.002175 0.002316 0.009106 -8277 1 0.000211 1560.000000 0.001066 0.002339 0.002779 -8278 1 0.000198 1560.000000 0.001008 0.002976 0.003438 -8279 1 0.000226 1560.000000 0.001930 0.003179 0.009422 -8280 1 0.000213 1560.000000 -0.001957 -0.003304 0.006685 -8281 1 0.000230 1560.000000 0.002621 -0.001610 0.005627 -8282 1 0.000259 1560.000000 -0.003564 0.000872 0.007129 -8283 1 0.000249 1560.000000 0.001931 -0.001745 0.007330 -8284 1 0.000267 1560.000000 0.002921 0.000982 0.009663 -8285 1 0.000199 1560.000000 0.000140 -0.002728 0.001196 -8286 1 0.000255 1560.000000 -0.001373 -0.000408 0.006872 -8287 1 0.000212 1560.000000 0.000097 0.002522 0.009128 -8288 1 0.000223 1560.000000 0.000657 -0.002531 0.001708 -8289 1 0.000257 1560.000000 0.002023 -0.000047 0.001990 -8290 1 0.000216 1560.000000 0.001283 0.002162 0.002274 -8291 1 0.000285 1560.000000 0.000099 0.003658 0.005060 -8292 1 0.000195 1560.000000 0.001713 0.001502 0.009112 -8293 1 0.000194 1560.000000 -0.001264 -0.001132 0.003851 -8294 1 0.000207 1560.000000 -0.000603 -0.000281 0.006913 -8295 1 0.000256 1560.000000 0.002836 0.002106 0.000934 -8296 1 0.000197 1560.000000 -0.000336 0.002191 0.002922 -8297 1 0.000270 1560.000000 -0.000383 -0.002118 0.001939 -8298 1 0.000256 1560.000000 -0.002478 -0.001978 0.002749 -8299 1 0.000273 1560.000000 0.003352 0.000160 0.009833 -8300 1 0.000196 1560.000000 -0.002728 0.000754 0.000259 -8301 1 0.000193 1560.000000 -0.002269 -0.002892 0.006471 -8302 1 0.000273 1560.000000 0.002328 0.002905 0.007484 -8303 1 0.000230 1560.000000 0.000031 -0.001416 0.002002 -8304 1 0.000253 1560.000000 -0.001458 -0.002085 0.000345 -8305 1 0.000223 1560.000000 -0.000009 -0.003167 0.001304 -8306 1 0.000260 1560.000000 0.003612 0.001332 0.007537 -8307 1 0.000271 1560.000000 -0.003330 0.000776 0.008623 -8308 1 0.000261 1560.000000 -0.002297 0.002973 0.001623 -8309 1 0.000264 1560.000000 -0.002873 -0.000793 0.003783 -8310 1 0.000204 1560.000000 0.000415 0.001711 0.002324 -8311 1 0.000249 1560.000000 -0.003322 -0.000537 0.002097 -8312 1 0.000257 1560.000000 -0.001665 -0.002589 0.003974 -8313 1 0.000253 1560.000000 -0.000102 -0.000941 0.002621 -8314 1 0.000219 1560.000000 0.001273 0.001195 0.000847 -8315 1 0.000214 1560.000000 -0.000302 0.001435 0.009476 -8316 1 0.000210 1560.000000 0.003285 -0.000686 0.006239 -8317 1 0.000230 1560.000000 0.001864 0.002333 0.009472 -8318 1 0.000252 1560.000000 0.001401 -0.001858 0.002549 -8319 1 0.000238 1560.000000 0.002809 -0.000338 0.009792 -8320 1 0.000207 1560.000000 -0.003036 -0.000332 0.001446 -8321 1 0.000240 1560.000000 0.003481 0.000390 0.007439 -8322 1 0.000253 1560.000000 0.002960 0.002166 0.008942 -8323 1 0.000202 1560.000000 0.002064 -0.000961 0.001553 -8324 1 0.000196 1560.000000 -0.000862 -0.003676 0.007257 -8325 1 0.000252 1560.000000 0.001647 -0.000581 0.008790 -8326 1 0.000214 1560.000000 0.000785 -0.001005 0.006354 -8327 1 0.000220 1560.000000 -0.002086 0.002661 0.001132 -8328 1 0.000214 1560.000000 -0.000287 -0.003845 0.008917 -8329 1 0.000248 1560.000000 -0.001540 -0.000568 0.001321 -8330 1 0.000281 1560.000000 -0.000951 0.001488 0.001211 -8331 1 0.000260 1560.000000 0.003536 -0.001249 0.003911 -8332 1 0.000250 1560.000000 -0.001526 0.001656 0.004804 -8333 1 0.000215 1560.000000 -0.003393 0.001383 0.005214 -8334 1 0.000258 1560.000000 -0.000900 0.003615 0.004958 -8335 1 0.000283 1560.000000 0.002754 0.000992 0.007562 -8336 1 0.000207 1560.000000 0.002889 0.001875 0.008174 -8337 1 0.000270 1560.000000 0.003683 -0.000958 0.005416 -8338 1 0.000235 1560.000000 0.000153 0.000844 0.003594 -8339 1 0.000255 1560.000000 -0.002719 0.001332 0.005746 -8340 1 0.000232 1560.000000 0.001799 -0.002831 0.002390 -8341 1 0.000217 1560.000000 -0.002044 0.002440 0.001922 -8342 1 0.000193 1560.000000 -0.000345 -0.002475 0.005856 -8343 1 0.000206 1560.000000 0.002065 0.002631 0.003509 -8344 1 0.000207 1560.000000 0.000237 -0.000685 0.009675 -8345 1 0.000194 1560.000000 0.003708 -0.000080 0.001933 -8346 1 0.000260 1560.000000 -0.001161 0.001008 0.002930 -8347 1 0.000240 1560.000000 0.000851 -0.002377 0.002350 -8348 1 0.000212 1560.000000 -0.001432 0.003576 0.002177 -8349 1 0.000229 1560.000000 -0.003552 0.000662 0.002717 -8350 1 0.000286 1560.000000 0.001908 -0.003067 0.003245 -8351 1 0.000228 1560.000000 0.002443 0.000854 0.006802 -8352 1 0.000204 1560.000000 0.000863 0.001946 0.000750 -8353 1 0.000214 1560.000000 -0.002365 -0.002491 0.005284 -8354 1 0.000263 1560.000000 -0.002214 0.000654 0.006622 -8355 1 0.000242 1560.000000 0.002389 -0.001947 0.007570 -8356 1 0.000221 1560.000000 0.001584 0.000609 0.008392 -8357 1 0.000281 1560.000000 -0.003521 0.000836 0.006496 -8358 1 0.000255 1560.000000 -0.002430 -0.000056 0.005430 -8359 1 0.000219 1560.000000 0.002830 0.000049 0.002298 -8360 1 0.000249 1560.000000 -0.000523 0.003743 0.009748 -8361 1 0.000201 1560.000000 -0.000267 -0.002933 0.006207 -8362 1 0.000254 1560.000000 -0.000739 0.000593 0.006996 -8363 1 0.000244 1560.000000 0.002735 0.000618 0.006173 -8364 1 0.000246 1560.000000 -0.001912 -0.000151 0.004056 -8365 1 0.000212 1560.000000 -0.000572 0.002790 0.004906 -8366 1 0.000241 1560.000000 -0.001004 0.001634 0.008895 -8367 1 0.000204 1560.000000 0.002361 -0.002870 0.002762 -8368 1 0.000220 1560.000000 0.000456 0.002647 0.006885 -8369 1 0.000196 1560.000000 0.002785 0.000054 0.005546 -8370 1 0.000251 1560.000000 -0.000564 0.000882 0.001353 -8371 1 0.000204 1560.000000 0.001602 -0.000703 0.004834 -8372 1 0.000250 1560.000000 -0.002191 -0.001620 0.007491 -8373 1 0.000193 1560.000000 -0.001788 0.003022 0.003084 -8374 1 0.000200 1560.000000 0.002043 -0.001710 0.002930 -8375 1 0.000246 1560.000000 -0.003382 0.000569 0.007493 -8376 1 0.000201 1560.000000 0.000721 -0.003721 0.001995 -8377 1 0.000288 1560.000000 -0.001518 0.003207 0.000452 -8378 1 0.000201 1560.000000 0.000559 -0.003752 0.001404 -8379 1 0.000277 1560.000000 0.002337 0.001976 0.000405 -8380 1 0.000209 1560.000000 0.000153 -0.000395 0.005445 -8381 1 0.000204 1560.000000 -0.000581 -0.000982 0.007573 -8382 1 0.000201 1560.000000 -0.000979 0.002669 0.007530 -8383 1 0.000209 1560.000000 0.000688 0.000185 0.001994 -8384 1 0.000204 1560.000000 0.002075 0.001905 0.009655 -8385 1 0.000228 1560.000000 -0.001328 -0.002432 0.003366 -8386 1 0.000252 1560.000000 -0.000508 -0.002861 0.000239 -8387 1 0.000196 1560.000000 -0.001336 0.002770 0.004196 -8388 1 0.000226 1560.000000 0.002670 -0.000675 0.001951 -8389 1 0.000228 1560.000000 -0.002048 0.002206 0.006302 -8390 1 0.000204 1560.000000 0.000943 -0.000315 0.004311 -8391 1 0.000210 1560.000000 0.002065 0.001216 0.007288 -8392 1 0.000242 1560.000000 0.001706 -0.001987 0.005054 -8393 1 0.000215 1560.000000 0.001495 0.002227 0.003656 -8394 1 0.000201 1560.000000 0.003560 0.000591 0.001013 -8395 1 0.000215 1560.000000 -0.002271 0.001079 0.006933 -8396 1 0.000203 1560.000000 0.000367 0.001554 0.004840 -8397 1 0.000240 1560.000000 -0.001685 0.003410 0.007898 -8398 1 0.000195 1560.000000 0.001479 0.000031 0.006694 -8399 1 0.000203 1560.000000 -0.000019 0.002589 0.005840 -8400 1 0.000231 1560.000000 0.002168 0.001195 0.006166 -8401 1 0.000218 1560.000000 0.000770 -0.001106 0.005802 -8402 1 0.000209 1560.000000 -0.001065 0.001650 0.004958 -8403 1 0.000229 1560.000000 -0.003471 -0.000814 0.004442 -8404 1 0.000218 1560.000000 0.000161 0.003043 0.000202 -8405 1 0.000202 1560.000000 -0.000155 -0.002228 0.000484 -8406 1 0.000214 1560.000000 0.003289 -0.000102 0.000284 -8407 1 0.000254 1560.000000 0.000054 -0.003552 0.001564 -8408 1 0.000203 1560.000000 0.000055 0.002728 0.002591 -8409 1 0.000206 1560.000000 0.000055 -0.003539 0.008008 -8410 1 0.000218 1560.000000 0.001695 0.002587 0.007232 -8411 1 0.000278 1560.000000 -0.001230 0.002051 0.001897 -8412 1 0.000207 1560.000000 -0.000377 -0.000102 0.004405 -8413 1 0.000216 1560.000000 -0.003593 0.000265 0.001161 -8414 1 0.000250 1560.000000 -0.001650 0.002280 0.003651 -8415 1 0.000220 1560.000000 0.001544 -0.000385 0.003177 -8416 1 0.000223 1560.000000 -0.002828 0.001460 0.004327 -8417 1 0.000205 1560.000000 0.001569 -0.002434 0.004418 -8418 1 0.000204 1560.000000 0.000971 -0.000838 0.004804 -8419 1 0.000251 1560.000000 -0.001883 -0.001344 0.002600 -8420 1 0.000233 1560.000000 0.003029 -0.001148 0.002977 -8421 1 0.000213 1560.000000 -0.003481 -0.001017 0.000710 -8422 1 0.000198 1560.000000 0.001438 0.000967 0.002352 -8423 1 0.000221 1560.000000 -0.002962 -0.000290 0.008430 -8424 1 0.000194 1560.000000 0.002315 0.000183 0.001169 -8425 1 0.000218 1560.000000 -0.002776 -0.000668 0.001432 -8426 1 0.000245 1560.000000 -0.002204 0.000905 0.008138 -8427 1 0.000257 1560.000000 0.001702 -0.002897 0.002877 -8428 1 0.000218 1560.000000 -0.000860 -0.000336 0.000280 -8429 1 0.000196 1560.000000 -0.000765 -0.001150 0.003503 -8430 1 0.000279 1560.000000 -0.002034 -0.003251 0.003309 -8431 1 0.000201 1560.000000 -0.001101 0.000930 0.005726 -8432 1 0.000271 1560.000000 -0.000999 0.001376 0.001532 -8433 1 0.000251 1560.000000 -0.000436 0.001703 0.006007 -8434 1 0.000229 1560.000000 0.001578 0.002151 0.002382 -8435 1 0.000202 1560.000000 -0.002658 0.000692 0.007855 -8436 1 0.000247 1560.000000 0.000412 -0.001704 0.005715 -8437 1 0.000249 1560.000000 0.003231 0.000253 0.004103 -8438 1 0.000202 1560.000000 -0.000530 0.000034 0.002222 -8439 1 0.000215 1560.000000 0.000314 0.002346 0.005106 -8440 1 0.000242 1560.000000 0.001779 0.003316 0.008263 -8441 1 0.000223 1560.000000 0.002637 0.001547 0.008016 -8442 1 0.000201 1560.000000 0.000898 0.001668 0.003057 -8443 1 0.000243 1560.000000 0.002409 -0.001677 0.007845 -8444 1 0.000244 1560.000000 -0.002283 -0.000733 0.009714 -8445 1 0.000213 1560.000000 -0.001141 0.000012 0.007860 -8446 1 0.000249 1560.000000 -0.003600 0.000806 0.003503 -8447 1 0.000236 1560.000000 0.000921 -0.001217 0.008438 -8448 1 0.000260 1560.000000 -0.000326 0.003071 0.001273 -8449 1 0.000259 1560.000000 -0.002506 -0.000303 0.006132 -8450 1 0.000261 1560.000000 -0.000186 0.002162 0.000534 -8451 1 0.000236 1560.000000 0.002730 0.000261 0.004540 -8452 1 0.000274 1560.000000 0.001697 0.002505 0.003606 -8453 1 0.000274 1560.000000 0.001642 -0.000680 0.007040 -8454 1 0.000234 1560.000000 -0.001577 0.002259 0.006555 -8455 1 0.000284 1560.000000 0.001182 -0.002904 0.006324 -8456 1 0.000193 1560.000000 0.002009 0.000310 0.004507 -8457 1 0.000196 1560.000000 0.000146 0.002597 0.008078 -8458 1 0.000211 1560.000000 0.000857 0.000305 0.007167 -8459 1 0.000226 1560.000000 0.001227 -0.001064 0.006901 -8460 1 0.000217 1560.000000 -0.000839 -0.003251 0.002087 -8461 1 0.000221 1560.000000 0.000997 0.000251 0.000663 -8462 1 0.000226 1560.000000 -0.001178 0.001033 0.004213 -8463 1 0.000276 1560.000000 0.002647 -0.001462 0.004758 -8464 1 0.000280 1560.000000 -0.002346 0.000692 0.001727 -8465 1 0.000243 1560.000000 0.001141 -0.002581 0.002095 -8466 1 0.000218 1560.000000 -0.001243 0.003348 0.001568 -8467 1 0.000271 1560.000000 0.000745 0.002324 0.003864 -8468 1 0.000204 1560.000000 0.001482 0.003463 0.003101 -8469 1 0.000268 1560.000000 -0.000521 0.001491 0.007491 -8470 1 0.000274 1560.000000 -0.002448 -0.000785 0.004705 -8471 1 0.000196 1560.000000 -0.001044 -0.000564 0.004124 -8472 1 0.000205 1560.000000 -0.001810 0.002191 0.006467 -8473 1 0.000274 1560.000000 -0.003693 0.000208 0.006769 -8474 1 0.000229 1560.000000 -0.002397 -0.001573 0.005354 -8475 1 0.000225 1560.000000 0.000830 -0.001973 0.009039 -8476 1 0.000217 1560.000000 0.002855 0.001233 0.001187 -8477 1 0.000248 1560.000000 0.003010 0.001164 0.008495 -8478 1 0.000231 1560.000000 -0.002414 -0.002136 0.003423 -8479 1 0.000201 1560.000000 0.001476 -0.000288 0.006391 -8480 1 0.000215 1560.000000 -0.000737 0.002516 0.009021 -8481 1 0.000275 1560.000000 -0.002198 -0.000170 0.000199 -8482 1 0.000221 1560.000000 -0.001193 -0.003514 0.001651 -8483 1 0.000287 1560.000000 0.000830 -0.002998 0.000702 -8484 1 0.000251 1560.000000 0.000291 -0.000213 0.006452 -8485 1 0.000196 1560.000000 -0.001753 0.002186 0.009646 -8486 1 0.000226 1560.000000 0.002475 -0.000705 0.002068 -8487 1 0.000259 1560.000000 0.000387 -0.000709 0.006352 -8488 1 0.000238 1560.000000 -0.001029 -0.001458 0.008834 -8489 1 0.000270 1560.000000 -0.002702 -0.002288 0.001944 -8490 1 0.000231 1560.000000 -0.000824 -0.001862 0.008145 -8491 1 0.000207 1560.000000 0.003132 0.000197 0.002618 -8492 1 0.000207 1560.000000 -0.000763 0.000384 0.009144 -8493 1 0.000225 1560.000000 0.001272 0.003473 0.003629 -8494 1 0.000229 1560.000000 -0.003708 -0.000287 0.004281 -8495 1 0.000201 1560.000000 0.000583 -0.002157 0.007062 -8496 1 0.000221 1560.000000 0.001789 -0.001333 0.005117 -8497 1 0.000213 1560.000000 0.000565 0.003434 0.002128 -8498 1 0.000217 1560.000000 0.002402 0.001051 0.009386 -8499 1 0.000258 1560.000000 0.002738 0.000079 0.006255 -8500 1 0.000270 1560.000000 -0.001648 0.001955 0.005472 -8501 1 0.000202 1560.000000 -0.002294 -0.002041 0.000367 -8502 1 0.000227 1560.000000 0.002406 0.002623 0.004789 -8503 1 0.000260 1560.000000 -0.001450 0.001027 0.001050 -8504 1 0.000246 1560.000000 0.001834 0.002972 0.005045 -8505 1 0.000226 1560.000000 -0.000588 0.003137 0.006129 -8506 1 0.000212 1560.000000 -0.000399 -0.001226 0.009811 -8507 1 0.000245 1560.000000 0.002384 -0.001617 0.002941 -8508 1 0.000280 1560.000000 -0.001220 0.000510 0.008574 -8509 1 0.000240 1560.000000 -0.001041 0.003533 0.000691 -8510 1 0.000256 1560.000000 -0.003178 0.000983 0.006560 -8511 1 0.000281 1560.000000 -0.001109 -0.000170 0.005577 -8512 1 0.000231 1560.000000 0.002092 0.001384 0.008406 -8513 1 0.000271 1560.000000 -0.001360 -0.001305 0.000992 -8514 1 0.000213 1560.000000 0.001616 0.000716 0.001260 -8515 1 0.000259 1560.000000 0.003438 -0.000689 0.005626 -8516 1 0.000251 1560.000000 -0.001773 0.001287 0.008445 -8517 1 0.000210 1560.000000 -0.000284 -0.001925 0.003153 -8518 1 0.000222 1560.000000 -0.001842 0.001154 0.008843 -8519 1 0.000214 1560.000000 -0.000147 0.000886 0.005464 -8520 1 0.000239 1560.000000 -0.000530 0.001425 0.004324 -8521 1 0.000210 1560.000000 0.001957 0.001815 0.007666 -8522 1 0.000283 1560.000000 -0.002287 0.003049 0.009549 -8523 1 0.000209 1560.000000 0.002216 0.000237 0.000792 -8524 1 0.000200 1560.000000 -0.001139 0.001792 0.002271 -8525 1 0.000282 1560.000000 -0.000090 0.002901 0.006556 -8526 1 0.000196 1560.000000 0.000305 0.001023 0.006298 -8527 1 0.000230 1560.000000 -0.002228 -0.001581 0.005883 -8528 1 0.000280 1560.000000 -0.000150 -0.001605 0.000817 -8529 1 0.000280 1560.000000 0.000096 0.003243 0.007049 -8530 1 0.000203 1560.000000 -0.003404 0.001132 0.000714 -8531 1 0.000232 1560.000000 -0.001105 -0.001796 0.007235 -8532 1 0.000200 1560.000000 0.002683 -0.001727 0.001215 -8533 1 0.000225 1560.000000 0.001544 -0.000798 0.007628 -8534 1 0.000207 1560.000000 -0.000946 -0.003096 0.006228 -8535 1 0.000194 1560.000000 -0.000394 -0.002418 0.004056 -8536 1 0.000263 1560.000000 -0.001131 0.001341 0.008097 -8537 1 0.000224 1560.000000 -0.002631 0.000408 0.004311 -8538 1 0.000207 1560.000000 0.000291 0.001831 0.006034 -8539 1 0.000215 1560.000000 -0.000522 -0.000580 0.002353 -8540 1 0.000230 1560.000000 -0.001771 0.000296 0.000319 -8541 1 0.000237 1560.000000 0.002359 0.000074 0.008405 -8542 1 0.000242 1560.000000 0.000689 0.003271 0.007847 -8543 1 0.000288 1560.000000 0.001547 -0.001113 0.006898 -8544 1 0.000264 1560.000000 0.003690 -0.000789 0.000514 -8545 1 0.000219 1560.000000 0.002243 0.001187 0.007034 -8546 1 0.000204 1560.000000 -0.003690 0.000556 0.000487 -8547 1 0.000220 1560.000000 -0.001987 -0.002475 0.001615 -8548 1 0.000241 1560.000000 -0.001537 0.001101 0.009528 -8549 1 0.000215 1560.000000 0.002769 0.001981 0.007266 -8550 1 0.000203 1560.000000 0.000693 0.001963 0.006551 -8551 1 0.000277 1560.000000 -0.000380 0.002430 0.009448 -8552 1 0.000250 1560.000000 -0.002620 -0.001838 0.004956 -8553 1 0.000225 1560.000000 -0.001033 0.003586 0.005759 -8554 1 0.000277 1560.000000 0.001505 0.001536 0.009653 -8555 1 0.000252 1560.000000 -0.001995 0.000917 0.000371 -8556 1 0.000198 1560.000000 0.001343 -0.001888 0.008562 -8557 1 0.000212 1560.000000 -0.002601 0.001581 0.001642 -8558 1 0.000228 1560.000000 0.002829 0.000646 0.001505 -8559 1 0.000222 1560.000000 -0.000765 0.000620 0.003057 -8560 1 0.000199 1560.000000 0.002027 -0.002746 0.004885 -8561 1 0.000215 1560.000000 0.003821 -0.000290 0.007667 -8562 1 0.000259 1560.000000 0.000850 -0.002336 0.000160 -8563 1 0.000246 1560.000000 0.002967 0.000355 0.003846 -8564 1 0.000232 1560.000000 0.001265 0.001382 0.006891 -8565 1 0.000226 1560.000000 0.003452 -0.000637 0.008320 -8566 1 0.000225 1560.000000 0.001679 0.002901 0.005367 -8567 1 0.000265 1560.000000 0.003793 0.000382 0.006008 -8568 1 0.000202 1560.000000 -0.000298 0.002127 0.004666 -8569 1 0.000195 1560.000000 0.000123 -0.000198 0.004842 -8570 1 0.000275 1560.000000 0.001864 0.000200 0.009834 -8571 1 0.000193 1560.000000 -0.003492 0.000650 0.001744 -8572 1 0.000271 1560.000000 0.001769 0.002687 0.001161 -8573 1 0.000195 1560.000000 0.001729 0.001764 0.008133 -8574 1 0.000247 1560.000000 0.000923 -0.002252 0.005840 -8575 1 0.000221 1560.000000 -0.001590 0.000897 0.009081 -8576 1 0.000214 1560.000000 0.001003 -0.001647 0.000194 -8577 1 0.000213 1560.000000 0.001740 0.001907 0.007573 -8578 1 0.000241 1560.000000 -0.000407 0.002817 0.008652 -8579 1 0.000265 1560.000000 0.000557 -0.002021 0.005569 -8580 1 0.000197 1560.000000 0.002463 -0.001370 0.005016 -8581 1 0.000241 1560.000000 0.002967 0.001876 0.008853 -8582 1 0.000286 1560.000000 0.001869 -0.001521 0.003432 -8583 1 0.000216 1560.000000 0.000435 -0.002248 0.009473 -8584 1 0.000209 1560.000000 0.001149 0.001721 0.003478 -8585 1 0.000229 1560.000000 -0.000562 0.003777 0.004894 -8586 1 0.000244 1560.000000 -0.003366 -0.001479 0.006011 -8587 1 0.000251 1560.000000 -0.000472 -0.003103 0.005029 -8588 1 0.000219 1560.000000 -0.000669 -0.003066 0.006989 -8589 1 0.000209 1560.000000 -0.002462 -0.001320 0.006159 -8590 1 0.000277 1560.000000 0.002381 -0.001495 0.008911 -8591 1 0.000199 1560.000000 -0.000252 0.003643 0.004910 -8592 1 0.000234 1560.000000 0.002725 0.002672 0.003976 -8593 1 0.000267 1560.000000 -0.002262 0.003087 0.009214 -8594 1 0.000218 1560.000000 0.000767 -0.001904 0.000473 -8595 1 0.000242 1560.000000 -0.002041 -0.001169 0.005142 -8596 1 0.000196 1560.000000 0.000639 0.001817 0.004409 -8597 1 0.000199 1560.000000 -0.000225 -0.001028 0.005869 -8598 1 0.000257 1560.000000 0.003590 0.000004 0.001315 -8599 1 0.000238 1560.000000 -0.001228 -0.001701 0.000386 -8600 1 0.000205 1560.000000 0.000195 0.002346 0.008220 -8601 1 0.000234 1560.000000 -0.001590 -0.000047 0.005051 -8602 1 0.000206 1560.000000 0.001816 0.001814 0.003893 -8603 1 0.000229 1560.000000 0.002206 -0.002986 0.006539 -8604 1 0.000208 1560.000000 0.001570 0.000470 0.002329 -8605 1 0.000208 1560.000000 0.002682 0.001293 0.002661 -8606 1 0.000272 1560.000000 0.003467 0.000560 0.005353 -8607 1 0.000244 1560.000000 -0.000514 -0.001224 0.002238 -8608 1 0.000248 1560.000000 -0.003215 0.000760 0.001170 -8609 1 0.000196 1560.000000 -0.000494 0.001110 0.008947 -8610 1 0.000209 1560.000000 -0.000215 -0.001443 0.001032 -8611 1 0.000217 1560.000000 0.000812 -0.002523 0.007344 -8612 1 0.000217 1560.000000 -0.003158 -0.001610 0.002152 -8613 1 0.000285 1560.000000 0.001595 0.001421 0.005214 -8614 1 0.000241 1560.000000 -0.001284 -0.001930 0.007493 -8615 1 0.000256 1560.000000 0.001985 -0.000210 0.009624 -8616 1 0.000242 1560.000000 0.001915 0.000316 0.007166 -8617 1 0.000202 1560.000000 0.001279 -0.000050 0.006400 -8618 1 0.000271 1560.000000 -0.002480 -0.000422 0.000697 -8619 1 0.000234 1560.000000 -0.000643 0.002217 0.001633 -8620 1 0.000215 1560.000000 -0.000206 0.001883 0.005750 -8621 1 0.000272 1560.000000 -0.002006 -0.001113 0.005669 -8622 1 0.000220 1560.000000 0.000449 -0.003110 0.004925 -8623 1 0.000261 1560.000000 0.001064 -0.003575 0.004928 -8624 1 0.000211 1560.000000 0.000392 -0.001277 0.007246 -8625 1 0.000218 1560.000000 -0.001954 0.002607 0.008223 -8626 1 0.000194 1560.000000 -0.003124 0.002011 0.001598 -8627 1 0.000199 1560.000000 0.000000 0.002330 0.004319 -8628 1 0.000230 1560.000000 -0.001309 0.001876 0.006231 -8629 1 0.000224 1560.000000 -0.001157 0.002100 0.003298 -8630 1 0.000202 1560.000000 -0.001208 -0.002079 0.003104 -8631 1 0.000208 1560.000000 0.003032 0.000218 0.005008 -8632 1 0.000203 1560.000000 -0.003117 0.002182 0.002127 -8633 1 0.000199 1560.000000 -0.000487 0.000177 0.004713 -8634 1 0.000276 1560.000000 -0.001484 -0.002808 0.004009 -8635 1 0.000222 1560.000000 0.001632 0.003113 0.009041 -8636 1 0.000204 1560.000000 0.000689 -0.002654 0.007046 -8637 1 0.000205 1560.000000 0.002329 -0.001778 0.005463 -8638 1 0.000262 1560.000000 -0.000449 0.003309 0.000784 -8639 1 0.000268 1560.000000 0.002271 0.000549 0.006530 -8640 1 0.000267 1560.000000 0.001825 0.002977 0.003655 -8641 1 0.000277 1560.000000 -0.001491 -0.001572 0.009248 -8642 1 0.000287 1560.000000 0.002097 -0.001467 0.004488 -8643 1 0.000199 1560.000000 0.003140 -0.001828 0.004018 -8644 1 0.000239 1560.000000 0.000341 -0.001348 0.007832 -8645 1 0.000269 1560.000000 0.000040 0.002128 0.006074 -8646 1 0.000198 1560.000000 0.001931 -0.000695 0.004837 -8647 1 0.000225 1560.000000 0.001606 -0.002938 0.008658 -8648 1 0.000223 1560.000000 0.001112 -0.000795 0.005974 -8649 1 0.000257 1560.000000 0.000751 0.002133 0.001022 -8650 1 0.000210 1560.000000 0.002407 -0.000384 0.000738 -8651 1 0.000198 1560.000000 -0.002431 0.002770 0.008086 -8652 1 0.000208 1560.000000 0.000576 0.003587 0.007470 -8653 1 0.000194 1560.000000 0.002812 0.000936 0.003297 -8654 1 0.000201 1560.000000 -0.002344 -0.000293 0.002087 -8655 1 0.000234 1560.000000 0.001103 -0.000389 0.004086 -8656 1 0.000214 1560.000000 -0.002410 -0.002441 0.004115 -8657 1 0.000260 1560.000000 0.001551 0.000847 0.003602 -8658 1 0.000277 1560.000000 -0.001631 -0.000846 0.005317 -8659 1 0.000233 1560.000000 -0.003142 -0.001933 0.002509 -8660 1 0.000206 1560.000000 0.003284 0.001074 0.007974 -8661 1 0.000199 1560.000000 -0.000876 0.001067 0.007956 -8662 1 0.000217 1560.000000 -0.000544 0.000191 0.007917 -8663 1 0.000224 1560.000000 0.002336 -0.002015 0.009672 -8664 1 0.000243 1560.000000 0.002373 0.002879 0.006606 -8665 1 0.000258 1560.000000 -0.002752 -0.000182 0.004309 -8666 1 0.000246 1560.000000 0.000547 0.001940 0.008179 -8667 1 0.000205 1560.000000 -0.001204 0.000983 0.005302 -8668 1 0.000204 1560.000000 0.000808 -0.001917 0.001866 -8669 1 0.000194 1560.000000 0.001801 -0.001010 0.002297 -8670 1 0.000200 1560.000000 -0.000121 0.001327 0.006508 -8671 1 0.000225 1560.000000 -0.002010 -0.002649 0.002156 -8672 1 0.000260 1560.000000 0.001769 -0.002508 0.000801 -8673 1 0.000198 1560.000000 -0.002672 -0.002150 0.004100 -8674 1 0.000288 1560.000000 0.000917 0.001567 0.002658 -8675 1 0.000257 1560.000000 0.002006 0.001959 0.002680 -8676 1 0.000274 1560.000000 0.001951 0.000834 0.008060 -8677 1 0.000226 1560.000000 0.001447 0.001730 0.005810 -8678 1 0.000237 1560.000000 -0.000107 0.002636 0.008076 -8679 1 0.000222 1560.000000 -0.002010 0.000783 0.006148 -8680 1 0.000252 1560.000000 -0.000798 -0.000658 0.008008 -8681 1 0.000193 1560.000000 0.000646 -0.000745 0.007321 -8682 1 0.000235 1560.000000 -0.000976 -0.000111 0.003081 -8683 1 0.000245 1560.000000 -0.000535 0.001561 0.003403 -8684 1 0.000235 1560.000000 0.000650 0.000952 0.007084 -8685 1 0.000234 1560.000000 -0.002848 0.000632 0.009575 -8686 1 0.000223 1560.000000 -0.002443 -0.000196 0.005902 -8687 1 0.000213 1560.000000 0.000110 0.000002 0.003602 -8688 1 0.000196 1560.000000 0.000380 0.003256 0.008667 -8689 1 0.000193 1560.000000 -0.000566 -0.002927 0.000769 -8690 1 0.000287 1560.000000 0.002700 0.002044 0.003511 -8691 1 0.000248 1560.000000 -0.000539 0.002357 0.008703 -8692 1 0.000277 1560.000000 0.003307 -0.000854 0.009297 -8693 1 0.000222 1560.000000 -0.002107 -0.003099 0.009167 -8694 1 0.000206 1560.000000 0.000682 -0.001021 0.001824 -8695 1 0.000193 1560.000000 -0.002233 0.003122 0.005466 -8696 1 0.000210 1560.000000 0.001104 -0.001873 0.006139 -8697 1 0.000233 1560.000000 0.000045 -0.000646 0.008584 -8698 1 0.000220 1560.000000 -0.002853 -0.001496 0.004787 -8699 1 0.000218 1560.000000 0.000743 0.001976 0.002501 -8700 1 0.000220 1560.000000 -0.001637 0.003482 0.004897 -8701 1 0.000258 1560.000000 0.002250 -0.000323 0.008252 -8702 1 0.000225 1560.000000 0.002759 -0.000612 0.001650 -8703 1 0.000249 1560.000000 0.001269 -0.001886 0.001258 -8704 1 0.000281 1560.000000 -0.000601 -0.002513 0.003794 -8705 1 0.000266 1560.000000 0.002513 -0.001215 0.006391 -8706 1 0.000208 1560.000000 -0.003324 -0.001695 0.001110 -8707 1 0.000220 1560.000000 0.000286 0.001816 0.007205 -8708 1 0.000284 1560.000000 -0.001887 -0.001089 0.004544 -8709 1 0.000249 1560.000000 -0.000819 -0.000149 0.006082 -8710 1 0.000282 1560.000000 -0.003270 0.001756 0.007131 -8711 1 0.000270 1560.000000 0.001102 -0.001882 0.002467 -8712 1 0.000208 1560.000000 0.001507 -0.003085 0.003946 -8713 1 0.000214 1560.000000 -0.000767 -0.001645 0.000373 -8714 1 0.000244 1560.000000 0.002372 -0.000773 0.008701 -8715 1 0.000207 1560.000000 0.000619 -0.002158 0.009572 -8716 1 0.000239 1560.000000 -0.001363 -0.000133 0.000791 -8717 1 0.000261 1560.000000 -0.001518 0.002537 0.001045 -8718 1 0.000200 1560.000000 0.002697 -0.001115 0.003227 -8719 1 0.000221 1560.000000 0.002865 0.002148 0.005855 -8720 1 0.000244 1560.000000 0.002711 -0.001597 0.004162 -8721 1 0.000219 1560.000000 0.000476 -0.001159 0.004206 -8722 1 0.000221 1560.000000 -0.001869 -0.000671 0.007830 -8723 1 0.000223 1560.000000 -0.000460 -0.003264 0.001932 -8724 1 0.000193 1560.000000 0.003686 -0.000339 0.009190 -8725 1 0.000216 1560.000000 -0.000572 -0.001856 0.009712 -8726 1 0.000219 1560.000000 -0.000574 0.001431 0.009433 -8727 1 0.000218 1560.000000 0.002523 -0.000030 0.003764 -8728 1 0.000255 1560.000000 -0.003032 -0.002330 0.002360 -8729 1 0.000208 1560.000000 -0.000653 -0.001511 0.004499 -8730 1 0.000249 1560.000000 -0.002569 0.002359 0.009641 -8731 1 0.000234 1560.000000 0.002456 0.001219 0.008567 -8732 1 0.000196 1560.000000 -0.002715 -0.000931 0.002132 -8733 1 0.000210 1560.000000 -0.002177 0.001087 0.000214 -8734 1 0.000210 1560.000000 0.001206 0.002963 0.003568 -8735 1 0.000224 1560.000000 0.000935 -0.001763 0.002071 -8736 1 0.000201 1560.000000 -0.002890 0.000417 0.004585 -8737 1 0.000248 1560.000000 0.000223 -0.001062 0.005241 -8738 1 0.000246 1560.000000 0.001538 0.000359 0.001763 -8739 1 0.000202 1560.000000 -0.001529 -0.001895 0.003007 -8740 1 0.000239 1560.000000 0.002479 0.002802 0.002816 -8741 1 0.000237 1560.000000 -0.002191 0.001833 0.004275 -8742 1 0.000219 1560.000000 0.001797 -0.001645 0.008515 -8743 1 0.000229 1560.000000 0.002594 -0.002296 0.001869 -8744 1 0.000219 1560.000000 -0.000103 0.001915 0.002558 -8745 1 0.000225 1560.000000 0.000349 -0.000814 0.004213 -8746 1 0.000249 1560.000000 -0.000686 0.002781 0.000811 -8747 1 0.000221 1560.000000 0.000229 0.003356 0.000856 -8748 1 0.000232 1560.000000 0.003536 -0.000612 0.007119 -8749 1 0.000229 1560.000000 -0.000340 -0.002777 0.000492 -8750 1 0.000245 1560.000000 -0.000518 -0.003056 0.008037 -8751 1 0.000283 1560.000000 0.002093 0.003114 0.007536 -8752 1 0.000236 1560.000000 -0.001649 -0.001443 0.009446 -8753 1 0.000253 1560.000000 -0.002946 0.001592 0.000169 -8754 1 0.000209 1560.000000 -0.001295 -0.002691 0.006913 -8755 1 0.000286 1560.000000 0.003735 -0.000481 0.008815 -8756 1 0.000198 1560.000000 -0.001746 0.000188 0.006886 -8757 1 0.000219 1560.000000 0.001211 -0.000083 0.004613 -8758 1 0.000217 1560.000000 0.001424 -0.001933 0.001039 -8759 1 0.000257 1560.000000 -0.002824 0.002484 0.008678 -8760 1 0.000228 1560.000000 0.003012 0.001889 0.002498 -8761 1 0.000215 1560.000000 0.002375 0.000688 0.003571 -8762 1 0.000201 1560.000000 -0.000039 -0.002081 0.001567 -8763 1 0.000222 1560.000000 0.003179 0.000687 0.005833 -8764 1 0.000193 1560.000000 -0.002761 -0.001508 0.004534 -8765 1 0.000216 1560.000000 -0.002855 -0.000547 0.006080 -8766 1 0.000227 1560.000000 -0.000221 0.001488 0.001567 -8767 1 0.000194 1560.000000 0.000840 -0.000184 0.009253 -8768 1 0.000272 1560.000000 -0.003158 -0.000210 0.000724 -8769 1 0.000195 1560.000000 0.001135 0.002277 0.006663 -8770 1 0.000222 1560.000000 -0.002558 0.002253 0.008586 -8771 1 0.000264 1560.000000 0.001098 -0.002427 0.007016 -8772 1 0.000241 1560.000000 -0.000365 -0.003429 0.006489 -8773 1 0.000209 1560.000000 -0.001589 0.001754 0.000673 -8774 1 0.000238 1560.000000 -0.003124 -0.000602 0.000178 -8775 1 0.000287 1560.000000 -0.001695 -0.003276 0.008737 -8776 1 0.000285 1560.000000 0.000065 -0.002327 0.001771 -8777 1 0.000202 1560.000000 0.001906 0.000741 0.000449 -8778 1 0.000248 1560.000000 0.003798 -0.000441 0.003723 -8779 1 0.000211 1560.000000 0.002253 0.003087 0.006072 -8780 1 0.000273 1560.000000 -0.000500 0.003329 0.002670 -8781 1 0.000201 1560.000000 0.002799 -0.000804 0.003810 -8782 1 0.000251 1560.000000 0.002228 0.000195 0.005795 -8783 1 0.000219 1560.000000 -0.000038 0.000332 0.009756 -8784 1 0.000242 1560.000000 -0.002601 -0.000168 0.000864 -8785 1 0.000268 1560.000000 -0.001543 0.002418 0.006311 -8786 1 0.000246 1560.000000 -0.001241 -0.002648 0.008553 -8787 1 0.000229 1560.000000 0.002404 -0.000666 0.007148 -8788 1 0.000267 1560.000000 -0.001929 0.000288 0.008870 -8789 1 0.000212 1560.000000 0.002082 0.003203 0.006642 -8790 1 0.000263 1560.000000 -0.000860 0.001580 0.003494 -8791 1 0.000275 1560.000000 -0.001568 0.000816 0.003272 -8792 1 0.000203 1560.000000 0.001045 -0.002658 0.006929 -8793 1 0.000242 1560.000000 0.000844 0.002732 0.006950 -8794 1 0.000238 1560.000000 0.001924 0.000786 0.001460 -8795 1 0.000228 1560.000000 -0.002444 0.001513 0.004428 -8796 1 0.000200 1560.000000 0.001097 -0.000272 0.006160 -8797 1 0.000263 1560.000000 0.001167 -0.003057 0.004574 -8798 1 0.000285 1560.000000 0.003408 0.001708 0.008999 -8799 1 0.000215 1560.000000 0.002034 -0.000498 0.002252 -8800 1 0.000246 1560.000000 -0.001749 -0.001905 0.006615 -8801 1 0.000202 1560.000000 -0.000523 -0.003196 0.000282 -8802 1 0.000199 1560.000000 0.001165 0.003309 0.006036 -8803 1 0.000196 1560.000000 -0.001804 -0.001414 0.000218 -8804 1 0.000246 1560.000000 -0.000221 0.002864 0.000510 -8805 1 0.000227 1560.000000 0.000814 -0.001206 0.003381 -8806 1 0.000257 1560.000000 -0.001858 0.000612 0.007074 -8807 1 0.000215 1560.000000 0.003223 -0.001487 0.004668 -8808 1 0.000257 1560.000000 0.002052 -0.001505 0.005429 -8809 1 0.000196 1560.000000 -0.001197 -0.001898 0.005303 -8810 1 0.000253 1560.000000 -0.001848 -0.000908 0.002119 -8811 1 0.000205 1560.000000 0.002374 -0.000305 0.001545 -8812 1 0.000206 1560.000000 0.002958 0.002205 0.002186 -8813 1 0.000206 1560.000000 -0.002698 -0.001419 0.005179 -8814 1 0.000259 1560.000000 0.000076 0.002003 0.007601 -8815 1 0.000241 1560.000000 0.000005 0.002119 0.007853 -8816 1 0.000238 1560.000000 -0.000344 0.001990 0.006779 -8817 1 0.000273 1560.000000 0.001852 -0.002007 0.009320 -8818 1 0.000275 1560.000000 0.000673 -0.000314 0.002983 -8819 1 0.000245 1560.000000 0.001273 0.003037 0.000924 -8820 1 0.000286 1560.000000 0.001876 0.003202 0.003353 -8821 1 0.000225 1560.000000 -0.000074 -0.003767 0.005368 -8822 1 0.000273 1560.000000 0.002859 -0.002223 0.006225 -8823 1 0.000198 1560.000000 0.002800 -0.000939 0.007343 -8824 1 0.000217 1560.000000 0.001233 0.001825 0.000298 -8825 1 0.000276 1560.000000 -0.000639 -0.003692 0.001976 -8826 1 0.000195 1560.000000 0.001172 0.002813 0.006010 -8827 1 0.000278 1560.000000 0.003262 -0.000393 0.009318 -8828 1 0.000241 1560.000000 0.001638 0.000369 0.008332 -8829 1 0.000257 1560.000000 -0.000040 -0.003818 0.001113 -8830 1 0.000235 1560.000000 -0.001412 -0.002747 0.000407 -8831 1 0.000204 1560.000000 0.001772 -0.000639 0.001370 -8832 1 0.000203 1560.000000 -0.001686 -0.000705 0.007680 -8833 1 0.000214 1560.000000 -0.002210 -0.002068 0.006763 -8834 1 0.000270 1560.000000 0.001445 0.002315 0.001951 -8835 1 0.000232 1560.000000 0.000672 -0.002377 0.007999 -8836 1 0.000215 1560.000000 0.002313 -0.002554 0.004670 -8837 1 0.000237 1560.000000 0.003420 0.000230 0.007782 -8838 1 0.000266 1560.000000 0.002031 -0.002057 0.006770 -8839 1 0.000233 1560.000000 0.000298 0.001359 0.000546 -8840 1 0.000243 1560.000000 -0.002210 -0.001476 0.006342 -8841 1 0.000238 1560.000000 0.003377 0.001145 0.004667 -8842 1 0.000193 1560.000000 -0.003345 -0.000273 0.009794 -8843 1 0.000273 1560.000000 -0.000477 0.003008 0.001664 -8844 1 0.000279 1560.000000 -0.003803 -0.000607 0.007093 -8845 1 0.000211 1560.000000 -0.002523 -0.002380 0.007541 -8846 1 0.000236 1560.000000 0.000396 0.002710 0.009707 -8847 1 0.000212 1560.000000 -0.001886 0.003167 0.007694 -8848 1 0.000216 1560.000000 0.001381 0.002563 0.001836 -8849 1 0.000221 1560.000000 0.002009 0.000907 0.006691 -8850 1 0.000245 1560.000000 0.001784 0.000929 0.002537 -8851 1 0.000205 1560.000000 0.000760 0.003181 0.003226 -8852 1 0.000216 1560.000000 0.000930 0.000083 0.007500 -8853 1 0.000217 1560.000000 -0.003083 0.000007 0.005470 -8854 1 0.000244 1560.000000 0.000452 0.000092 0.004863 -8855 1 0.000230 1560.000000 0.001674 -0.000344 0.006261 -8856 1 0.000210 1560.000000 -0.002579 -0.000782 0.003265 -8857 1 0.000194 1560.000000 -0.001040 0.003124 0.002404 -8858 1 0.000239 1560.000000 0.001625 0.000827 0.007133 -8859 1 0.000245 1560.000000 -0.000389 0.000081 0.006259 -8860 1 0.000222 1560.000000 -0.001747 0.001783 0.002162 -8861 1 0.000247 1560.000000 0.002935 -0.000896 0.002576 -8862 1 0.000281 1560.000000 0.002635 -0.001622 0.008169 -8863 1 0.000283 1560.000000 -0.003841 0.000215 0.007074 -8864 1 0.000225 1560.000000 -0.000723 -0.000775 0.000909 -8865 1 0.000207 1560.000000 0.002286 0.002416 0.005142 -8866 1 0.000225 1560.000000 -0.000936 0.001947 0.000194 -8867 1 0.000215 1560.000000 -0.000632 -0.001065 0.009203 -8868 1 0.000204 1560.000000 0.000344 -0.002438 0.008733 -8869 1 0.000201 1560.000000 0.000298 0.000926 0.004246 -8870 1 0.000273 1560.000000 0.001463 0.000544 0.005799 -8871 1 0.000193 1560.000000 0.000577 0.000557 0.002415 -8872 1 0.000220 1560.000000 0.000278 -0.002212 0.004961 -8873 1 0.000263 1560.000000 -0.000247 0.001310 0.004128 -8874 1 0.000236 1560.000000 -0.002768 -0.000741 0.006263 -8875 1 0.000252 1560.000000 0.003234 -0.000529 0.004544 -8876 1 0.000247 1560.000000 -0.000046 -0.001918 0.005110 -8877 1 0.000200 1560.000000 0.001811 -0.002377 0.002278 -8878 1 0.000214 1560.000000 0.001280 0.001540 0.008955 -8879 1 0.000233 1560.000000 -0.001725 0.001781 0.002954 -8880 1 0.000234 1560.000000 -0.002005 -0.000203 0.005969 -8881 1 0.000230 1560.000000 -0.000196 -0.000622 0.000473 -8882 1 0.000195 1560.000000 -0.000947 0.003534 0.000356 -8883 1 0.000224 1560.000000 0.000718 0.001371 0.000256 -8884 1 0.000250 1560.000000 0.001366 0.003462 0.002348 -8885 1 0.000229 1560.000000 -0.001669 0.002891 0.008252 -8886 1 0.000211 1560.000000 -0.003611 -0.000049 0.008662 -8887 1 0.000204 1560.000000 0.003516 -0.000720 0.005888 -8888 1 0.000258 1560.000000 0.001799 0.000410 0.002444 -8889 1 0.000285 1560.000000 0.002587 0.001993 0.005518 -8890 1 0.000250 1560.000000 -0.001791 0.000695 0.004139 -8891 1 0.000216 1560.000000 -0.002178 -0.001658 0.004997 -8892 1 0.000281 1560.000000 0.001919 -0.000279 0.002431 -8893 1 0.000271 1560.000000 -0.003713 0.000513 0.005683 -8894 1 0.000253 1560.000000 0.002853 0.002490 0.007949 -8895 1 0.000219 1560.000000 -0.003015 0.000795 0.008008 -8896 1 0.000256 1560.000000 0.001404 -0.002004 0.002315 -8897 1 0.000269 1560.000000 -0.001981 -0.002285 0.002510 -8898 1 0.000218 1560.000000 0.000074 0.002146 0.002290 -8899 1 0.000204 1560.000000 0.002005 -0.000579 0.003175 -8900 1 0.000207 1560.000000 -0.003309 -0.001821 0.008766 -8901 1 0.000276 1560.000000 -0.001124 -0.000298 0.002524 -8902 1 0.000234 1560.000000 0.001652 -0.001188 0.003197 -8903 1 0.000222 1560.000000 -0.000681 -0.003624 0.009480 -8904 1 0.000233 1560.000000 -0.000126 0.002637 0.003196 -8905 1 0.000247 1560.000000 0.001310 -0.000694 0.004299 -8906 1 0.000267 1560.000000 -0.000571 0.002468 0.004063 -8907 1 0.000262 1560.000000 -0.000897 0.003051 0.004897 -8908 1 0.000196 1560.000000 -0.002114 0.001919 0.003321 -8909 1 0.000205 1560.000000 0.002119 -0.000085 0.007504 -8910 1 0.000225 1560.000000 0.001608 -0.001670 0.003174 -8911 1 0.000202 1560.000000 0.001196 -0.000921 0.001285 -8912 1 0.000193 1560.000000 0.000708 -0.002314 0.009377 -8913 1 0.000283 1560.000000 0.001076 0.001208 0.002728 -8914 1 0.000251 1560.000000 0.000029 0.003342 0.004202 -8915 1 0.000273 1560.000000 -0.002247 -0.002099 0.000808 -8916 1 0.000236 1560.000000 -0.000376 -0.000913 0.004006 -8917 1 0.000244 1560.000000 -0.001857 0.001234 0.004553 -8918 1 0.000200 1560.000000 0.000567 -0.002894 0.006093 -8919 1 0.000255 1560.000000 0.003562 0.001070 0.001987 -8920 1 0.000230 1560.000000 -0.000405 -0.003223 0.006676 -8921 1 0.000194 1560.000000 0.002160 -0.002538 0.008857 -8922 1 0.000210 1560.000000 0.001999 0.000923 0.009058 -8923 1 0.000204 1560.000000 0.000637 -0.000443 0.006157 -8924 1 0.000238 1560.000000 -0.002576 0.000744 0.009355 -8925 1 0.000200 1560.000000 0.000611 -0.000242 0.005715 -8926 1 0.000199 1560.000000 0.001724 -0.002237 0.006872 -8927 1 0.000201 1560.000000 0.003447 0.001393 0.002113 -8928 1 0.000235 1560.000000 -0.000082 -0.001628 0.008766 -8929 1 0.000243 1560.000000 0.002208 0.001025 0.004110 -8930 1 0.000203 1560.000000 -0.002487 -0.000509 0.000435 -8931 1 0.000215 1560.000000 -0.001054 0.003449 0.001931 -8932 1 0.000264 1560.000000 0.001714 0.002075 0.000856 -8933 1 0.000231 1560.000000 0.001519 -0.002144 0.003489 -8934 1 0.000233 1560.000000 -0.002835 -0.000841 0.001127 -8935 1 0.000213 1560.000000 0.003609 0.000816 0.001435 -8936 1 0.000237 1560.000000 0.001636 0.002010 0.003072 -8937 1 0.000230 1560.000000 0.000233 -0.002228 0.003682 -8938 1 0.000233 1560.000000 -0.000899 0.000118 0.009517 -8939 1 0.000236 1560.000000 -0.001610 -0.002223 0.001678 -8940 1 0.000256 1560.000000 -0.001159 0.000813 0.000364 -8941 1 0.000264 1560.000000 0.001400 0.002426 0.002439 -8942 1 0.000203 1560.000000 -0.003181 0.001046 0.002116 -8943 1 0.000205 1560.000000 0.001632 -0.002816 0.009507 -8944 1 0.000216 1560.000000 -0.003346 -0.001042 0.003815 -8945 1 0.000216 1560.000000 -0.002244 0.002530 0.007067 -8946 1 0.000233 1560.000000 -0.000752 -0.001055 0.006372 -8947 1 0.000221 1560.000000 -0.000316 -0.002484 0.006742 -8948 1 0.000259 1560.000000 -0.000030 0.001969 0.000395 -8949 1 0.000206 1560.000000 0.000589 0.002634 0.005755 -8950 1 0.000244 1560.000000 0.002565 -0.002719 0.005964 -8951 1 0.000275 1560.000000 -0.000313 -0.001419 0.001521 -8952 1 0.000195 1560.000000 0.000159 0.001193 0.006947 -8953 1 0.000229 1560.000000 -0.002041 -0.002699 0.009344 -8954 1 0.000283 1560.000000 -0.001104 -0.002632 0.003353 -8955 1 0.000210 1560.000000 -0.001165 0.000187 0.004555 -8956 1 0.000232 1560.000000 0.001047 0.002052 0.008713 -8957 1 0.000233 1560.000000 -0.000510 -0.003810 0.006938 -8958 1 0.000242 1560.000000 -0.001492 0.002073 0.001823 -8959 1 0.000259 1560.000000 0.003048 0.001810 0.005818 -8960 1 0.000280 1560.000000 0.001567 -0.003460 0.002160 -8961 1 0.000227 1560.000000 -0.002167 -0.000860 0.007594 -8962 1 0.000201 1560.000000 0.001939 0.003243 0.001166 -8963 1 0.000231 1560.000000 0.003198 0.001435 0.005760 -8964 1 0.000255 1560.000000 0.001236 -0.000337 0.007465 -8965 1 0.000197 1560.000000 -0.002411 -0.000839 0.009139 -8966 1 0.000193 1560.000000 0.001266 -0.001736 0.002322 -8967 1 0.000197 1560.000000 0.000195 0.003388 0.008702 -8968 1 0.000215 1560.000000 0.001956 0.000877 0.005308 -8969 1 0.000253 1560.000000 -0.002500 -0.000446 0.005106 -8970 1 0.000250 1560.000000 0.003530 -0.001218 0.004298 -8971 1 0.000230 1560.000000 0.002152 0.000917 0.005613 -8972 1 0.000237 1560.000000 -0.000971 0.000843 0.003433 -8973 1 0.000238 1560.000000 -0.002681 -0.001081 0.009264 -8974 1 0.000200 1560.000000 -0.003235 0.000811 0.009021 -8975 1 0.000225 1560.000000 0.000503 -0.000334 0.006881 -8976 1 0.000285 1560.000000 -0.000527 -0.001278 0.006495 -8977 1 0.000239 1560.000000 -0.000098 0.003634 0.006800 -8978 1 0.000194 1560.000000 -0.001083 0.002914 0.008867 -8979 1 0.000201 1560.000000 -0.001335 0.003260 0.004584 -8980 1 0.000268 1560.000000 0.001509 -0.003401 0.001515 -8981 1 0.000232 1560.000000 0.000251 -0.001831 0.006002 -8982 1 0.000233 1560.000000 -0.002573 -0.000495 0.006292 -8983 1 0.000208 1560.000000 0.000141 0.000188 0.009614 -8984 1 0.000227 1560.000000 0.003633 -0.000647 0.003819 -8985 1 0.000222 1560.000000 -0.001572 0.003069 0.001907 -8986 1 0.000259 1560.000000 0.000215 0.003400 0.004862 -8987 1 0.000250 1560.000000 0.003672 0.001133 0.009725 -8988 1 0.000274 1560.000000 0.002961 -0.000683 0.009665 -8989 1 0.000214 1560.000000 0.002662 -0.001348 0.007574 -8990 1 0.000219 1560.000000 0.002138 -0.002939 0.002412 -8991 1 0.000225 1560.000000 0.001884 -0.001375 0.008449 -8992 1 0.000280 1560.000000 -0.000840 -0.001973 0.007170 -8993 1 0.000204 1560.000000 -0.002410 -0.002254 0.007094 -8994 1 0.000218 1560.000000 0.002356 0.002000 0.001960 -8995 1 0.000228 1560.000000 0.000839 0.000967 0.001733 -8996 1 0.000228 1560.000000 -0.000444 0.000354 0.001505 -8997 1 0.000194 1560.000000 -0.001063 0.000355 0.000408 -8998 1 0.000206 1560.000000 -0.002964 0.001687 0.005516 -8999 1 0.000243 1560.000000 0.001982 0.000965 0.002125 -9000 1 0.000261 1560.000000 0.002039 0.002507 0.008274 -9001 1 0.000199 1560.000000 -0.002359 0.002348 0.006718 -9002 1 0.000212 1560.000000 0.000554 0.003023 0.002166 -9003 1 0.000244 1560.000000 0.002548 -0.000012 0.003402 -9004 1 0.000214 1560.000000 0.001432 0.001720 0.004026 -9005 1 0.000197 1560.000000 0.001489 0.000527 0.001132 -9006 1 0.000232 1560.000000 0.001678 -0.001695 0.004375 -9007 1 0.000266 1560.000000 0.001891 -0.002607 0.009262 -9008 1 0.000249 1560.000000 -0.000538 -0.001371 0.004209 -9009 1 0.000224 1560.000000 0.001930 -0.003330 0.004005 -9010 1 0.000239 1560.000000 0.000834 0.001401 0.006456 -9011 1 0.000193 1560.000000 -0.000190 -0.001682 0.006477 -9012 1 0.000218 1560.000000 0.000894 0.002617 0.008859 -9013 1 0.000195 1560.000000 0.000489 -0.002924 0.004385 -9014 1 0.000241 1560.000000 -0.000025 0.003828 0.005615 -9015 1 0.000202 1560.000000 -0.002576 0.000442 0.001209 -9016 1 0.000236 1560.000000 -0.000421 -0.003305 0.005211 -9017 1 0.000239 1560.000000 -0.003549 -0.001240 0.004274 -9018 1 0.000226 1560.000000 -0.000876 -0.000358 0.008906 -9019 1 0.000282 1560.000000 -0.000584 -0.003387 0.000768 -9020 1 0.000213 1560.000000 -0.000967 -0.002125 0.008508 -9021 1 0.000195 1560.000000 0.000414 0.000194 0.007826 -9022 1 0.000251 1560.000000 0.001558 0.003078 0.008059 -9023 1 0.000254 1560.000000 -0.001108 -0.003628 0.006578 -9024 1 0.000265 1560.000000 -0.001837 0.002238 0.001704 -9025 1 0.000197 1560.000000 0.002115 -0.001593 0.004109 -9026 1 0.000214 1560.000000 0.003024 0.001336 0.004660 -9027 1 0.000252 1560.000000 0.000146 -0.003387 0.002637 -9028 1 0.000201 1560.000000 -0.001075 0.003472 0.008652 -9029 1 0.000279 1560.000000 0.001239 0.003503 0.005394 -9030 1 0.000276 1560.000000 -0.000742 -0.001365 0.009373 -9031 1 0.000212 1560.000000 -0.000219 -0.001075 0.008891 -9032 1 0.000230 1560.000000 -0.000569 0.003214 0.007390 -9033 1 0.000199 1560.000000 0.003144 -0.000190 0.003123 -9034 1 0.000208 1560.000000 -0.000684 -0.003788 0.001176 -9035 1 0.000193 1560.000000 -0.000194 0.002659 0.004382 -9036 1 0.000208 1560.000000 -0.001513 -0.003424 0.004105 -9037 1 0.000220 1560.000000 0.001757 0.000964 0.003391 -9038 1 0.000198 1560.000000 0.000416 -0.003403 0.004575 -9039 1 0.000242 1560.000000 -0.000524 0.000323 0.009371 -9040 1 0.000266 1560.000000 0.002815 -0.002433 0.001298 -9041 1 0.000193 1560.000000 -0.001994 -0.001918 0.005449 -9042 1 0.000195 1560.000000 -0.002490 -0.002067 0.007776 -9043 1 0.000284 1560.000000 0.000694 0.001503 0.003629 -9044 1 0.000268 1560.000000 -0.000339 -0.002803 0.006000 -9045 1 0.000194 1560.000000 0.003479 -0.001425 0.008451 -9046 1 0.000235 1560.000000 -0.002734 -0.001560 0.001602 -9047 1 0.000200 1560.000000 0.002410 -0.001258 0.001622 -9048 1 0.000269 1560.000000 -0.001354 -0.000003 0.005712 -9049 1 0.000238 1560.000000 -0.000978 0.000472 0.009721 -9050 1 0.000245 1560.000000 0.003016 -0.001299 0.009739 -9051 1 0.000244 1560.000000 0.001730 0.002631 0.001560 -9052 1 0.000253 1560.000000 -0.002367 -0.000691 0.007938 -9053 1 0.000218 1560.000000 -0.002221 0.000304 0.009231 -9054 1 0.000237 1560.000000 0.000821 0.001991 0.006218 -9055 1 0.000238 1560.000000 0.002559 0.000858 0.001242 -9056 1 0.000239 1560.000000 0.002881 0.002479 0.000433 -9057 1 0.000241 1560.000000 0.000200 0.001562 0.006596 -9058 1 0.000229 1560.000000 0.001307 -0.000590 0.009585 -9059 1 0.000196 1560.000000 -0.001710 -0.002644 0.008143 -9060 1 0.000211 1560.000000 -0.002910 -0.001607 0.000847 -9061 1 0.000246 1560.000000 0.002558 -0.002768 0.009561 -9062 1 0.000253 1560.000000 0.002794 0.000852 0.009222 -9063 1 0.000226 1560.000000 0.000350 0.001249 0.002596 -9064 1 0.000209 1560.000000 -0.001217 0.002237 0.000479 -9065 1 0.000222 1560.000000 -0.003182 0.001069 0.005820 -9066 1 0.000266 1560.000000 -0.000268 -0.003186 0.000543 -9067 1 0.000235 1560.000000 -0.002333 0.002240 0.007997 -9068 1 0.000223 1560.000000 0.002873 0.000183 0.005247 -9069 1 0.000237 1560.000000 -0.001812 -0.001211 0.008989 -9070 1 0.000205 1560.000000 0.000871 -0.000712 0.004024 -9071 1 0.000250 1560.000000 -0.002911 0.002327 0.003065 -9072 1 0.000261 1560.000000 0.003457 0.000880 0.003098 -9073 1 0.000245 1560.000000 0.000771 -0.003115 0.006759 -9074 1 0.000265 1560.000000 0.000852 -0.001483 0.002726 -9075 1 0.000285 1560.000000 -0.003161 0.002042 0.008703 -9076 1 0.000247 1560.000000 0.000396 -0.003806 0.000370 -9077 1 0.000231 1560.000000 -0.000196 -0.003025 0.009535 -9078 1 0.000249 1560.000000 -0.000461 -0.002452 0.000672 -9079 1 0.000195 1560.000000 -0.002190 -0.002622 0.001201 -9080 1 0.000210 1560.000000 -0.000253 -0.002136 0.009036 -9081 1 0.000238 1560.000000 0.001844 0.001918 0.004744 -9082 1 0.000218 1560.000000 -0.000756 -0.000845 0.004897 -9083 1 0.000230 1560.000000 -0.000819 0.001074 0.003548 -9084 1 0.000243 1560.000000 -0.001876 -0.003005 0.001505 -9085 1 0.000228 1560.000000 -0.000447 0.001344 0.001098 -9086 1 0.000200 1560.000000 -0.000400 0.000643 0.008815 -9087 1 0.000209 1560.000000 0.000166 -0.000044 0.006211 -9088 1 0.000236 1560.000000 0.001264 0.003338 0.004587 -9089 1 0.000263 1560.000000 0.002937 0.001558 0.001244 -9090 1 0.000256 1560.000000 -0.002578 -0.000281 0.009098 -9091 1 0.000248 1560.000000 0.002427 0.001203 0.003938 -9092 1 0.000202 1560.000000 -0.003257 0.001710 0.005153 -9093 1 0.000229 1560.000000 -0.001026 0.001235 0.001263 -9094 1 0.000241 1560.000000 0.002010 -0.002719 0.007279 -9095 1 0.000237 1560.000000 -0.000268 0.001993 0.005952 -9096 1 0.000236 1560.000000 -0.001797 0.000528 0.009005 -9097 1 0.000205 1560.000000 -0.001351 0.003492 0.008201 -9098 1 0.000216 1560.000000 0.000332 -0.003402 0.004035 -9099 1 0.000197 1560.000000 -0.000342 -0.001884 0.002022 -9100 1 0.000258 1560.000000 -0.000871 -0.000434 0.008226 -9101 1 0.000284 1560.000000 0.000496 0.001162 0.004305 -9102 1 0.000201 1560.000000 0.002718 -0.000007 0.007805 -9103 1 0.000265 1560.000000 -0.000599 -0.003637 0.008034 -9104 1 0.000280 1560.000000 -0.001606 -0.001292 0.002271 -9105 1 0.000284 1560.000000 -0.001447 0.002644 0.002818 -9106 1 0.000262 1560.000000 0.000860 -0.001573 0.001848 -9107 1 0.000199 1560.000000 -0.002869 0.001279 0.008315 -9108 1 0.000229 1560.000000 -0.001114 -0.001902 0.001796 -9109 1 0.000256 1560.000000 0.003740 0.000570 0.003950 -9110 1 0.000229 1560.000000 0.000113 -0.002754 0.001575 -9111 1 0.000221 1560.000000 0.002695 -0.001263 0.000124 -9112 1 0.000285 1560.000000 0.002657 -0.002643 0.008541 -9113 1 0.000278 1560.000000 0.001963 -0.000180 0.007743 -9114 1 0.000207 1560.000000 0.000031 0.002036 0.004961 -9115 1 0.000212 1560.000000 -0.002819 -0.000957 0.001437 -9116 1 0.000217 1560.000000 -0.001633 -0.002592 0.005627 -9117 1 0.000217 1560.000000 -0.000685 -0.002100 0.000884 -9118 1 0.000212 1560.000000 0.000063 -0.002380 0.005958 -9119 1 0.000235 1560.000000 0.000867 0.003226 0.007652 -9120 1 0.000201 1560.000000 0.000252 -0.003292 0.000887 -9121 1 0.000264 1560.000000 -0.000153 0.001603 0.005716 -9122 1 0.000193 1560.000000 -0.001728 -0.001013 0.000178 -9123 1 0.000273 1560.000000 0.001564 0.001865 0.007192 -9124 1 0.000192 1560.000000 0.001214 -0.003368 0.005352 -9125 1 0.000259 1560.000000 0.002885 -0.002023 0.004381 -9126 1 0.000195 1560.000000 -0.002400 0.002110 0.008759 -9127 1 0.000208 1560.000000 -0.002168 -0.000773 0.008514 -9128 1 0.000256 1560.000000 0.000759 -0.001989 0.009448 -9129 1 0.000213 1560.000000 -0.002486 0.002792 0.003885 -9130 1 0.000195 1560.000000 -0.001337 0.000335 0.009776 -9131 1 0.000215 1560.000000 0.000669 -0.000161 0.008190 -9132 1 0.000214 1560.000000 0.000341 -0.003157 0.007757 -9133 1 0.000203 1560.000000 -0.000174 -0.000896 0.008130 -9134 1 0.000218 1560.000000 0.000919 0.002470 0.003280 -9135 1 0.000253 1560.000000 -0.001152 0.002504 0.004268 -9136 1 0.000211 1560.000000 0.000666 0.000094 0.007158 -9137 1 0.000288 1560.000000 -0.001763 -0.000435 0.001067 -9138 1 0.000246 1560.000000 0.001145 0.001248 0.006657 -9139 1 0.000273 1560.000000 -0.001857 -0.001429 0.003674 -9140 1 0.000273 1560.000000 -0.001118 -0.000282 0.003527 -9141 1 0.000220 1560.000000 -0.001618 0.001730 0.001444 -9142 1 0.000205 1560.000000 -0.003725 0.000674 0.009152 -9143 1 0.000226 1560.000000 -0.001406 -0.000684 0.003357 -9144 1 0.000223 1560.000000 -0.000014 -0.001069 0.006637 -9145 1 0.000286 1560.000000 0.002730 0.001267 0.002375 -9146 1 0.000222 1560.000000 0.001228 0.000509 0.003718 -9147 1 0.000192 1560.000000 0.000325 -0.002201 0.001652 -9148 1 0.000199 1560.000000 0.002122 0.000579 0.008652 -9149 1 0.000217 1560.000000 -0.000569 -0.000326 0.004730 -9150 1 0.000237 1560.000000 0.000802 0.000782 0.004981 -9151 1 0.000241 1560.000000 0.001868 -0.002296 0.008550 -9152 1 0.000193 1560.000000 0.002080 0.001781 0.008797 -9153 1 0.000221 1560.000000 0.002356 0.001875 0.007150 -9154 1 0.000223 1560.000000 -0.002245 0.000850 0.002496 -9155 1 0.000266 1560.000000 0.002958 0.000069 0.003698 -9156 1 0.000288 1560.000000 0.001367 -0.001933 0.008258 -9157 1 0.000235 1560.000000 -0.002380 -0.002580 0.008276 -9158 1 0.000203 1560.000000 -0.000669 0.003256 0.004622 -9159 1 0.000274 1560.000000 0.000236 0.003792 0.007709 -9160 1 0.000271 1560.000000 0.002109 0.000453 0.003241 -9161 1 0.000249 1560.000000 0.002509 0.000740 0.000482 -9162 1 0.000204 1560.000000 0.002950 0.001566 0.001782 -9163 1 0.000202 1560.000000 -0.000019 0.000272 0.000835 -9164 1 0.000217 1560.000000 -0.000343 0.000960 0.004004 -9165 1 0.000219 1560.000000 0.001375 0.001685 0.001443 -9166 1 0.000206 1560.000000 -0.003179 -0.001986 0.006146 -9167 1 0.000212 1560.000000 -0.003287 -0.000341 0.000179 -9168 1 0.000230 1560.000000 -0.001096 -0.003658 0.002889 -9169 1 0.000208 1560.000000 0.000629 -0.000465 0.001154 -9170 1 0.000225 1560.000000 0.003627 0.001230 0.008211 -9171 1 0.000220 1560.000000 -0.002821 0.001567 0.004654 -9172 1 0.000192 1560.000000 0.000679 0.000606 0.000142 -9173 1 0.000202 1560.000000 0.001874 0.000232 0.002013 -9174 1 0.000238 1560.000000 -0.003143 0.000623 0.005707 -9175 1 0.000248 1560.000000 -0.000396 -0.002189 0.006425 -9176 1 0.000235 1560.000000 -0.002125 0.002095 0.001279 -9177 1 0.000195 1560.000000 0.002057 -0.000564 0.009287 -9178 1 0.000204 1560.000000 0.001285 0.002827 0.007234 -9179 1 0.000221 1560.000000 0.000079 0.001671 0.007049 -9180 1 0.000246 1560.000000 -0.001741 0.003439 0.001701 -9181 1 0.000252 1560.000000 -0.003211 -0.001034 0.002521 -9182 1 0.000266 1560.000000 -0.001064 0.003080 0.006341 -9183 1 0.000276 1560.000000 -0.001461 -0.000511 0.001850 -9184 1 0.000257 1560.000000 -0.002632 -0.002298 0.002283 -9185 1 0.000208 1560.000000 -0.000498 0.001781 0.002917 -9186 1 0.000211 1560.000000 -0.003311 0.000870 0.000879 -9187 1 0.000263 1560.000000 -0.002886 0.002235 0.000791 -9188 1 0.000213 1560.000000 -0.001902 0.001691 0.000645 -9189 1 0.000235 1560.000000 -0.003032 -0.001823 0.005417 -9190 1 0.000219 1560.000000 -0.000748 -0.003339 0.003215 -9191 1 0.000256 1560.000000 0.001149 -0.000508 0.001987 -9192 1 0.000206 1560.000000 0.000267 0.000946 0.000712 -9193 1 0.000273 1560.000000 -0.001208 0.000147 0.000603 -9194 1 0.000199 1560.000000 0.002967 -0.000197 0.004733 -9195 1 0.000196 1560.000000 0.001039 -0.000714 0.001986 -9196 1 0.000204 1560.000000 0.000083 -0.002418 0.008505 -9197 1 0.000198 1560.000000 -0.002499 -0.002283 0.001584 -9198 1 0.000278 1560.000000 0.000964 -0.002218 0.009226 -9199 1 0.000257 1560.000000 -0.001001 -0.003135 0.005177 -9200 1 0.000207 1560.000000 -0.001967 -0.001052 0.000277 -9201 1 0.000197 1560.000000 -0.000018 0.001889 0.000823 -9202 1 0.000223 1560.000000 0.002687 -0.000771 0.000989 -9203 1 0.000238 1560.000000 0.002100 0.001759 0.002160 -9204 1 0.000223 1560.000000 -0.002877 -0.001420 0.008639 -9205 1 0.000217 1560.000000 0.001647 0.001244 0.006920 -9206 1 0.000266 1560.000000 0.000440 0.001526 0.000234 -9207 1 0.000212 1560.000000 0.002470 0.002681 0.002508 -9208 1 0.000269 1560.000000 -0.000289 -0.002481 0.003217 -9209 1 0.000206 1560.000000 -0.001234 -0.000840 0.007417 -9210 1 0.000221 1560.000000 -0.002330 -0.000506 0.008456 -9211 1 0.000197 1560.000000 0.000588 -0.001740 0.007404 -9212 1 0.000197 1560.000000 0.001898 -0.001202 0.008197 -9213 1 0.000198 1560.000000 -0.001441 -0.000658 0.009354 -9214 1 0.000256 1560.000000 -0.001616 0.003064 0.003881 -9215 1 0.000244 1560.000000 -0.001490 0.000201 0.005486 -9216 1 0.000278 1560.000000 0.000641 0.002877 0.000377 -9217 1 0.000243 1560.000000 0.003020 0.001625 0.002112 -9218 1 0.000212 1560.000000 0.001136 -0.001352 0.001868 -9219 1 0.000197 1560.000000 -0.002380 0.000532 0.004255 -9220 1 0.000227 1560.000000 -0.001059 -0.000254 0.008706 -9221 1 0.000230 1560.000000 0.003604 0.001183 0.007083 -9222 1 0.000198 1560.000000 0.003340 0.000594 0.006785 -9223 1 0.000226 1560.000000 0.003527 0.001107 0.002873 -9224 1 0.000258 1560.000000 -0.002591 -0.000159 0.007385 -9225 1 0.000260 1560.000000 0.002709 0.001868 0.001802 -9226 1 0.000215 1560.000000 -0.001687 0.002293 0.005101 -9227 1 0.000201 1560.000000 -0.000619 -0.002586 0.008277 -9228 1 0.000192 1560.000000 -0.000920 -0.001931 0.002436 -9229 1 0.000226 1560.000000 -0.003711 0.000196 0.007933 -9230 1 0.000227 1560.000000 -0.001479 -0.002949 0.009785 -9231 1 0.000216 1560.000000 0.000543 -0.002075 0.002409 -9232 1 0.000198 1560.000000 0.000794 -0.000992 0.005314 -9233 1 0.000255 1560.000000 0.003424 -0.001565 0.003091 -9234 1 0.000217 1560.000000 -0.000739 0.000741 0.008876 -9235 1 0.000203 1560.000000 -0.000980 0.000800 0.002022 -9236 1 0.000263 1560.000000 0.000445 -0.002747 0.008366 -9237 1 0.000271 1560.000000 0.002960 0.002172 0.008433 -9238 1 0.000228 1560.000000 0.000066 0.000320 0.000609 -9239 1 0.000265 1560.000000 0.001093 0.000518 0.002147 -9240 1 0.000253 1560.000000 -0.000283 0.002527 0.006762 -9241 1 0.000253 1560.000000 0.002491 -0.002028 0.004955 -9242 1 0.000255 1560.000000 -0.002070 0.002284 0.004603 -9243 1 0.000220 1560.000000 0.001317 -0.003150 0.005895 -9244 1 0.000193 1560.000000 0.000664 -0.000203 0.001730 -9245 1 0.000252 1560.000000 0.002963 -0.001520 0.003497 -9246 1 0.000198 1560.000000 -0.001599 0.002515 0.000481 -9247 1 0.000193 1560.000000 -0.002291 -0.002479 0.007682 -9248 1 0.000205 1560.000000 0.001169 -0.002194 0.000460 -9249 1 0.000256 1560.000000 -0.001653 -0.002810 0.008409 -9250 1 0.000268 1560.000000 0.002942 -0.001809 0.003010 -9251 1 0.000198 1560.000000 0.001002 -0.003699 0.008317 -9252 1 0.000216 1560.000000 -0.003495 -0.000818 0.008061 -9253 1 0.000246 1560.000000 -0.001031 -0.001580 0.007155 -9254 1 0.000260 1560.000000 -0.001726 -0.000709 0.008767 -9255 1 0.000227 1560.000000 0.002275 0.001960 0.004250 -9256 1 0.000271 1560.000000 0.001906 -0.003129 0.009746 -9257 1 0.000286 1560.000000 0.000863 -0.003152 0.008955 -9258 1 0.000202 1560.000000 -0.003218 0.000541 0.009612 -9259 1 0.000227 1560.000000 0.000049 0.000794 0.000136 -9260 1 0.000218 1560.000000 0.000665 0.003601 0.004621 -9261 1 0.000210 1560.000000 0.001507 0.002909 0.009228 -9262 1 0.000287 1560.000000 0.001446 -0.002612 0.007306 -9263 1 0.000233 1560.000000 -0.002254 0.001942 0.009244 -9264 1 0.000203 1560.000000 0.001696 0.000872 0.009356 -9265 1 0.000287 1560.000000 0.003483 0.000038 0.009026 -9266 1 0.000260 1560.000000 0.003099 0.000365 0.007790 -9267 1 0.000195 1560.000000 0.000465 0.003111 0.001402 -9268 1 0.000241 1560.000000 -0.000678 -0.000270 0.009586 -9269 1 0.000230 1560.000000 0.002785 0.001102 0.005207 -9270 1 0.000263 1560.000000 0.002339 -0.002258 0.007379 -9271 1 0.000218 1560.000000 0.003452 -0.000319 0.009025 -9272 1 0.000233 1560.000000 -0.003640 0.000811 0.008567 -9273 1 0.000251 1560.000000 0.000618 0.003679 0.005422 -9274 1 0.000218 1560.000000 0.000664 0.001983 0.002285 -9275 1 0.000247 1560.000000 0.001498 -0.000307 0.008555 -9276 1 0.000193 1560.000000 0.002539 -0.000895 0.008281 -9277 1 0.000247 1560.000000 0.001074 -0.002504 0.002687 -9278 1 0.000205 1560.000000 -0.003473 0.000656 0.002002 -9279 1 0.000194 1560.000000 0.002984 -0.001145 0.004756 -9280 1 0.000233 1560.000000 0.001111 -0.002103 0.004347 -9281 1 0.000267 1560.000000 0.002132 -0.001028 0.002755 -9282 1 0.000275 1560.000000 0.001512 0.003419 0.007826 -9283 1 0.000198 1560.000000 -0.002020 -0.002633 0.004455 -9284 1 0.000201 1560.000000 0.000057 0.001634 0.005450 -9285 1 0.000226 1560.000000 -0.002479 0.002886 0.004245 -9286 1 0.000262 1560.000000 -0.000451 0.002323 0.005561 -9287 1 0.000193 1560.000000 -0.000103 0.001480 0.007282 -9288 1 0.000229 1560.000000 -0.000965 0.001675 0.006824 -9289 1 0.000211 1560.000000 0.001582 0.000788 0.006285 -9290 1 0.000230 1560.000000 -0.002720 -0.001999 0.001015 -9291 1 0.000269 1560.000000 0.002035 -0.001560 0.006502 -9292 1 0.000280 1560.000000 0.000116 0.003113 0.006510 -9293 1 0.000282 1560.000000 0.001014 0.000141 0.008535 -9294 1 0.000196 1560.000000 0.000649 0.003076 0.008909 -9295 1 0.000216 1560.000000 -0.001518 0.003174 0.008355 -9296 1 0.000283 1560.000000 -0.000977 0.003374 0.003946 -9297 1 0.000211 1560.000000 -0.001047 0.001424 0.003704 -9298 1 0.000262 1560.000000 -0.000838 0.003692 0.009008 -9299 1 0.000214 1560.000000 -0.002167 0.001459 0.003654 -9300 1 0.000249 1560.000000 0.001628 -0.001783 0.009707 -9301 1 0.000279 1560.000000 0.002358 0.001919 0.005325 -9302 1 0.000258 1560.000000 0.000598 0.002144 0.009799 -9303 1 0.000200 1560.000000 0.002752 0.001368 0.003257 -9304 1 0.000247 1560.000000 0.003610 -0.000703 0.004190 -9305 1 0.000230 1560.000000 0.000358 -0.003833 0.003844 -9306 1 0.000212 1560.000000 -0.003531 0.000831 0.003265 -9307 1 0.000254 1560.000000 -0.001276 0.000135 0.007664 -9308 1 0.000276 1560.000000 -0.002536 0.001033 0.006729 -9309 1 0.000243 1560.000000 -0.000486 -0.000716 0.003767 -9310 1 0.000202 1560.000000 -0.001537 -0.003450 0.007845 -9311 1 0.000196 1560.000000 0.001963 0.002998 0.000483 -9312 1 0.000250 1560.000000 0.001307 0.002948 0.006394 -9313 1 0.000246 1560.000000 0.000448 -0.002410 0.001968 -9314 1 0.000218 1560.000000 0.001475 -0.001962 0.007979 -9315 1 0.000242 1560.000000 -0.001609 -0.001160 0.003032 -9316 1 0.000227 1560.000000 -0.002300 -0.000516 0.008857 -9317 1 0.000247 1560.000000 0.001103 0.002953 0.008269 -9318 1 0.000278 1560.000000 0.002703 -0.001764 0.003222 -9319 1 0.000250 1560.000000 -0.002027 0.000534 0.007259 -9320 1 0.000223 1560.000000 -0.000479 -0.001101 0.001606 -9321 1 0.000199 1560.000000 -0.000105 0.003158 0.003665 -9322 1 0.000211 1560.000000 0.001538 0.003474 0.001242 -9323 1 0.000198 1560.000000 -0.001194 -0.002236 0.000979 -9324 1 0.000245 1560.000000 -0.001410 0.000456 0.006476 -9325 1 0.000211 1560.000000 -0.001079 -0.001178 0.008559 -9326 1 0.000238 1560.000000 0.002731 0.000680 0.000139 -9327 1 0.000201 1560.000000 0.002704 0.002433 0.005081 -9328 1 0.000223 1560.000000 0.001391 -0.000496 0.004749 -9329 1 0.000235 1560.000000 0.000177 0.003036 0.001681 -9330 1 0.000266 1560.000000 0.001600 -0.001057 0.004088 -9331 1 0.000193 1560.000000 -0.003146 -0.001470 0.008082 -9332 1 0.000222 1560.000000 -0.003251 -0.001861 0.002942 -9333 1 0.000250 1560.000000 0.003290 -0.000857 0.005165 -9334 1 0.000254 1560.000000 -0.002765 -0.002676 0.006585 -9335 1 0.000198 1560.000000 -0.003220 0.000477 0.006864 -9336 1 0.000208 1560.000000 -0.000366 0.001839 0.007697 -9337 1 0.000218 1560.000000 -0.001471 -0.002342 0.007606 -9338 1 0.000273 1560.000000 -0.002170 0.001213 0.006441 -9339 1 0.000230 1560.000000 0.000268 0.003730 0.008451 -9340 1 0.000203 1560.000000 0.000197 -0.000561 0.000914 -9341 1 0.000217 1560.000000 -0.001135 0.002678 0.005828 -9342 1 0.000197 1560.000000 0.002368 -0.000774 0.006891 -9343 1 0.000196 1560.000000 -0.000373 -0.003040 0.008883 -9344 1 0.000193 1560.000000 -0.001172 -0.001826 0.000138 -9345 1 0.000201 1560.000000 -0.000267 0.002961 0.007712 -9346 1 0.000225 1560.000000 -0.003323 0.001291 0.003297 -9347 1 0.000216 1560.000000 -0.001207 -0.002846 0.001409 -9348 1 0.000260 1560.000000 0.000486 0.003422 0.000388 -9349 1 0.000229 1560.000000 -0.000312 0.003819 0.005424 -9350 1 0.000280 1560.000000 -0.001122 -0.003546 0.002496 -9351 1 0.000279 1560.000000 -0.003833 -0.000220 0.005759 -9352 1 0.000277 1560.000000 0.002489 -0.002526 0.008139 -9353 1 0.000224 1560.000000 0.002600 0.002653 0.006613 -9354 1 0.000193 1560.000000 0.002366 -0.001325 0.008706 -9355 1 0.000227 1560.000000 -0.000536 0.000865 0.004151 -9356 1 0.000204 1560.000000 0.000765 -0.002978 0.007952 -9357 1 0.000193 1560.000000 -0.002879 -0.000898 0.006758 -9358 1 0.000251 1560.000000 0.000354 0.002858 0.001600 -9359 1 0.000234 1560.000000 -0.003106 0.001441 0.000923 -9360 1 0.000288 1560.000000 0.001657 0.001409 0.003479 -9361 1 0.000204 1560.000000 0.000023 -0.002725 0.004019 -9362 1 0.000195 1560.000000 -0.000071 0.001717 0.008797 -9363 1 0.000270 1560.000000 0.002189 0.001596 0.004276 -9364 1 0.000215 1560.000000 -0.002956 -0.001220 0.002530 -9365 1 0.000265 1560.000000 -0.000528 -0.002834 0.008729 -9366 1 0.000257 1560.000000 0.001251 0.002859 0.000397 -9367 1 0.000199 1560.000000 0.000809 0.001223 0.004903 -9368 1 0.000250 1560.000000 0.000392 -0.002519 0.009787 -9369 1 0.000279 1560.000000 0.002148 0.000673 0.000723 -9370 1 0.000208 1560.000000 -0.000313 0.002429 0.002671 -9371 1 0.000235 1560.000000 -0.003645 -0.000544 0.008068 -9372 1 0.000204 1560.000000 -0.000567 0.002651 0.004467 -9373 1 0.000202 1560.000000 -0.000841 0.003273 0.007090 -9374 1 0.000219 1560.000000 -0.000261 -0.002181 0.000269 -9375 1 0.000240 1560.000000 -0.000293 0.002328 0.008254 -9376 1 0.000225 1560.000000 0.000727 0.000328 0.009818 -9377 1 0.000256 1560.000000 0.002958 -0.001603 0.009405 -9378 1 0.000239 1560.000000 0.001731 -0.001414 0.002333 -9379 1 0.000269 1560.000000 -0.000163 -0.001691 0.009163 -9380 1 0.000222 1560.000000 0.002560 -0.000051 0.009763 -9381 1 0.000250 1560.000000 -0.000166 0.003737 0.000233 -9382 1 0.000239 1560.000000 -0.003162 -0.000033 0.008777 -9383 1 0.000200 1560.000000 0.001238 0.001706 0.004268 -9384 1 0.000261 1560.000000 -0.000307 -0.002005 0.001193 -9385 1 0.000241 1560.000000 -0.002656 -0.001034 0.001077 -9386 1 0.000213 1560.000000 -0.003389 -0.001673 0.000645 -9387 1 0.000267 1560.000000 0.002752 0.001626 0.000725 -9388 1 0.000250 1560.000000 0.003196 0.001213 0.002597 -9389 1 0.000218 1560.000000 -0.001343 -0.002955 0.008513 -9390 1 0.000211 1560.000000 0.000985 -0.003361 0.004377 -9391 1 0.000248 1560.000000 -0.000404 0.000866 0.005360 -9392 1 0.000196 1560.000000 -0.001399 -0.001617 0.006618 -9393 1 0.000260 1560.000000 -0.002323 0.002037 0.007317 -9394 1 0.000244 1560.000000 0.000622 0.002170 0.006334 -9395 1 0.000246 1560.000000 -0.001267 -0.002178 0.007578 -9396 1 0.000228 1560.000000 0.002650 0.000628 0.004505 -9397 1 0.000242 1560.000000 -0.000675 -0.002963 0.001762 -9398 1 0.000234 1560.000000 0.000230 -0.001627 0.008396 -9399 1 0.000218 1560.000000 0.002312 0.001411 0.008276 -9400 1 0.000224 1560.000000 -0.003762 -0.000372 0.002847 -9401 1 0.000215 1560.000000 0.002768 0.000719 0.005423 -9402 1 0.000219 1560.000000 -0.001146 0.000931 0.003613 -9403 1 0.000193 1560.000000 0.000070 0.002121 0.002545 -9404 1 0.000264 1560.000000 0.002340 0.001676 0.004518 -9405 1 0.000229 1560.000000 -0.000980 0.001843 0.008142 -9406 1 0.000224 1560.000000 -0.002079 -0.001727 0.006538 -9407 1 0.000287 1560.000000 0.000904 0.001199 0.008834 -9408 1 0.000257 1560.000000 -0.002587 0.002588 0.006275 -9409 1 0.000250 1560.000000 -0.002511 0.002866 0.002470 -9410 1 0.000263 1560.000000 0.002495 -0.002410 0.009252 -9411 1 0.000193 1560.000000 0.002036 0.000641 0.001203 -9412 1 0.000272 1560.000000 -0.003642 0.000086 0.002936 -9413 1 0.000203 1560.000000 0.000458 0.001135 0.007981 -9414 1 0.000204 1560.000000 -0.001280 0.001987 0.005828 -9415 1 0.000223 1560.000000 -0.002700 -0.002299 0.000829 -9416 1 0.000229 1560.000000 -0.000286 -0.000282 0.007637 -9417 1 0.000230 1560.000000 -0.002856 0.002573 0.003118 -9418 1 0.000241 1560.000000 -0.001497 -0.002966 0.003372 -9419 1 0.000261 1560.000000 0.000016 -0.003346 0.009244 -9420 1 0.000214 1560.000000 -0.000259 -0.001356 0.000163 -9421 1 0.000229 1560.000000 -0.000437 -0.002456 0.007850 -9422 1 0.000264 1560.000000 0.000448 -0.000534 0.001681 -9423 1 0.000203 1560.000000 -0.000606 -0.000669 0.003174 -9424 1 0.000213 1560.000000 0.003698 -0.000460 0.002267 -9425 1 0.000287 1560.000000 -0.000392 0.001499 0.009747 -9426 1 0.000216 1560.000000 0.000891 -0.001927 0.004678 -9427 1 0.000212 1560.000000 -0.000928 -0.000932 0.003145 -9428 1 0.000200 1560.000000 -0.000965 0.000890 0.002890 -9429 1 0.000223 1560.000000 0.001319 -0.001251 0.005651 -9430 1 0.000261 1560.000000 -0.000230 -0.001828 0.006896 -9431 1 0.000239 1560.000000 0.003577 0.000085 0.002088 -9432 1 0.000231 1560.000000 0.000004 -0.000761 0.000497 -9433 1 0.000279 1560.000000 -0.001250 0.001177 0.008325 -9434 1 0.000248 1560.000000 -0.001448 0.002929 0.001144 -9435 1 0.000217 1560.000000 0.000024 -0.000218 0.000803 -9436 1 0.000201 1560.000000 -0.002895 -0.001397 0.005702 -9437 1 0.000220 1560.000000 0.000300 -0.001158 0.008642 -9438 1 0.000219 1560.000000 -0.003608 0.001289 0.001938 -9439 1 0.000204 1560.000000 0.002760 -0.000279 0.002996 -9440 1 0.000237 1560.000000 0.002804 0.001016 0.008369 -9441 1 0.000245 1560.000000 0.001783 -0.001921 0.004528 -9442 1 0.000234 1560.000000 -0.003727 -0.000896 0.001133 -9443 1 0.000257 1560.000000 -0.000612 0.001338 0.008175 -9444 1 0.000222 1560.000000 0.001462 -0.001707 0.007794 -9445 1 0.000237 1560.000000 -0.001856 -0.002430 0.003522 -9446 1 0.000260 1560.000000 -0.000082 0.003419 0.009712 -9447 1 0.000264 1560.000000 0.000105 0.000667 0.004399 -9448 1 0.000285 1560.000000 -0.002829 -0.000094 0.009850 -9449 1 0.000235 1560.000000 -0.000106 -0.001850 0.003654 -9450 1 0.000226 1560.000000 0.000339 -0.000112 0.003024 -9451 1 0.000254 1560.000000 0.000135 -0.002448 0.004539 -9452 1 0.000207 1560.000000 -0.002746 -0.000321 0.003575 -9453 1 0.000219 1560.000000 -0.000792 -0.002022 0.005704 -9454 1 0.000263 1560.000000 -0.001697 -0.000515 0.009634 -9455 1 0.000248 1560.000000 -0.003441 -0.000871 0.005200 -9456 1 0.000248 1560.000000 0.001736 0.000526 0.006521 -9457 1 0.000282 1560.000000 -0.001971 0.000224 0.001508 -9458 1 0.000206 1560.000000 -0.001314 0.003316 0.000159 -9459 1 0.000236 1560.000000 -0.000718 0.002153 0.005745 -9460 1 0.000240 1560.000000 0.003062 -0.002251 0.000860 -9461 1 0.000265 1560.000000 -0.002432 0.002893 0.009349 -9462 1 0.000264 1560.000000 -0.001660 -0.002857 0.001364 -9463 1 0.000195 1560.000000 0.002528 -0.002292 0.007207 -9464 1 0.000241 1560.000000 -0.002544 -0.002802 0.008929 -9465 1 0.000208 1560.000000 0.001982 -0.001120 0.006755 -9466 1 0.000200 1560.000000 -0.000005 -0.001817 0.000746 -9467 1 0.000218 1560.000000 -0.000769 -0.001807 0.004339 -9468 1 0.000278 1560.000000 0.002742 -0.001629 0.009097 -9469 1 0.000205 1560.000000 0.000749 -0.002598 0.006394 -9470 1 0.000243 1560.000000 -0.000812 0.001468 0.002417 -9471 1 0.000234 1560.000000 0.000515 0.003166 0.000151 -9472 1 0.000229 1560.000000 0.001819 0.001633 0.004154 -9473 1 0.000202 1560.000000 0.001405 0.001711 0.005448 -9474 1 0.000210 1560.000000 0.000149 0.003094 0.000568 -9475 1 0.000228 1560.000000 -0.002002 -0.002891 0.001205 -9476 1 0.000232 1560.000000 -0.003430 0.001712 0.003972 -9477 1 0.000224 1560.000000 0.002725 0.002568 0.005655 -9478 1 0.000215 1560.000000 0.002096 0.000547 0.002011 -9479 1 0.000219 1560.000000 -0.000362 -0.000540 0.002857 -9480 1 0.000227 1560.000000 -0.002331 0.001115 0.003591 -9481 1 0.000206 1560.000000 0.001154 -0.001723 0.007185 -9482 1 0.000242 1560.000000 -0.000466 0.001678 0.003158 -9483 1 0.000233 1560.000000 0.003200 -0.001485 0.003996 -9484 1 0.000198 1560.000000 -0.000082 0.002733 0.003833 -9485 1 0.000207 1560.000000 0.001379 0.000996 0.004997 -9486 1 0.000260 1560.000000 0.001006 -0.003588 0.000426 -9487 1 0.000210 1560.000000 0.001009 0.000671 0.005186 -9488 1 0.000224 1560.000000 -0.000525 0.000614 0.000944 -9489 1 0.000196 1560.000000 0.003547 -0.000727 0.009301 -9490 1 0.000193 1560.000000 0.000208 -0.000207 0.003750 -9491 1 0.000287 1560.000000 0.003149 -0.001238 0.003352 -9492 1 0.000213 1560.000000 -0.000859 0.000767 0.007743 -9493 1 0.000208 1560.000000 0.000562 -0.002434 0.001533 -9494 1 0.000217 1560.000000 0.001653 -0.002637 0.002505 -9495 1 0.000196 1560.000000 -0.002043 -0.000271 0.007223 -9496 1 0.000212 1560.000000 -0.002022 0.002841 0.003372 -9497 1 0.000206 1560.000000 0.001421 0.002599 0.009059 -9498 1 0.000224 1560.000000 0.002051 -0.002718 0.002065 -9499 1 0.000250 1560.000000 0.000858 0.003670 0.000772 -9500 1 0.000266 1560.000000 -0.003613 -0.000844 0.006594 -9501 1 0.000279 1560.000000 -0.001737 -0.001625 0.008687 -9502 1 0.000261 1560.000000 0.002077 0.002642 0.009202 -9503 1 0.000241 1560.000000 -0.002023 -0.003161 0.004628 -9504 1 0.000226 1560.000000 0.001254 -0.002072 0.000820 -9505 1 0.000261 1560.000000 -0.001975 -0.001588 0.001584 -9506 1 0.000194 1560.000000 0.000235 -0.002195 0.007385 -9507 1 0.000226 1560.000000 -0.001024 0.002715 0.007991 -9508 1 0.000261 1560.000000 0.001278 0.000845 0.001180 -9509 1 0.000264 1560.000000 0.002721 0.002664 0.002382 -9510 1 0.000233 1560.000000 0.000407 -0.003542 0.003240 -9511 1 0.000236 1560.000000 0.001535 0.002837 0.009569 -9512 1 0.000281 1560.000000 -0.001476 0.001134 0.000245 -9513 1 0.000202 1560.000000 0.002578 0.002512 0.003954 -9514 1 0.000217 1560.000000 0.000112 0.001847 0.006553 -9515 1 0.000279 1560.000000 0.000371 -0.001513 0.002315 -9516 1 0.000281 1560.000000 -0.003681 -0.000922 0.002955 -9517 1 0.000270 1560.000000 -0.001121 -0.002144 0.003408 -9518 1 0.000233 1560.000000 -0.003682 0.000679 0.002260 -9519 1 0.000277 1560.000000 0.000523 -0.002884 0.003346 -9520 1 0.000225 1560.000000 0.000256 -0.002130 0.008409 -9521 1 0.000216 1560.000000 0.001544 -0.001341 0.007204 -9522 1 0.000200 1560.000000 -0.000879 0.002380 0.002869 -9523 1 0.000280 1560.000000 -0.002879 -0.000304 0.005208 -9524 1 0.000217 1560.000000 -0.003617 -0.000168 0.001293 -9525 1 0.000195 1560.000000 0.001632 -0.002934 0.008195 -9526 1 0.000212 1560.000000 -0.001897 -0.000546 0.004022 -9527 1 0.000253 1560.000000 -0.001007 0.002711 0.003159 -9528 1 0.000228 1560.000000 0.003144 -0.002071 0.005555 -9529 1 0.000216 1560.000000 -0.003515 -0.001043 0.004024 -9530 1 0.000246 1560.000000 -0.001861 0.001249 0.003710 -9531 1 0.000234 1560.000000 0.000045 -0.001987 0.007597 -9532 1 0.000235 1560.000000 -0.000518 -0.002311 0.006896 -9533 1 0.000218 1560.000000 -0.001438 -0.000648 0.008088 -9534 1 0.000215 1560.000000 -0.001419 0.000097 0.004151 -9535 1 0.000194 1560.000000 -0.001766 -0.002616 0.002647 -9536 1 0.000244 1560.000000 -0.002225 0.002467 0.000993 -9537 1 0.000225 1560.000000 0.001142 -0.000267 0.005645 -9538 1 0.000215 1560.000000 0.000672 -0.000836 0.009810 -9539 1 0.000227 1560.000000 -0.003640 -0.000460 0.003721 -9540 1 0.000213 1560.000000 -0.001158 0.001520 0.004035 -9541 1 0.000215 1560.000000 0.002171 0.000188 0.007859 -9542 1 0.000244 1560.000000 -0.000001 0.002223 0.001974 -9543 1 0.000232 1560.000000 0.002492 -0.000357 0.005226 -9544 1 0.000234 1560.000000 -0.000953 -0.001626 0.004713 -9545 1 0.000201 1560.000000 0.001207 -0.002983 0.007744 -9546 1 0.000251 1560.000000 -0.002326 0.000271 0.003454 -9547 1 0.000232 1560.000000 0.002959 -0.002365 0.006563 -9548 1 0.000257 1560.000000 0.001049 0.001973 0.003456 -9549 1 0.000193 1560.000000 0.001760 0.003317 0.002271 -9550 1 0.000213 1560.000000 -0.001254 0.001610 0.007586 -9551 1 0.000242 1560.000000 0.003145 0.000631 0.000252 -9552 1 0.000243 1560.000000 0.000238 0.002136 0.005861 -9553 1 0.000197 1560.000000 -0.000951 0.001701 0.007246 -9554 1 0.000227 1560.000000 -0.001510 0.002394 0.002850 -9555 1 0.000228 1560.000000 -0.003443 0.001019 0.002057 -9556 1 0.000276 1560.000000 0.002228 0.001405 0.001484 -9557 1 0.000194 1560.000000 -0.001421 0.000184 0.008675 -9558 1 0.000281 1560.000000 0.002667 -0.001363 0.003609 -9559 1 0.000229 1560.000000 0.000229 0.003154 0.008280 -9560 1 0.000277 1560.000000 0.000658 -0.002602 0.005907 -9561 1 0.000226 1560.000000 -0.002192 -0.001950 0.001227 -9562 1 0.000267 1560.000000 0.001502 -0.000565 0.002697 -9563 1 0.000223 1560.000000 0.002827 -0.000477 0.008599 -9564 1 0.000253 1560.000000 -0.000749 0.000843 0.007040 -9565 1 0.000245 1560.000000 0.003157 0.000683 0.001755 -9566 1 0.000256 1560.000000 0.001783 0.000075 0.006255 -9567 1 0.000259 1560.000000 -0.000684 0.002580 0.004760 -9568 1 0.000199 1560.000000 -0.002703 0.002122 0.000959 -9569 1 0.000278 1560.000000 0.000884 0.002067 0.008410 -9570 1 0.000246 1560.000000 -0.000181 -0.000028 0.006700 -9571 1 0.000195 1560.000000 0.000286 -0.000399 0.006167 -9572 1 0.000205 1560.000000 -0.002943 -0.001873 0.001234 -9573 1 0.000197 1560.000000 -0.001613 -0.002009 0.002122 -9574 1 0.000199 1560.000000 0.003128 -0.000485 0.006401 -9575 1 0.000208 1560.000000 -0.001494 -0.001786 0.001415 -9576 1 0.000210 1560.000000 -0.003127 0.001208 0.004747 -9577 1 0.000199 1560.000000 -0.002060 0.002312 0.000134 -9578 1 0.000278 1560.000000 0.003181 0.002114 0.005729 -9579 1 0.000195 1560.000000 -0.000874 0.001320 0.002792 -9580 1 0.000222 1560.000000 0.000066 -0.002800 0.007591 -9581 1 0.000208 1560.000000 0.001201 0.001164 0.002953 -9582 1 0.000200 1560.000000 0.000145 -0.000917 0.002878 -9583 1 0.000216 1560.000000 0.000152 -0.001211 0.005831 -9584 1 0.000269 1560.000000 0.001121 0.002186 0.007575 -9585 1 0.000202 1560.000000 0.001164 -0.001259 0.008207 -9586 1 0.000226 1560.000000 -0.002095 -0.001209 0.008124 -9587 1 0.000232 1560.000000 0.002562 -0.002183 0.000818 -9588 1 0.000196 1560.000000 -0.003803 0.000628 0.009654 -9589 1 0.000256 1560.000000 -0.000422 -0.000289 0.003465 -9590 1 0.000197 1560.000000 -0.001929 -0.000820 0.007681 -9591 1 0.000266 1560.000000 -0.000412 -0.000402 0.004213 -9592 1 0.000247 1560.000000 0.000315 -0.001940 0.008035 -9593 1 0.000270 1560.000000 0.000385 -0.003102 0.003192 -9594 1 0.000246 1560.000000 0.001116 -0.001401 0.004179 -9595 1 0.000266 1560.000000 0.000051 0.001311 0.005973 -9596 1 0.000230 1560.000000 0.001010 0.001270 0.005111 -9597 1 0.000253 1560.000000 0.001500 -0.003087 0.008432 -9598 1 0.000279 1560.000000 -0.002278 0.002113 0.005072 -9599 1 0.000200 1560.000000 0.000241 0.001401 0.004885 -9600 1 0.000213 1560.000000 -0.001339 -0.000696 0.002390 -9601 1 0.000214 1560.000000 -0.002454 -0.000890 0.000204 -9602 1 0.000207 1560.000000 -0.001742 -0.000451 0.005358 -9603 1 0.000197 1560.000000 -0.001834 -0.001686 0.008918 -9604 1 0.000248 1560.000000 -0.003622 0.001036 0.008753 -9605 1 0.000207 1560.000000 -0.001883 0.002729 0.005166 -9606 1 0.000249 1560.000000 -0.000021 0.003112 0.002531 -9607 1 0.000269 1560.000000 -0.001921 0.002485 0.005788 -9608 1 0.000260 1560.000000 0.002245 -0.001244 0.004122 -9609 1 0.000217 1560.000000 0.002830 0.000081 0.005813 -9610 1 0.000233 1560.000000 -0.000459 0.002081 0.009324 -9611 1 0.000284 1560.000000 0.003223 -0.001621 0.005429 -9612 1 0.000253 1560.000000 0.001377 -0.002138 0.001204 -9613 1 0.000237 1560.000000 0.001920 0.000995 0.006447 -9614 1 0.000215 1560.000000 -0.002406 0.002337 0.006460 -9615 1 0.000220 1560.000000 0.000065 0.001786 0.001409 -9616 1 0.000286 1560.000000 -0.000884 0.002047 0.000919 -9617 1 0.000245 1560.000000 0.001075 0.001022 0.000726 -9618 1 0.000206 1560.000000 0.000366 0.003487 0.006472 -9619 1 0.000251 1560.000000 0.000468 0.000285 0.009057 -9620 1 0.000281 1560.000000 0.000087 0.001767 0.009518 -9621 1 0.000220 1560.000000 -0.001517 -0.000042 0.000503 -9622 1 0.000231 1560.000000 0.002210 -0.000674 0.002446 -9623 1 0.000237 1560.000000 -0.000263 0.003406 0.006449 -9624 1 0.000196 1560.000000 -0.000022 0.002000 0.008820 -9625 1 0.000222 1560.000000 -0.002982 0.001073 0.006029 -9626 1 0.000195 1560.000000 -0.000025 0.001633 0.006154 -9627 1 0.000254 1560.000000 -0.000427 0.003107 0.007824 -9628 1 0.000246 1560.000000 0.003662 -0.000114 0.004234 -9629 1 0.000269 1560.000000 -0.003099 0.002157 0.006453 -9630 1 0.000207 1560.000000 0.002029 0.000578 0.009219 -9631 1 0.000255 1560.000000 0.001391 -0.002758 0.001182 -9632 1 0.000198 1560.000000 0.002135 0.002126 0.007783 -9633 1 0.000218 1560.000000 0.002801 -0.002063 0.001030 -9634 1 0.000208 1560.000000 -0.002684 0.000941 0.000677 -9635 1 0.000253 1560.000000 0.002139 0.000467 0.004084 -9636 1 0.000197 1560.000000 0.001450 0.002474 0.000205 -9637 1 0.000194 1560.000000 0.002290 0.000009 0.007381 -9638 1 0.000233 1560.000000 -0.001418 -0.002425 0.000531 -9639 1 0.000222 1560.000000 0.000386 0.002885 0.004965 -9640 1 0.000226 1560.000000 0.001687 -0.002286 0.001001 -9641 1 0.000216 1560.000000 -0.001744 -0.001700 0.004735 -9642 1 0.000194 1560.000000 -0.000198 0.000591 0.002897 -9643 1 0.000213 1560.000000 0.000977 0.002361 0.005336 -9644 1 0.000283 1560.000000 -0.002256 -0.002838 0.004671 -9645 1 0.000210 1560.000000 -0.002519 0.002122 0.004483 -9646 1 0.000206 1560.000000 -0.002165 0.001994 0.001969 -9647 1 0.000193 1560.000000 -0.002781 -0.002544 0.008371 -9648 1 0.000247 1560.000000 0.001781 -0.002611 0.008722 -9649 1 0.000208 1560.000000 -0.002551 -0.001715 0.000773 -9650 1 0.000275 1560.000000 -0.002175 -0.003035 0.007056 -9651 1 0.000205 1560.000000 0.000586 -0.000949 0.003600 -9652 1 0.000229 1560.000000 0.000386 -0.001902 0.000494 -9653 1 0.000198 1560.000000 0.002206 0.002862 0.008102 -9654 1 0.000200 1560.000000 0.001059 0.003067 0.009595 -9655 1 0.000247 1560.000000 0.000777 -0.001794 0.004321 -9656 1 0.000265 1560.000000 0.002218 -0.001318 0.000917 -9657 1 0.000197 1560.000000 0.000102 0.002221 0.003343 -9658 1 0.000237 1560.000000 0.000739 0.003473 0.006491 -9659 1 0.000286 1560.000000 0.001836 -0.001647 0.001083 -9660 1 0.000192 1560.000000 -0.002785 -0.000617 0.002471 -9661 1 0.000248 1560.000000 -0.001830 0.000913 0.007683 -9662 1 0.000283 1560.000000 0.001849 0.000090 0.001583 -9663 1 0.000212 1560.000000 -0.000010 -0.002386 0.005656 -9664 1 0.000246 1560.000000 0.000715 0.001086 0.006155 -9665 1 0.000249 1560.000000 -0.002809 -0.002465 0.002172 -9666 1 0.000198 1560.000000 -0.000818 -0.003680 0.002512 -9667 1 0.000198 1560.000000 -0.000585 -0.000735 0.001949 -9668 1 0.000288 1560.000000 -0.003173 0.000257 0.009383 -9669 1 0.000229 1560.000000 0.001311 0.001853 0.004560 -9670 1 0.000232 1560.000000 0.001981 0.001570 0.000814 -9671 1 0.000264 1560.000000 -0.002363 0.001638 0.001731 -9672 1 0.000242 1560.000000 -0.002200 0.001525 0.008333 -9673 1 0.000227 1560.000000 -0.001016 0.001712 0.003643 -9674 1 0.000203 1560.000000 -0.000127 0.001485 0.001253 -9675 1 0.000201 1560.000000 -0.002379 -0.002274 0.000157 -9676 1 0.000194 1560.000000 0.003060 0.001091 0.002879 -9677 1 0.000211 1560.000000 -0.001788 0.001165 0.006883 -9678 1 0.000276 1560.000000 0.001643 0.002125 0.008300 -9679 1 0.000268 1560.000000 0.000649 0.002092 0.001612 -9680 1 0.000247 1560.000000 0.002457 0.002267 0.003690 -9681 1 0.000287 1560.000000 0.003152 -0.000148 0.004014 -9682 1 0.000285 1560.000000 0.001048 0.001680 0.004672 -9683 1 0.000205 1560.000000 -0.000476 0.000255 0.004008 -9684 1 0.000213 1560.000000 0.000577 -0.002334 0.008931 -9685 1 0.000246 1560.000000 -0.002794 -0.002055 0.009514 -9686 1 0.000217 1560.000000 0.000287 -0.003249 0.003887 -9687 1 0.000250 1560.000000 0.001274 0.002359 0.003267 -9688 1 0.000279 1560.000000 -0.003561 0.001267 0.009800 -9689 1 0.000192 1560.000000 -0.000350 0.000256 0.003777 -9690 1 0.000237 1560.000000 0.000287 0.000502 0.002165 -9691 1 0.000201 1560.000000 0.000190 -0.001754 0.003614 -9692 1 0.000218 1560.000000 -0.001261 -0.000395 0.004502 -9693 1 0.000198 1560.000000 0.001619 -0.001332 0.001751 -9694 1 0.000213 1560.000000 0.000554 0.000446 0.000148 -9695 1 0.000286 1560.000000 -0.002619 -0.002006 0.001268 -9696 1 0.000246 1560.000000 0.002832 0.001284 0.006137 -9697 1 0.000255 1560.000000 -0.001362 -0.003165 0.005523 -9698 1 0.000202 1560.000000 0.001089 -0.003054 0.001098 -9699 1 0.000234 1560.000000 -0.002296 -0.002291 0.006681 -9700 1 0.000256 1560.000000 -0.001177 0.000665 0.005931 -9701 1 0.000215 1560.000000 0.002800 0.001759 0.008529 -9702 1 0.000221 1560.000000 0.000510 -0.000022 0.009329 -9703 1 0.000199 1560.000000 0.002456 0.001928 0.009069 -9704 1 0.000206 1560.000000 -0.000258 -0.003049 0.001165 -9705 1 0.000241 1560.000000 0.001408 0.001447 0.000455 -9706 1 0.000197 1560.000000 -0.000166 0.002632 0.000490 -9707 1 0.000224 1560.000000 -0.001229 -0.000632 0.002763 -9708 1 0.000281 1560.000000 0.003374 0.001568 0.003290 -9709 1 0.000210 1560.000000 0.002236 -0.002817 0.005649 -9710 1 0.000288 1560.000000 0.003295 0.000844 0.008192 -9711 1 0.000230 1560.000000 0.001190 0.000456 0.006880 -9712 1 0.000281 1560.000000 0.000596 0.003535 0.004853 -9713 1 0.000277 1560.000000 0.002629 -0.002253 0.000493 -9714 1 0.000234 1560.000000 -0.002902 0.000424 0.005124 -9715 1 0.000236 1560.000000 0.000913 0.003002 0.005427 -9716 1 0.000241 1560.000000 0.000797 0.002659 0.006308 -9717 1 0.000258 1560.000000 0.000680 -0.000181 0.008863 -9718 1 0.000213 1560.000000 -0.002369 -0.000934 0.002086 -9719 1 0.000205 1560.000000 0.000185 -0.001285 0.005217 -9720 1 0.000202 1560.000000 0.000882 -0.001572 0.007175 -9721 1 0.000207 1560.000000 -0.001253 0.001883 0.004136 -9722 1 0.000232 1560.000000 -0.000743 -0.002663 0.008737 -9723 1 0.000281 1560.000000 -0.002066 -0.001224 0.003329 -9724 1 0.000260 1560.000000 0.001665 -0.001977 0.008302 -9725 1 0.000243 1560.000000 -0.001147 -0.002670 0.004125 -9726 1 0.000238 1560.000000 -0.002382 -0.002252 0.002868 -9727 1 0.000238 1560.000000 0.001438 0.003490 0.005600 -9728 1 0.000194 1560.000000 0.000548 0.000062 0.009100 -9729 1 0.000232 1560.000000 -0.000681 -0.002434 0.003374 -9730 1 0.000287 1560.000000 0.003152 0.000326 0.004576 -9731 1 0.000214 1560.000000 0.000698 -0.001735 0.003470 -9732 1 0.000195 1560.000000 -0.001390 -0.003445 0.005141 -9733 1 0.000199 1560.000000 -0.002317 0.000247 0.002447 -9734 1 0.000203 1560.000000 0.001853 0.001984 0.000168 -9735 1 0.000263 1560.000000 0.003389 0.001082 0.007229 -9736 1 0.000276 1560.000000 0.001034 -0.002839 0.009571 -9737 1 0.000219 1560.000000 -0.002745 -0.002382 0.007473 -9738 1 0.000244 1560.000000 0.002071 -0.002664 0.009737 -9739 1 0.000261 1560.000000 0.000281 -0.002828 0.005477 -9740 1 0.000206 1560.000000 -0.000350 0.000362 0.004712 -9741 1 0.000258 1560.000000 -0.000123 0.002786 0.005239 -9742 1 0.000228 1560.000000 0.003317 -0.000705 0.002050 -9743 1 0.000286 1560.000000 0.002305 0.000645 0.008186 -9744 1 0.000213 1560.000000 0.003298 -0.000365 0.004918 -9745 1 0.000198 1560.000000 0.001131 0.002472 0.006959 -9746 1 0.000257 1560.000000 -0.002495 0.000235 0.007120 -9747 1 0.000275 1560.000000 0.002536 0.002721 0.005815 -9748 1 0.000233 1560.000000 0.002706 -0.001140 0.000475 -9749 1 0.000250 1560.000000 0.000709 0.000162 0.003241 -9750 1 0.000215 1560.000000 -0.003334 0.001175 0.008216 -9751 1 0.000236 1560.000000 0.002114 0.000012 0.000995 -9752 1 0.000214 1560.000000 0.002603 0.002295 0.000185 -9753 1 0.000261 1560.000000 0.003169 0.001519 0.003869 -9754 1 0.000222 1560.000000 0.000352 -0.000680 0.009068 -9755 1 0.000239 1560.000000 0.002639 0.002035 0.007552 -9756 1 0.000197 1560.000000 0.002063 -0.002077 0.002956 -9757 1 0.000232 1560.000000 -0.002654 -0.001258 0.007430 -9758 1 0.000264 1560.000000 -0.001259 -0.003080 0.001097 -9759 1 0.000260 1560.000000 0.001884 -0.000748 0.007313 -9760 1 0.000243 1560.000000 -0.002284 0.003045 0.000328 -9761 1 0.000196 1560.000000 -0.000996 0.003494 0.004372 -9762 1 0.000205 1560.000000 0.002644 0.000155 0.006571 -9763 1 0.000216 1560.000000 -0.002567 0.001208 0.001550 -9764 1 0.000259 1560.000000 -0.001036 0.001090 0.006160 -9765 1 0.000266 1560.000000 -0.000153 -0.002232 0.002628 -9766 1 0.000244 1560.000000 0.000806 0.003756 0.006665 -9767 1 0.000233 1560.000000 0.003249 -0.001727 0.006743 -9768 1 0.000204 1560.000000 0.000905 0.002217 0.006035 -9769 1 0.000196 1560.000000 -0.001940 0.002137 0.005778 -9770 1 0.000280 1560.000000 0.001634 0.002483 0.004197 -9771 1 0.000209 1560.000000 0.000927 -0.002248 0.005185 -9772 1 0.000209 1560.000000 -0.003535 -0.000599 0.003099 -9773 1 0.000217 1560.000000 -0.000559 -0.001336 0.004972 -9774 1 0.000233 1560.000000 -0.001319 0.000348 0.004619 -9775 1 0.000217 1560.000000 -0.001506 -0.003329 0.002724 -9776 1 0.000217 1560.000000 -0.001625 0.002657 0.005222 -9777 1 0.000224 1560.000000 0.001404 0.000469 0.004014 -9778 1 0.000252 1560.000000 -0.002904 0.000843 0.004481 -9779 1 0.000196 1560.000000 -0.001925 0.001045 0.007511 -9780 1 0.000236 1560.000000 -0.002158 0.001310 0.000475 -9781 1 0.000214 1560.000000 0.000833 0.002339 0.004426 -9782 1 0.000271 1560.000000 0.002003 -0.003073 0.006703 -9783 1 0.000216 1560.000000 -0.002042 0.001394 0.004565 -9784 1 0.000227 1560.000000 -0.003355 0.000878 0.004398 -9785 1 0.000227 1560.000000 -0.002427 0.000780 0.007442 -9786 1 0.000195 1560.000000 -0.000860 -0.002491 0.001078 -9787 1 0.000278 1560.000000 -0.001320 0.003425 0.003386 -9788 1 0.000246 1560.000000 0.000456 -0.002605 0.007205 -9789 1 0.000262 1560.000000 -0.001933 -0.000207 0.008674 -9790 1 0.000244 1560.000000 -0.000691 -0.001407 0.006206 -9791 1 0.000197 1560.000000 -0.003803 -0.000236 0.008965 -9792 1 0.000243 1560.000000 -0.002924 0.000473 0.003298 -9793 1 0.000213 1560.000000 -0.000226 -0.001590 0.001282 -9794 1 0.000219 1560.000000 0.000148 -0.000802 0.007434 -9795 1 0.000217 1560.000000 0.001986 0.002327 0.001483 -9796 1 0.000196 1560.000000 0.000531 -0.000271 0.008608 -9797 1 0.000255 1560.000000 0.001912 0.001732 0.004930 -9798 1 0.000272 1560.000000 -0.001015 -0.003301 0.007453 -9799 1 0.000224 1560.000000 0.000158 0.000271 0.001817 -9800 1 0.000263 1560.000000 -0.002145 0.002597 0.003291 -9801 1 0.000196 1560.000000 -0.001049 0.001733 0.001604 -9802 1 0.000204 1560.000000 0.000789 -0.003100 0.006535 -9803 1 0.000204 1560.000000 -0.001673 0.001056 0.003220 -9804 1 0.000263 1560.000000 0.001827 -0.003234 0.007991 -9805 1 0.000203 1560.000000 0.002241 0.001667 0.003359 -9806 1 0.000246 1560.000000 0.001232 -0.001594 0.009679 -9807 1 0.000244 1560.000000 -0.001145 0.003213 0.002689 -9808 1 0.000261 1560.000000 0.003622 -0.000469 0.006179 -9809 1 0.000215 1560.000000 -0.001232 -0.000818 0.009054 -9810 1 0.000204 1560.000000 -0.000159 0.003845 0.006767 -9811 1 0.000213 1560.000000 -0.002057 -0.000725 0.003278 -9812 1 0.000220 1560.000000 -0.000093 -0.001975 0.000215 -9813 1 0.000223 1560.000000 0.002897 0.001740 0.005288 -9814 1 0.000231 1560.000000 -0.000214 0.002301 0.001238 -9815 1 0.000209 1560.000000 0.000139 0.000954 0.003313 -9816 1 0.000192 1560.000000 0.003071 -0.002018 0.006742 -9817 1 0.000268 1560.000000 0.000622 -0.000699 0.005419 -9818 1 0.000193 1560.000000 0.000453 0.000847 0.000580 -9819 1 0.000196 1560.000000 0.000148 -0.001584 0.001516 -9820 1 0.000201 1560.000000 0.000846 0.002018 0.006800 -9821 1 0.000210 1560.000000 0.002007 -0.001526 0.007869 -9822 1 0.000250 1560.000000 0.001741 -0.001478 0.000164 -9823 1 0.000223 1560.000000 -0.000032 -0.003538 0.004595 -9824 1 0.000195 1560.000000 -0.000580 -0.003556 0.001454 -9825 1 0.000247 1560.000000 0.000316 0.000449 0.005496 -9826 1 0.000212 1560.000000 -0.002432 0.002653 0.007531 -9827 1 0.000275 1560.000000 -0.001026 0.002199 0.002984 -9828 1 0.000210 1560.000000 0.002759 -0.002255 0.008885 -9829 1 0.000267 1560.000000 -0.003616 -0.000473 0.005751 -9830 1 0.000266 1560.000000 0.001029 0.000725 0.001190 -9831 1 0.000218 1560.000000 0.001236 0.001273 0.001095 -9832 1 0.000207 1560.000000 -0.002279 -0.000992 0.001679 -9833 1 0.000229 1560.000000 -0.002696 0.001257 0.003306 -9834 1 0.000261 1560.000000 -0.002054 0.000234 0.001889 -9835 1 0.000194 1560.000000 0.001785 0.001274 0.000676 -9836 1 0.000245 1560.000000 0.001319 0.001280 0.004738 -9837 1 0.000205 1560.000000 0.001670 0.002518 0.008110 -9838 1 0.000254 1560.000000 0.003438 -0.000777 0.003763 -9839 1 0.000197 1560.000000 -0.001553 0.001898 0.008559 -9840 1 0.000202 1560.000000 -0.000934 0.003124 0.005771 -9841 1 0.000208 1560.000000 -0.002565 -0.000038 0.008452 -9842 1 0.000204 1560.000000 0.001539 -0.002221 0.008121 -9843 1 0.000228 1560.000000 0.002297 0.000639 0.007499 -9844 1 0.000243 1560.000000 -0.001186 -0.002122 0.006608 -9845 1 0.000239 1560.000000 -0.000341 -0.001342 0.004039 -9846 1 0.000210 1560.000000 -0.001590 -0.000579 0.005160 -9847 1 0.000210 1560.000000 -0.003327 -0.000133 0.007613 -9848 1 0.000236 1560.000000 0.000310 -0.001342 0.004974 -9849 1 0.000212 1560.000000 0.002592 0.001012 0.004745 -9850 1 0.000250 1560.000000 -0.003102 0.001098 0.002422 -9851 1 0.000284 1560.000000 0.000913 -0.003053 0.009233 -9852 1 0.000211 1560.000000 0.002100 0.002308 0.003211 -9853 1 0.000220 1560.000000 -0.001712 0.001224 0.001287 -9854 1 0.000262 1560.000000 -0.002008 -0.003257 0.007957 -9855 1 0.000257 1560.000000 -0.002411 0.002560 0.000787 -9856 1 0.000249 1560.000000 0.003114 0.001800 0.003643 -9857 1 0.000219 1560.000000 -0.002182 0.003174 0.005717 -9858 1 0.000273 1560.000000 -0.001667 0.000516 0.008363 -9859 1 0.000260 1560.000000 -0.001102 0.002425 0.001946 -9860 1 0.000273 1560.000000 -0.003570 0.001183 0.002307 -9861 1 0.000198 1560.000000 0.003035 -0.001499 0.008094 -9862 1 0.000204 1560.000000 0.000210 -0.001162 0.008114 -9863 1 0.000200 1560.000000 -0.001791 -0.003188 0.003228 -9864 1 0.000267 1560.000000 0.001307 0.002098 0.004470 -9865 1 0.000198 1560.000000 0.000327 -0.002268 0.005739 -9866 1 0.000217 1560.000000 -0.002831 -0.002364 0.005596 -9867 1 0.000208 1560.000000 -0.000435 -0.002564 0.007044 -9868 1 0.000238 1560.000000 -0.000854 0.001146 0.001866 -9869 1 0.000198 1560.000000 -0.000623 -0.001902 0.009134 -9870 1 0.000220 1560.000000 -0.000368 0.000397 0.007811 -9871 1 0.000229 1560.000000 0.001691 -0.003431 0.004670 -9872 1 0.000239 1560.000000 0.000872 -0.000288 0.001070 -9873 1 0.000194 1560.000000 -0.000563 0.000697 0.004819 -9874 1 0.000271 1560.000000 0.001957 0.001434 0.009670 -9875 1 0.000257 1560.000000 0.002961 0.002171 0.002686 -9876 1 0.000220 1560.000000 -0.001238 0.001636 0.008200 -9877 1 0.000227 1560.000000 0.001394 0.002882 0.003104 -9878 1 0.000279 1560.000000 -0.000725 0.001330 0.000141 -9879 1 0.000267 1560.000000 0.001459 -0.000470 0.005853 -9880 1 0.000209 1560.000000 0.001558 -0.000685 0.008068 -9881 1 0.000197 1560.000000 -0.001502 -0.002394 0.006281 -9882 1 0.000288 1560.000000 -0.000397 0.003513 0.008918 -9883 1 0.000193 1560.000000 -0.003021 -0.001518 0.007713 -9884 1 0.000264 1560.000000 0.000756 0.002894 0.003631 -9885 1 0.000252 1560.000000 -0.001610 0.003077 0.001352 -9886 1 0.000196 1560.000000 -0.000759 -0.001662 0.008459 -9887 1 0.000272 1560.000000 0.003003 0.000565 0.004608 -9888 1 0.000275 1560.000000 0.003271 -0.000249 0.001634 -9889 1 0.000246 1560.000000 -0.002412 0.002329 0.006048 -9890 1 0.000272 1560.000000 0.003197 0.001699 0.004364 -9891 1 0.000205 1560.000000 0.000204 -0.003383 0.005427 -9892 1 0.000242 1560.000000 0.002780 0.001729 0.006011 -9893 1 0.000219 1560.000000 0.002766 0.002119 0.001786 -9894 1 0.000217 1560.000000 -0.001763 -0.000116 0.000911 -9895 1 0.000254 1560.000000 -0.000102 0.003673 0.009255 -9896 1 0.000247 1560.000000 -0.003173 -0.000017 0.009215 -9897 1 0.000268 1560.000000 -0.002305 0.001472 0.004118 -9898 1 0.000220 1560.000000 -0.002771 0.001389 0.002163 -9899 1 0.000204 1560.000000 0.001416 -0.002082 0.006067 -9900 1 0.000221 1560.000000 0.002934 -0.000790 0.007157 -9901 1 0.000210 1560.000000 0.001417 -0.001872 0.008896 -9902 1 0.000268 1560.000000 0.003493 -0.001607 0.000226 -9903 1 0.000252 1560.000000 0.000796 0.003016 0.005159 -9904 1 0.000218 1560.000000 -0.002885 0.001746 0.006122 -9905 1 0.000197 1560.000000 -0.000366 0.001447 0.006154 -9906 1 0.000281 1560.000000 0.001235 -0.000045 0.006770 -9907 1 0.000201 1560.000000 0.002301 0.002888 0.000842 -9908 1 0.000207 1560.000000 0.000736 -0.000536 0.002639 -9909 1 0.000193 1560.000000 -0.003417 -0.001322 0.001137 -9910 1 0.000202 1560.000000 0.000394 0.003825 0.001188 -9911 1 0.000238 1560.000000 -0.000745 0.000592 0.006666 -9912 1 0.000245 1560.000000 0.001277 -0.001948 0.005249 -9913 1 0.000279 1560.000000 0.003608 0.000380 0.004459 -9914 1 0.000197 1560.000000 0.002242 0.003053 0.004656 -9915 1 0.000214 1560.000000 0.000511 -0.001097 0.000461 -9916 1 0.000283 1560.000000 -0.001140 0.003659 0.001285 -9917 1 0.000233 1560.000000 0.002782 -0.001275 0.008304 -9918 1 0.000222 1560.000000 0.000559 0.001710 0.000799 -9919 1 0.000280 1560.000000 0.002728 0.002062 0.009177 -9920 1 0.000211 1560.000000 0.001321 0.001976 0.003298 -9921 1 0.000248 1560.000000 0.000877 0.001553 0.004055 -9922 1 0.000237 1560.000000 -0.000644 0.002137 0.006229 -9923 1 0.000261 1560.000000 -0.002839 -0.000316 0.006297 -9924 1 0.000198 1560.000000 0.002756 0.002434 0.008481 -9925 1 0.000201 1560.000000 0.000887 0.003733 0.001855 -9926 1 0.000282 1560.000000 0.003274 0.000694 0.008480 -9927 1 0.000197 1560.000000 -0.002553 -0.002862 0.003235 -9928 1 0.000233 1560.000000 0.001589 0.000734 0.005299 -9929 1 0.000213 1560.000000 0.001287 -0.000252 0.006536 -9930 1 0.000272 1560.000000 -0.002849 -0.001524 0.003086 -9931 1 0.000199 1560.000000 0.002156 -0.000523 0.000361 -9932 1 0.000194 1560.000000 0.000194 0.003292 0.002715 -9933 1 0.000226 1560.000000 -0.001779 -0.001783 0.006201 -9934 1 0.000198 1560.000000 0.002444 0.002342 0.003957 -9935 1 0.000204 1560.000000 -0.002760 -0.000215 0.008677 -9936 1 0.000260 1560.000000 0.001088 -0.003681 0.007408 -9937 1 0.000203 1560.000000 0.001926 -0.000282 0.009134 -9938 1 0.000197 1560.000000 -0.002006 -0.001965 0.007085 -9939 1 0.000197 1560.000000 0.002974 -0.002194 0.008580 -9940 1 0.000252 1560.000000 0.001510 -0.002925 0.007277 -9941 1 0.000276 1560.000000 -0.001830 -0.000475 0.002870 -9942 1 0.000203 1560.000000 0.001032 0.001476 0.008315 -9943 1 0.000195 1560.000000 -0.001143 0.003021 0.004712 -9944 1 0.000231 1560.000000 -0.000998 -0.001335 0.001500 -9945 1 0.000209 1560.000000 0.002403 0.002267 0.000440 -9946 1 0.000242 1560.000000 0.000846 -0.002111 0.002409 -9947 1 0.000248 1560.000000 0.003765 -0.000244 0.000231 -9948 1 0.000209 1560.000000 0.001084 0.000504 0.009717 -9949 1 0.000207 1560.000000 -0.003749 0.000631 0.008440 -9950 1 0.000242 1560.000000 -0.000385 0.003676 0.007183 -9951 1 0.000215 1560.000000 -0.000220 -0.002389 0.007394 -9952 1 0.000229 1560.000000 -0.000566 0.003035 0.009390 -9953 1 0.000221 1560.000000 -0.001526 -0.000375 0.008033 -9954 1 0.000216 1560.000000 0.002453 -0.001797 0.006563 -9955 1 0.000263 1560.000000 -0.000538 0.003466 0.001222 -9956 1 0.000286 1560.000000 -0.000720 0.002935 0.007435 -9957 1 0.000236 1560.000000 -0.000230 0.001201 0.008731 -9958 1 0.000248 1560.000000 0.001178 -0.000066 0.002888 -9959 1 0.000268 1560.000000 0.001193 0.000448 0.009219 -9960 1 0.000198 1560.000000 -0.002331 0.001411 0.001587 -9961 1 0.000210 1560.000000 0.001824 0.000071 0.000319 -9962 1 0.000283 1560.000000 -0.003847 0.000014 0.003463 -9963 1 0.000234 1560.000000 0.000491 -0.003330 0.008076 -9964 1 0.000217 1560.000000 0.002061 0.002317 0.003510 -9965 1 0.000198 1560.000000 0.002780 -0.001744 0.003700 -9966 1 0.000231 1560.000000 0.003640 0.000849 0.006947 -9967 1 0.000206 1560.000000 -0.000086 0.002690 0.004692 -9968 1 0.000247 1560.000000 -0.001850 -0.002964 0.006949 -9969 1 0.000257 1560.000000 0.002296 0.002952 0.000569 -9970 1 0.000216 1560.000000 -0.000780 -0.002223 0.005124 -9971 1 0.000256 1560.000000 -0.000264 -0.003699 0.001982 -9972 1 0.000272 1560.000000 0.002174 0.000766 0.002612 -9973 1 0.000244 1560.000000 -0.001293 0.002100 0.009529 -9974 1 0.000276 1560.000000 -0.000972 -0.003627 0.005113 -9975 1 0.000267 1560.000000 0.003057 0.000583 0.006947 -9976 1 0.000195 1560.000000 -0.001457 -0.002157 0.005628 -9977 1 0.000200 1560.000000 0.000851 0.001607 0.008576 -9978 1 0.000258 1560.000000 -0.002442 -0.001556 0.008172 -9979 1 0.000203 1560.000000 -0.001057 -0.001164 0.003583 -9980 1 0.000218 1560.000000 0.001603 0.000923 0.000207 -9981 1 0.000276 1560.000000 0.000376 0.001006 0.007258 -9982 1 0.000233 1560.000000 -0.003151 -0.002188 0.000373 -9983 1 0.000199 1560.000000 0.003443 -0.001591 0.000982 -9984 1 0.000242 1560.000000 0.000047 0.003691 0.007460 -9985 1 0.000270 1560.000000 -0.001402 -0.001349 0.003072 -9986 1 0.000208 1560.000000 0.003854 -0.000057 0.009612 -9987 1 0.000209 1560.000000 -0.001753 0.001619 0.002410 -9988 1 0.000254 1560.000000 0.001317 -0.000808 0.004011 -9989 1 0.000214 1560.000000 -0.001577 -0.002720 0.008816 -9990 1 0.000213 1560.000000 -0.003306 -0.001451 0.008647 -9991 1 0.000270 1560.000000 -0.000991 -0.003240 0.008943 -9992 1 0.000200 1560.000000 -0.001166 0.001648 0.009420 -9993 1 0.000224 1560.000000 0.000627 0.002170 0.006845 -9994 1 0.000236 1560.000000 -0.001836 -0.001384 0.000625 -9995 1 0.000209 1560.000000 -0.003468 0.000635 0.008397 -9996 1 0.000237 1560.000000 0.000553 0.002743 0.002775 -9997 1 0.000280 1560.000000 0.001562 0.001989 0.008657 -9998 1 0.000247 1560.000000 -0.001598 0.000087 0.007204 -9999 1 0.000249 1560.000000 0.000978 0.003027 0.003716 -10000 1 0.000204 1560.000000 0.000818 0.000782 0.000110 -10001 1 0.000203 1560.000000 -0.000518 -0.001917 0.008064 -10002 1 0.000220 1560.000000 0.001032 -0.000359 0.001786 -10003 1 0.000251 1560.000000 -0.003821 0.000374 0.002485 -10004 1 0.000217 1560.000000 0.002795 -0.002037 0.002826 -10005 1 0.000223 1560.000000 0.000035 0.003162 0.008859 -10006 1 0.000240 1560.000000 0.003045 0.000968 0.003086 -10007 1 0.000195 1560.000000 -0.003140 0.000029 0.007727 -10008 1 0.000275 1560.000000 -0.003107 -0.000010 0.005766 -10009 1 0.000207 1560.000000 0.002938 0.001518 0.007853 -10010 1 0.000236 1560.000000 0.000237 0.001686 0.009162 -10011 1 0.000277 1560.000000 0.002692 0.001590 0.006817 -10012 1 0.000212 1560.000000 0.000463 0.000999 0.005579 -10013 1 0.000213 1560.000000 0.001187 -0.000922 0.002830 -10014 1 0.000194 1560.000000 -0.002756 0.001212 0.001293 -10015 1 0.000281 1560.000000 -0.001285 -0.000342 0.007205 -10016 1 0.000273 1560.000000 0.000832 0.001696 0.002330 -10017 1 0.000199 1560.000000 -0.000180 -0.001945 0.009297 -10018 1 0.000210 1560.000000 0.001012 -0.002613 0.007827 -10019 1 0.000197 1560.000000 -0.001198 -0.002232 0.004731 -10020 1 0.000194 1560.000000 -0.001978 0.002597 0.003670 -10021 1 0.000212 1560.000000 -0.001352 0.002101 0.002279 -10022 1 0.000196 1560.000000 0.001281 -0.002607 0.008027 -10023 1 0.000227 1560.000000 -0.000219 0.003492 0.002831 -10024 1 0.000275 1560.000000 0.003449 -0.001286 0.001677 -10025 1 0.000193 1560.000000 0.003086 0.000806 0.007988 -10026 1 0.000253 1560.000000 -0.000526 -0.003532 0.005589 -10027 1 0.000212 1560.000000 0.000210 -0.002136 0.001224 -10028 1 0.000279 1560.000000 -0.001730 0.001512 0.000253 -10029 1 0.000222 1560.000000 -0.001945 -0.000212 0.002487 -10030 1 0.000270 1560.000000 0.003117 -0.000360 0.008326 -10031 1 0.000257 1560.000000 0.001311 0.002597 0.000489 -10032 1 0.000212 1560.000000 0.001996 -0.002771 0.008231 -10033 1 0.000193 1560.000000 0.002121 0.001084 0.003825 -10034 1 0.000207 1560.000000 0.003170 -0.001778 0.000976 -10035 1 0.000200 1560.000000 -0.000385 0.001206 0.003392 -10036 1 0.000250 1560.000000 -0.001970 -0.002371 0.002166 -10037 1 0.000202 1560.000000 -0.001253 -0.003060 0.003512 -10038 1 0.000208 1560.000000 0.002168 -0.002341 0.004975 -10039 1 0.000253 1560.000000 -0.002555 0.001400 0.001058 -10040 1 0.000219 1560.000000 -0.001708 0.000354 0.009806 -10041 1 0.000227 1560.000000 -0.001405 0.003273 0.008175 -10042 1 0.000203 1560.000000 -0.001749 0.001372 0.003272 -10043 1 0.000266 1560.000000 -0.002049 0.003196 0.001231 -10044 1 0.000228 1560.000000 -0.000172 -0.001394 0.006826 -10045 1 0.000224 1560.000000 0.000801 0.000412 0.005313 -10046 1 0.000264 1560.000000 -0.000921 -0.001510 0.005821 -10047 1 0.000209 1560.000000 0.000619 0.000486 0.004254 -10048 1 0.000207 1560.000000 0.000263 0.003653 0.008226 -10049 1 0.000266 1560.000000 0.000089 0.002089 0.006944 -10050 1 0.000211 1560.000000 0.001672 -0.000158 0.003438 -10051 1 0.000241 1560.000000 -0.003243 0.000482 0.006009 -10052 1 0.000195 1560.000000 -0.001737 0.001741 0.005982 -10053 1 0.000210 1560.000000 -0.002658 -0.002791 0.008620 -10054 1 0.000234 1560.000000 0.002355 0.000463 0.003653 -10055 1 0.000236 1560.000000 0.000397 -0.003777 0.004478 -10056 1 0.000192 1560.000000 -0.000289 -0.003824 0.006853 -10057 1 0.000240 1560.000000 0.002653 0.000843 0.005650 -10058 1 0.000281 1560.000000 -0.000231 0.003674 0.008463 -10059 1 0.000193 1560.000000 -0.001531 0.001362 0.003950 -10060 1 0.000265 1560.000000 0.002925 0.002402 0.001129 -10061 1 0.000194 1560.000000 -0.001920 -0.000053 0.009034 -10062 1 0.000273 1560.000000 -0.002623 -0.002707 0.005263 -10063 1 0.000194 1560.000000 -0.000638 0.002686 0.008708 -10064 1 0.000229 1560.000000 0.002049 -0.000359 0.009819 -10065 1 0.000243 1560.000000 -0.001374 -0.001420 0.007164 -10066 1 0.000262 1560.000000 -0.002235 0.002199 0.002301 -10067 1 0.000223 1560.000000 -0.000091 0.002012 0.004412 -10068 1 0.000287 1560.000000 -0.001459 -0.000220 0.003681 -10069 1 0.000280 1560.000000 0.001064 -0.000518 0.004845 -10070 1 0.000274 1560.000000 0.002185 0.000341 0.009447 -10071 1 0.000242 1560.000000 0.000793 -0.003295 0.003942 -10072 1 0.000224 1560.000000 -0.002680 -0.001132 0.004153 -10073 1 0.000214 1560.000000 0.000066 0.001832 0.007822 -10074 1 0.000207 1560.000000 0.000355 -0.003447 0.002504 -10075 1 0.000267 1560.000000 0.001243 0.003495 0.009820 -10076 1 0.000229 1560.000000 -0.001877 0.000708 0.002200 -10077 1 0.000252 1560.000000 0.000844 0.000234 0.000302 -10078 1 0.000259 1560.000000 0.000563 -0.002591 0.000423 -10079 1 0.000241 1560.000000 -0.003083 -0.000463 0.004302 -10080 1 0.000286 1560.000000 0.000884 -0.003342 0.001394 -10081 1 0.000223 1560.000000 -0.000547 0.002623 0.006628 -10082 1 0.000195 1560.000000 -0.002514 0.000953 0.003785 -10083 1 0.000286 1560.000000 -0.001835 0.003086 0.006377 -10084 1 0.000278 1560.000000 0.001500 -0.003048 0.006275 -10085 1 0.000287 1560.000000 0.001418 0.001492 0.000833 -10086 1 0.000280 1560.000000 0.000858 0.003180 0.001518 -10087 1 0.000196 1560.000000 -0.003728 0.000321 0.001549 -10088 1 0.000206 1560.000000 -0.001041 0.000387 0.005766 -10089 1 0.000215 1560.000000 0.003161 0.001481 0.002416 -10090 1 0.000192 1560.000000 -0.002008 -0.000227 0.006946 -10091 1 0.000244 1560.000000 0.001289 -0.000540 0.006148 -10092 1 0.000202 1560.000000 0.000431 0.003613 0.002441 -10093 1 0.000264 1560.000000 0.001533 0.000157 0.007628 -10094 1 0.000232 1560.000000 0.002330 -0.001940 0.000581 -10095 1 0.000194 1560.000000 -0.001785 0.000921 0.003467 -10096 1 0.000262 1560.000000 -0.000431 0.002954 0.003313 -10097 1 0.000240 1560.000000 0.002714 -0.000542 0.004030 -10098 1 0.000239 1560.000000 0.002458 0.000682 0.003859 -10099 1 0.000215 1560.000000 -0.001200 0.003323 0.005278 -10100 1 0.000254 1560.000000 0.001025 -0.000823 0.006427 -10101 1 0.000237 1560.000000 0.001925 -0.001181 0.004112 -10102 1 0.000225 1560.000000 0.002194 -0.003108 0.005741 -10103 1 0.000278 1560.000000 0.001619 -0.003465 0.008096 -10104 1 0.000205 1560.000000 -0.003039 -0.002107 0.004700 -10105 1 0.000196 1560.000000 -0.002673 0.000500 0.009157 -10106 1 0.000224 1560.000000 0.000433 -0.000143 0.004836 -10107 1 0.000208 1560.000000 0.002732 0.000133 0.001783 -10108 1 0.000269 1560.000000 -0.002535 -0.002191 0.005007 -10109 1 0.000225 1560.000000 -0.001694 -0.003170 0.007567 -10110 1 0.000211 1560.000000 0.001315 -0.003622 0.005147 -10111 1 0.000245 1560.000000 -0.003060 0.000343 0.008125 -10112 1 0.000240 1560.000000 -0.000978 -0.001019 0.004956 -10113 1 0.000233 1560.000000 0.001503 -0.002706 0.001419 -10114 1 0.000207 1560.000000 0.000097 0.003780 0.009012 -10115 1 0.000206 1560.000000 -0.001228 0.002615 0.004882 -10116 1 0.000223 1560.000000 0.000957 0.001316 0.002968 -10117 1 0.000274 1560.000000 0.000109 -0.001843 0.002891 -10118 1 0.000197 1560.000000 -0.001984 -0.000158 0.003271 -10119 1 0.000200 1560.000000 0.001161 -0.001780 0.003923 -10120 1 0.000211 1560.000000 0.001156 -0.002952 0.000570 -10121 1 0.000201 1560.000000 0.001300 -0.002850 0.006081 -10122 1 0.000232 1560.000000 0.002369 -0.002807 0.000669 -10123 1 0.000271 1560.000000 -0.003091 -0.001365 0.004153 -10124 1 0.000232 1560.000000 -0.001962 0.003205 0.003091 -10125 1 0.000262 1560.000000 -0.001129 0.002988 0.009678 -10126 1 0.000212 1560.000000 -0.003128 0.000832 0.005121 -10127 1 0.000225 1560.000000 -0.001847 0.002649 0.002680 -10128 1 0.000263 1560.000000 -0.001484 0.000187 0.008012 -10129 1 0.000264 1560.000000 0.001416 0.002537 0.007994 -10130 1 0.000234 1560.000000 -0.003527 -0.000092 0.006238 -10131 1 0.000210 1560.000000 0.001564 0.001501 0.006006 -10132 1 0.000205 1560.000000 0.003542 -0.000954 0.004843 -10133 1 0.000283 1560.000000 -0.000535 -0.002085 0.005508 -10134 1 0.000194 1560.000000 0.000127 -0.001807 0.008452 -10135 1 0.000198 1560.000000 -0.000128 -0.003517 0.001227 -10136 1 0.000229 1560.000000 -0.002821 0.002138 0.001174 -10137 1 0.000222 1560.000000 -0.002099 0.000116 0.009596 -10138 1 0.000265 1560.000000 0.001082 0.001029 0.001109 -10139 1 0.000251 1560.000000 -0.001415 0.001517 0.008402 -10140 1 0.000252 1560.000000 -0.001542 0.000366 0.007043 -10141 1 0.000212 1560.000000 0.003042 -0.001486 0.005257 -10142 1 0.000193 1560.000000 0.002925 0.000710 0.001152 -10143 1 0.000236 1560.000000 -0.001377 0.001390 0.002275 -10144 1 0.000218 1560.000000 -0.001115 -0.002902 0.007615 -10145 1 0.000255 1560.000000 0.000254 0.000867 0.002755 -10146 1 0.000232 1560.000000 0.001535 -0.000991 0.009801 -10147 1 0.000258 1560.000000 0.001653 0.001625 0.006642 -10148 1 0.000219 1560.000000 0.001335 -0.003471 0.004827 -10149 1 0.000223 1560.000000 -0.001757 0.001533 0.006816 -10150 1 0.000236 1560.000000 -0.001474 -0.001932 0.000612 -10151 1 0.000235 1560.000000 0.000171 -0.002629 0.007827 -10152 1 0.000232 1560.000000 0.001913 0.001231 0.006262 -10153 1 0.000208 1560.000000 -0.000196 -0.002798 0.007800 -10154 1 0.000238 1560.000000 0.000292 -0.002810 0.006937 -10155 1 0.000209 1560.000000 0.000738 0.000712 0.009172 -10156 1 0.000200 1560.000000 -0.001441 0.003064 0.004181 -10157 1 0.000237 1560.000000 -0.002847 0.002162 0.006490 -10158 1 0.000192 1560.000000 0.000172 0.000867 0.009088 -10159 1 0.000243 1560.000000 -0.002848 0.000104 0.008029 -10160 1 0.000282 1560.000000 -0.000487 0.003798 0.008710 -10161 1 0.000246 1560.000000 0.001835 0.000955 0.004159 -10162 1 0.000260 1560.000000 -0.003131 0.001894 0.002080 -10163 1 0.000196 1560.000000 0.001115 -0.001740 0.004781 -10164 1 0.000212 1560.000000 0.002615 -0.002301 0.004573 -10165 1 0.000256 1560.000000 0.000936 -0.002246 0.001078 -10166 1 0.000216 1560.000000 -0.000619 -0.001577 0.007327 -10167 1 0.000274 1560.000000 -0.001851 -0.003070 0.005337 -10168 1 0.000263 1560.000000 0.003260 0.002047 0.007437 -10169 1 0.000235 1560.000000 0.000493 -0.002481 0.009300 -10170 1 0.000222 1560.000000 0.001997 -0.002250 0.003338 -10171 1 0.000269 1560.000000 0.001690 0.001295 0.007960 -10172 1 0.000232 1560.000000 0.001293 -0.002654 0.001579 -10173 1 0.000196 1560.000000 0.001700 0.000390 0.006241 -10174 1 0.000228 1560.000000 -0.003533 0.001044 0.007938 -10175 1 0.000217 1560.000000 0.002968 0.000328 0.008750 -10176 1 0.000216 1560.000000 -0.001200 -0.002714 0.004789 -10177 1 0.000241 1560.000000 0.002411 -0.002562 0.009549 -10178 1 0.000221 1560.000000 0.000689 -0.003204 0.004232 -10179 1 0.000224 1560.000000 -0.002667 0.002147 0.003717 -10180 1 0.000262 1560.000000 -0.000757 0.000326 0.005369 -10181 1 0.000206 1560.000000 -0.001847 0.002970 0.008071 -10182 1 0.000248 1560.000000 -0.001002 -0.003451 0.003605 -10183 1 0.000231 1560.000000 0.001686 -0.002518 0.005249 -10184 1 0.000218 1560.000000 -0.001365 0.002434 0.007203 -10185 1 0.000212 1560.000000 0.003279 0.000964 0.000760 -10186 1 0.000196 1560.000000 0.002589 -0.002633 0.004831 -10187 1 0.000288 1560.000000 -0.001913 0.002939 0.000414 -10188 1 0.000200 1560.000000 0.002957 0.002054 0.005270 -10189 1 0.000203 1560.000000 -0.002739 0.002122 0.003315 -10190 1 0.000219 1560.000000 0.003190 0.002116 0.005442 -10191 1 0.000208 1560.000000 -0.002776 -0.000356 0.001750 -10192 1 0.000265 1560.000000 -0.001094 -0.003638 0.004103 -10193 1 0.000225 1560.000000 0.000061 -0.003525 0.005997 -10194 1 0.000218 1560.000000 0.001830 0.000726 0.007518 -10195 1 0.000200 1560.000000 -0.002580 -0.002154 0.006952 -10196 1 0.000213 1560.000000 -0.001084 -0.000685 0.009779 -10197 1 0.000202 1560.000000 0.000671 0.000419 0.003680 -10198 1 0.000254 1560.000000 -0.003521 -0.000140 0.003827 -10199 1 0.000209 1560.000000 -0.002862 -0.000446 0.002255 -10200 1 0.000231 1560.000000 -0.000585 0.002556 0.005274 -10201 1 0.000286 1560.000000 -0.000098 0.003718 0.009534 -10202 1 0.000203 1560.000000 0.002444 0.000225 0.006606 -10203 1 0.000213 1560.000000 -0.001356 0.000455 0.002523 -10204 1 0.000278 1560.000000 -0.000634 -0.002094 0.002136 -10205 1 0.000230 1560.000000 -0.000300 -0.000210 0.003742 -10206 1 0.000263 1560.000000 0.001267 0.003532 0.008384 -10207 1 0.000241 1560.000000 -0.003787 -0.000134 0.006058 -10208 1 0.000199 1560.000000 0.003472 0.000211 0.008820 -10209 1 0.000256 1560.000000 -0.002401 -0.002907 0.002864 -10210 1 0.000235 1560.000000 -0.002598 0.002667 0.004746 -10211 1 0.000251 1560.000000 -0.002334 -0.001983 0.008838 -10212 1 0.000214 1560.000000 -0.002873 0.001597 0.003895 -10213 1 0.000221 1560.000000 0.000678 0.001170 0.006400 -10214 1 0.000246 1560.000000 -0.002790 0.001892 0.000202 -10215 1 0.000192 1560.000000 0.002477 0.002088 0.006932 -10216 1 0.000211 1560.000000 0.001757 -0.001347 0.009388 -10217 1 0.000250 1560.000000 0.001439 -0.003320 0.009686 -10218 1 0.000280 1560.000000 -0.000025 -0.003232 0.003840 -10219 1 0.000223 1560.000000 -0.002150 0.002117 0.007089 -10220 1 0.000237 1560.000000 0.000138 -0.001777 0.007277 -10221 1 0.000237 1560.000000 0.002031 -0.001638 0.006927 -10222 1 0.000242 1560.000000 0.002235 0.002168 0.007193 -10223 1 0.000203 1560.000000 0.003652 0.000737 0.009151 -10224 1 0.000205 1560.000000 -0.003195 0.000582 0.008255 -10225 1 0.000226 1560.000000 -0.002638 0.002458 0.004491 -10226 1 0.000227 1560.000000 0.000305 0.003323 0.004628 -10227 1 0.000238 1560.000000 -0.002314 -0.000177 0.006724 -10228 1 0.000246 1560.000000 -0.002994 0.000932 0.008593 -10229 1 0.000231 1560.000000 0.001590 -0.001728 0.008288 -10230 1 0.000197 1560.000000 0.002206 0.002637 0.006730 -10231 1 0.000227 1560.000000 0.002873 -0.000571 0.007104 -10232 1 0.000209 1560.000000 0.000351 -0.001874 0.001085 -10233 1 0.000198 1560.000000 -0.001390 0.002696 0.003737 -10234 1 0.000207 1560.000000 0.000680 0.001494 0.008258 -10235 1 0.000266 1560.000000 -0.000757 -0.002823 0.007495 -10236 1 0.000226 1560.000000 -0.002126 0.000116 0.000714 -10237 1 0.000194 1560.000000 -0.001496 0.002234 0.000981 -10238 1 0.000243 1560.000000 0.000387 -0.000317 0.003658 -10239 1 0.000264 1560.000000 0.002249 0.001370 0.002301 -10240 1 0.000193 1560.000000 0.003146 0.002013 0.004059 -10241 1 0.000206 1560.000000 0.002389 -0.001240 0.002885 -10242 1 0.000206 1560.000000 -0.001087 -0.000595 0.008726 -10243 1 0.000246 1560.000000 0.000659 -0.003227 0.000320 -10244 1 0.000235 1560.000000 0.002110 0.000270 0.006680 -10245 1 0.000220 1560.000000 0.000670 -0.000920 0.006641 -10246 1 0.000213 1560.000000 0.000888 0.002950 0.009400 -10247 1 0.000213 1560.000000 0.000854 0.001915 0.007639 -10248 1 0.000226 1560.000000 -0.001138 -0.003034 0.006573 -10249 1 0.000209 1560.000000 -0.000698 -0.003684 0.007095 -10250 1 0.000207 1560.000000 0.001163 -0.001020 0.009072 -10251 1 0.000258 1560.000000 -0.001583 -0.002677 0.009536 -10252 1 0.000284 1560.000000 0.001230 0.002513 0.008233 -10253 1 0.000269 1560.000000 -0.003011 -0.000854 0.007494 -10254 1 0.000219 1560.000000 -0.000511 -0.000961 0.002891 -10255 1 0.000272 1560.000000 0.001303 -0.001984 0.004847 -10256 1 0.000272 1560.000000 0.003090 -0.001790 0.000152 -10257 1 0.000220 1560.000000 -0.003379 0.000888 0.009393 -10258 1 0.000216 1560.000000 -0.001184 -0.002752 0.006490 -10259 1 0.000238 1560.000000 -0.002467 0.000094 0.007966 -10260 1 0.000230 1560.000000 -0.003517 -0.000358 0.002278 -10261 1 0.000236 1560.000000 0.000762 -0.002650 0.004063 -10262 1 0.000196 1560.000000 -0.003372 0.000173 0.003867 -10263 1 0.000255 1560.000000 -0.001073 -0.000221 0.000932 -10264 1 0.000271 1560.000000 0.000520 0.003337 0.002457 -10265 1 0.000196 1560.000000 0.001784 -0.001454 0.007698 -10266 1 0.000226 1560.000000 0.000598 -0.001214 0.003794 -10267 1 0.000259 1560.000000 0.001891 -0.003094 0.008550 -10268 1 0.000219 1560.000000 0.000800 -0.003351 0.008156 -10269 1 0.000235 1560.000000 -0.000109 0.000719 0.001821 -10270 1 0.000235 1560.000000 0.003551 0.000375 0.000164 -10271 1 0.000260 1560.000000 0.002603 -0.001057 0.002101 -10272 1 0.000225 1560.000000 0.003012 0.000447 0.008178 -10273 1 0.000232 1560.000000 0.000184 -0.000875 0.003667 -10274 1 0.000279 1560.000000 -0.001893 0.001898 0.009795 -10275 1 0.000252 1560.000000 0.001170 0.000926 0.003663 -10276 1 0.000273 1560.000000 0.002994 0.001814 0.007580 -10277 1 0.000239 1560.000000 -0.003217 -0.000977 0.000829 -10278 1 0.000257 1560.000000 0.002355 -0.000936 0.004495 -10279 1 0.000225 1560.000000 -0.001558 0.000132 0.000964 -10280 1 0.000222 1560.000000 -0.000104 -0.003057 0.008114 -10281 1 0.000219 1560.000000 -0.001927 0.000326 0.006358 -10282 1 0.000246 1560.000000 -0.003140 0.002210 0.005049 -10283 1 0.000229 1560.000000 0.002122 0.002804 0.004980 -10284 1 0.000268 1560.000000 -0.002878 0.001022 0.000810 -10285 1 0.000193 1560.000000 0.002632 -0.000988 0.003877 -10286 1 0.000250 1560.000000 0.001195 0.002811 0.009731 -10287 1 0.000238 1560.000000 0.001184 0.000705 0.002968 -10288 1 0.000196 1560.000000 0.001633 0.002496 0.002107 -10289 1 0.000283 1560.000000 -0.001232 0.000736 0.007416 -10290 1 0.000247 1560.000000 -0.001485 0.003170 0.001574 -10291 1 0.000247 1560.000000 -0.000468 0.001254 0.000606 -10292 1 0.000194 1560.000000 -0.002071 0.000992 0.006413 -10293 1 0.000201 1560.000000 -0.000499 0.000672 0.007078 -10294 1 0.000243 1560.000000 -0.001651 -0.000981 0.009409 -10295 1 0.000200 1560.000000 -0.001981 -0.002175 0.000185 -10296 1 0.000208 1560.000000 0.003194 -0.001436 0.005757 -10297 1 0.000236 1560.000000 0.002241 -0.000671 0.009129 -10298 1 0.000198 1560.000000 0.002290 -0.000621 0.002785 -10299 1 0.000227 1560.000000 0.002420 -0.002571 0.006145 -10300 1 0.000226 1560.000000 0.000930 0.001493 0.005271 -10301 1 0.000225 1560.000000 0.003190 0.002112 0.002326 -10302 1 0.000211 1560.000000 -0.000128 0.000776 0.007704 -10303 1 0.000238 1560.000000 0.000644 0.002104 0.007572 -10304 1 0.000203 1560.000000 0.002330 -0.001406 0.007563 -10305 1 0.000237 1560.000000 -0.002738 0.001093 0.005318 -10306 1 0.000223 1560.000000 -0.000956 0.001145 0.008139 -10307 1 0.000233 1560.000000 -0.000622 -0.000440 0.001838 -10308 1 0.000218 1560.000000 -0.000385 0.001643 0.004979 -10309 1 0.000195 1560.000000 -0.002490 -0.000315 0.009688 -10310 1 0.000261 1560.000000 0.001672 -0.000107 0.002430 -10311 1 0.000260 1560.000000 0.001259 0.000731 0.006278 -10312 1 0.000276 1560.000000 -0.003036 0.000762 0.000747 -10313 1 0.000272 1560.000000 0.001509 0.001057 0.004693 -10314 1 0.000228 1560.000000 -0.002701 0.002735 0.002940 -10315 1 0.000234 1560.000000 0.003757 0.000490 0.008774 -10316 1 0.000272 1560.000000 -0.002432 0.002096 0.004059 -10317 1 0.000204 1560.000000 -0.002101 -0.001359 0.004144 -10318 1 0.000228 1560.000000 -0.002965 0.000736 0.008768 -10319 1 0.000217 1560.000000 0.002159 -0.000592 0.001921 -10320 1 0.000220 1560.000000 0.000610 -0.002670 0.006231 -10321 1 0.000252 1560.000000 0.002282 -0.002378 0.005439 -10322 1 0.000230 1560.000000 -0.000341 -0.000986 0.007979 -10323 1 0.000258 1560.000000 0.001354 -0.000938 0.004812 -10324 1 0.000201 1560.000000 -0.000639 0.001035 0.009158 -10325 1 0.000212 1560.000000 -0.001123 0.003651 0.004793 -10326 1 0.000273 1560.000000 -0.001834 0.000444 0.003369 -10327 1 0.000196 1560.000000 0.002154 0.001334 0.008919 -10328 1 0.000211 1560.000000 -0.001931 0.002874 0.008332 -10329 1 0.000263 1560.000000 -0.000888 -0.003124 0.007667 -10330 1 0.000233 1560.000000 0.001477 -0.000332 0.000885 -10331 1 0.000216 1560.000000 -0.003121 -0.000975 0.008120 -10332 1 0.000214 1560.000000 0.001032 0.003238 0.005805 -10333 1 0.000217 1560.000000 0.000750 -0.003018 0.004347 -10334 1 0.000205 1560.000000 0.002961 -0.000968 0.009217 -10335 1 0.000198 1560.000000 -0.002111 0.001221 0.008644 -10336 1 0.000227 1560.000000 0.001971 0.001030 0.003599 -10337 1 0.000205 1560.000000 0.001913 -0.000648 0.006959 -10338 1 0.000260 1560.000000 0.000344 -0.003826 0.002529 -10339 1 0.000219 1560.000000 0.000793 0.002509 0.008268 -10340 1 0.000209 1560.000000 -0.001879 0.003236 0.005354 -10341 1 0.000215 1560.000000 0.002773 0.000887 0.006147 -10342 1 0.000241 1560.000000 0.001737 0.000069 0.004447 -10343 1 0.000195 1560.000000 0.002179 0.000890 0.007450 -10344 1 0.000257 1560.000000 -0.002446 0.002831 0.006988 -10345 1 0.000249 1560.000000 0.003545 0.000164 0.000531 -10346 1 0.000220 1560.000000 -0.000350 0.000399 0.006690 -10347 1 0.000285 1560.000000 0.000732 -0.002801 0.000948 -10348 1 0.000281 1560.000000 0.000807 0.002201 0.000142 -10349 1 0.000266 1560.000000 -0.003718 -0.000716 0.004768 -10350 1 0.000199 1560.000000 0.002182 -0.000617 0.001283 -10351 1 0.000241 1560.000000 -0.000343 0.002840 0.003536 -10352 1 0.000218 1560.000000 0.000365 -0.001231 0.001656 -10353 1 0.000279 1560.000000 -0.001412 -0.002752 0.003226 -10354 1 0.000249 1560.000000 -0.003047 -0.001688 0.001478 -10355 1 0.000271 1560.000000 -0.003154 0.000150 0.001416 -10356 1 0.000233 1560.000000 0.000921 0.001958 0.001633 -10357 1 0.000246 1560.000000 -0.002479 0.001445 0.005977 -10358 1 0.000193 1560.000000 -0.001036 -0.003252 0.008486 -10359 1 0.000286 1560.000000 -0.000642 -0.003208 0.008457 -10360 1 0.000196 1560.000000 -0.003060 0.000369 0.002241 -10361 1 0.000213 1560.000000 0.002103 -0.000662 0.009764 -10362 1 0.000195 1560.000000 -0.000019 0.000229 0.005978 -10363 1 0.000234 1560.000000 -0.002143 -0.002071 0.008150 -10364 1 0.000282 1560.000000 -0.002772 -0.002623 0.001751 -10365 1 0.000192 1560.000000 0.000232 0.002420 0.000254 -10366 1 0.000280 1560.000000 -0.002370 -0.002704 0.005506 -10367 1 0.000230 1560.000000 -0.001446 0.002421 0.008792 -10368 1 0.000230 1560.000000 -0.002506 -0.002224 0.005753 -10369 1 0.000222 1560.000000 -0.000124 -0.001675 0.002843 -10370 1 0.000260 1560.000000 -0.000143 -0.001926 0.002172 -10371 1 0.000210 1560.000000 0.002222 -0.001649 0.003615 -10372 1 0.000268 1560.000000 -0.000040 0.003779 0.008667 -10373 1 0.000250 1560.000000 -0.003757 -0.000528 0.004945 -10374 1 0.000246 1560.000000 -0.000531 -0.002708 0.007421 -10375 1 0.000193 1560.000000 -0.000155 -0.001049 0.007768 -10376 1 0.000198 1560.000000 0.002332 0.001841 0.007509 -10377 1 0.000207 1560.000000 -0.002333 -0.001267 0.005676 -10378 1 0.000213 1560.000000 -0.000643 -0.001012 0.005688 -10379 1 0.000272 1560.000000 0.001541 0.002633 0.003949 -10380 1 0.000201 1560.000000 0.003226 0.001916 0.009596 -10381 1 0.000213 1560.000000 -0.000254 0.003274 0.000200 -10382 1 0.000203 1560.000000 -0.000163 -0.000709 0.007165 -10383 1 0.000237 1560.000000 0.000372 0.002383 0.001548 -10384 1 0.000193 1560.000000 0.000887 -0.001493 0.009591 -10385 1 0.000198 1560.000000 -0.002004 -0.000859 0.006226 -10386 1 0.000195 1560.000000 -0.000462 0.001278 0.001469 -10387 1 0.000240 1560.000000 0.002573 0.001595 0.007637 -10388 1 0.000209 1560.000000 0.002188 0.000361 0.007552 -10389 1 0.000273 1560.000000 -0.003071 0.001916 0.003602 -10390 1 0.000237 1560.000000 -0.001094 0.000316 0.004747 -10391 1 0.000208 1560.000000 0.000556 0.001259 0.004916 -10392 1 0.000255 1560.000000 -0.003288 -0.001899 0.009360 -10393 1 0.000267 1560.000000 0.002574 0.002583 0.008587 -10394 1 0.000257 1560.000000 -0.001993 0.000798 0.009704 -10395 1 0.000271 1560.000000 -0.000290 0.001940 0.008839 -10396 1 0.000202 1560.000000 -0.003665 0.000078 0.005022 -10397 1 0.000205 1560.000000 -0.003372 -0.000192 0.003602 -10398 1 0.000195 1560.000000 0.001400 0.003318 0.001404 -10399 1 0.000234 1560.000000 -0.001074 0.002847 0.003885 -10400 1 0.000238 1560.000000 0.000948 -0.002861 0.000353 -10401 1 0.000253 1560.000000 -0.002503 0.000661 0.002173 -10402 1 0.000248 1560.000000 0.003090 0.000013 0.007392 -10403 1 0.000266 1560.000000 0.000921 0.001195 0.000584 -10404 1 0.000202 1560.000000 -0.000362 0.001305 0.002082 -10405 1 0.000263 1560.000000 -0.000199 -0.002602 0.001443 -10406 1 0.000241 1560.000000 -0.001598 -0.003249 0.009714 -10407 1 0.000273 1560.000000 -0.000972 -0.003675 0.008897 -10408 1 0.000197 1560.000000 -0.001328 0.002223 0.008817 -10409 1 0.000208 1560.000000 0.001325 0.002110 0.006586 -10410 1 0.000235 1560.000000 0.001497 -0.001579 0.006980 -10411 1 0.000233 1560.000000 -0.002477 0.000489 0.006912 -10412 1 0.000229 1560.000000 -0.003108 0.001974 0.000457 -10413 1 0.000197 1560.000000 0.000014 0.000692 0.004615 -10414 1 0.000263 1560.000000 -0.002512 0.002204 0.008303 -10415 1 0.000192 1560.000000 0.000215 -0.002948 0.004680 -10416 1 0.000221 1560.000000 -0.001686 0.001551 0.004547 -10417 1 0.000216 1560.000000 -0.000958 -0.002391 0.006546 -10418 1 0.000237 1560.000000 0.002530 0.002600 0.001709 -10419 1 0.000226 1560.000000 0.000466 -0.001580 0.000662 -10420 1 0.000247 1560.000000 -0.002446 -0.000540 0.003211 -10421 1 0.000250 1560.000000 -0.002752 0.000323 0.000411 -10422 1 0.000232 1560.000000 0.001097 0.001303 0.005628 -10423 1 0.000211 1560.000000 0.003658 -0.000860 0.003661 -10424 1 0.000200 1560.000000 -0.000659 0.001637 0.000259 -10425 1 0.000203 1560.000000 -0.000047 -0.002708 0.002979 -10426 1 0.000212 1560.000000 0.001196 -0.001199 0.006202 -10427 1 0.000205 1560.000000 -0.000656 0.003235 0.005580 -10428 1 0.000194 1560.000000 -0.001289 0.000160 0.004802 -10429 1 0.000202 1560.000000 0.000297 0.001995 0.000904 -10430 1 0.000255 1560.000000 0.003286 -0.001966 0.001503 -10431 1 0.000221 1560.000000 0.003560 0.000560 0.003711 -10432 1 0.000198 1560.000000 -0.000416 -0.003545 0.002751 -10433 1 0.000228 1560.000000 0.001799 -0.000368 0.007007 -10434 1 0.000225 1560.000000 -0.000530 -0.002955 0.001208 -10435 1 0.000199 1560.000000 0.002298 0.001877 0.001738 -10436 1 0.000275 1560.000000 -0.003830 -0.000275 0.005155 -10437 1 0.000208 1560.000000 -0.001888 0.000813 0.008846 -10438 1 0.000270 1560.000000 0.000612 -0.003246 0.005336 -10439 1 0.000244 1560.000000 0.001515 0.002642 0.008644 -10440 1 0.000216 1560.000000 -0.000806 0.003239 0.002797 -10441 1 0.000234 1560.000000 0.000598 -0.002950 0.001681 -10442 1 0.000284 1560.000000 0.002047 0.002496 0.007625 -10443 1 0.000262 1560.000000 0.000090 0.002792 0.000189 -10444 1 0.000234 1560.000000 -0.001633 -0.000325 0.009157 -10445 1 0.000284 1560.000000 0.000887 0.002327 0.005711 -10446 1 0.000267 1560.000000 -0.001052 0.001492 0.000952 -10447 1 0.000201 1560.000000 0.002083 0.001362 0.004500 -10448 1 0.000198 1560.000000 -0.000485 -0.001455 0.008811 -10449 1 0.000281 1560.000000 -0.000547 0.003311 0.004007 -10450 1 0.000247 1560.000000 0.001526 0.003085 0.001165 -10451 1 0.000216 1560.000000 0.001039 -0.001729 0.000505 -10452 1 0.000253 1560.000000 0.000685 -0.002116 0.006238 -10453 1 0.000263 1560.000000 0.003766 -0.000715 0.002449 -10454 1 0.000193 1560.000000 0.002095 -0.002300 0.008384 -10455 1 0.000266 1560.000000 -0.002410 0.000746 0.005418 -10456 1 0.000238 1560.000000 -0.000674 0.001696 0.001182 -10457 1 0.000193 1560.000000 -0.001091 -0.002884 0.007925 -10458 1 0.000204 1560.000000 0.002416 -0.000150 0.008465 -10459 1 0.000248 1560.000000 -0.003608 0.001286 0.001299 -10460 1 0.000218 1560.000000 -0.002648 0.001019 0.001216 -10461 1 0.000211 1560.000000 -0.003537 -0.000318 0.000914 -10462 1 0.000208 1560.000000 0.000506 0.003257 0.006606 -10463 1 0.000275 1560.000000 0.003718 -0.000426 0.001504 -10464 1 0.000245 1560.000000 -0.003773 0.000522 0.005303 -10465 1 0.000224 1560.000000 -0.001518 -0.002772 0.007994 -10466 1 0.000202 1560.000000 -0.003379 0.000324 0.001093 -10467 1 0.000269 1560.000000 0.001351 0.000941 0.005965 -10468 1 0.000199 1560.000000 -0.003542 -0.000809 0.009672 -10469 1 0.000231 1560.000000 0.001334 0.000122 0.007128 -10470 1 0.000195 1560.000000 -0.002521 0.000039 0.001938 -10471 1 0.000195 1560.000000 -0.002759 -0.001297 0.001798 -10472 1 0.000200 1560.000000 0.001117 0.001993 0.003095 -10473 1 0.000269 1560.000000 0.002360 -0.001274 0.005825 -10474 1 0.000250 1560.000000 -0.002204 0.002033 0.007908 -10475 1 0.000212 1560.000000 -0.002255 0.001868 0.009010 -10476 1 0.000258 1560.000000 0.002717 0.000233 0.004799 -10477 1 0.000276 1560.000000 -0.002688 -0.002596 0.000245 -10478 1 0.000270 1560.000000 -0.002379 -0.000686 0.006118 -10479 1 0.000255 1560.000000 0.002663 0.000158 0.005383 -10480 1 0.000259 1560.000000 0.003133 -0.000032 0.004903 -10481 1 0.000211 1560.000000 -0.003263 -0.000845 0.008340 -10482 1 0.000230 1560.000000 -0.000404 0.000956 0.002714 -10483 1 0.000213 1560.000000 0.003677 -0.000409 0.007253 -10484 1 0.000279 1560.000000 -0.002796 0.002608 0.004271 -10485 1 0.000206 1560.000000 0.000091 0.000580 0.006179 -10486 1 0.000256 1560.000000 -0.003619 -0.000002 0.009647 -10487 1 0.000230 1560.000000 0.002753 0.001487 0.005675 -10488 1 0.000201 1560.000000 -0.000176 0.003306 0.005997 -10489 1 0.000196 1560.000000 -0.001612 0.001918 0.006945 -10490 1 0.000237 1560.000000 0.001591 -0.001553 0.007534 -10491 1 0.000219 1560.000000 -0.001771 0.002068 0.003250 -10492 1 0.000266 1560.000000 0.000462 -0.002503 0.006908 -10493 1 0.000285 1560.000000 0.000946 0.003210 0.004962 -10494 1 0.000219 1560.000000 0.000397 -0.002543 0.005995 -10495 1 0.000194 1560.000000 0.001708 -0.001355 0.000608 -10496 1 0.000236 1560.000000 -0.000153 0.001707 0.006947 -10497 1 0.000241 1560.000000 0.002766 -0.000385 0.004229 -10498 1 0.000225 1560.000000 0.000700 0.000969 0.000970 -10499 1 0.000268 1560.000000 0.001212 -0.001201 0.009255 -10500 1 0.000244 1560.000000 -0.000942 0.001995 0.003640 -10501 1 0.000274 1560.000000 0.000754 0.000481 0.005071 -10502 1 0.000256 1560.000000 0.000203 0.002415 0.007260 -10503 1 0.000216 1560.000000 -0.002600 0.002280 0.005213 -10504 1 0.000195 1560.000000 -0.000649 -0.002436 0.004186 -10505 1 0.000194 1560.000000 -0.000321 0.002038 0.005012 -10506 1 0.000219 1560.000000 0.000660 -0.002362 0.008720 -10507 1 0.000214 1560.000000 0.002793 0.001669 0.009246 -10508 1 0.000281 1560.000000 0.000134 -0.001961 0.004195 -10509 1 0.000202 1560.000000 0.002672 0.002187 0.005244 -10510 1 0.000197 1560.000000 0.003062 -0.000112 0.002068 -10511 1 0.000221 1560.000000 0.001064 0.000911 0.003981 -10512 1 0.000222 1560.000000 0.002732 -0.001659 0.004979 -10513 1 0.000238 1560.000000 0.000278 0.003690 0.007253 -10514 1 0.000209 1560.000000 -0.001581 0.002679 0.005709 -10515 1 0.000244 1560.000000 0.001481 0.003159 0.008318 -10516 1 0.000205 1560.000000 0.001679 0.000020 0.005313 -10517 1 0.000216 1560.000000 -0.003374 0.000733 0.004129 -10518 1 0.000203 1560.000000 0.001471 0.000183 0.006858 -10519 1 0.000197 1560.000000 0.000455 -0.000627 0.004864 -10520 1 0.000234 1560.000000 0.002632 0.000748 0.000881 -10521 1 0.000193 1560.000000 -0.000088 -0.002638 0.008042 -10522 1 0.000218 1560.000000 0.001680 -0.001103 0.004733 -10523 1 0.000247 1560.000000 -0.002534 0.002074 0.009773 -10524 1 0.000216 1560.000000 0.002417 0.001657 0.008195 -10525 1 0.000213 1560.000000 0.000592 -0.001083 0.004990 -10526 1 0.000195 1560.000000 0.000318 -0.000585 0.003143 -10527 1 0.000210 1560.000000 -0.000505 0.001052 0.005511 -10528 1 0.000262 1560.000000 -0.002391 0.001811 0.005716 -10529 1 0.000233 1560.000000 -0.003307 -0.001620 0.006290 -10530 1 0.000249 1560.000000 0.001199 0.002463 0.006014 -10531 1 0.000279 1560.000000 -0.003442 0.001249 0.003830 -10532 1 0.000228 1560.000000 0.000445 -0.002693 0.004849 -10533 1 0.000260 1560.000000 -0.002715 0.002112 0.000480 -10534 1 0.000218 1560.000000 -0.000529 0.002039 0.007853 -10535 1 0.000241 1560.000000 -0.000411 0.000958 0.008284 -10536 1 0.000198 1560.000000 0.001091 -0.001953 0.002139 -10537 1 0.000200 1560.000000 -0.000672 0.000231 0.000794 -10538 1 0.000240 1560.000000 0.001271 0.000950 0.008187 -10539 1 0.000221 1560.000000 -0.000746 0.002222 0.008937 -10540 1 0.000197 1560.000000 -0.003069 -0.001497 0.004632 -10541 1 0.000284 1560.000000 0.002173 0.001581 0.004718 -10542 1 0.000241 1560.000000 -0.002970 0.001363 0.000485 -10543 1 0.000251 1560.000000 0.002543 0.001972 0.006172 -10544 1 0.000240 1560.000000 -0.001230 -0.002373 0.007320 -10545 1 0.000235 1560.000000 -0.000843 -0.000596 0.000179 -10546 1 0.000238 1560.000000 0.001040 0.001810 0.009785 -10547 1 0.000194 1560.000000 0.003755 0.000343 0.004120 -10548 1 0.000206 1560.000000 0.000888 0.003592 0.004603 -10549 1 0.000241 1560.000000 -0.000185 0.001032 0.006411 -10550 1 0.000287 1560.000000 0.003573 0.001373 0.000235 -10551 1 0.000202 1560.000000 0.000956 -0.001049 0.002423 -10552 1 0.000204 1560.000000 -0.001566 -0.002085 0.004293 -10553 1 0.000199 1560.000000 0.001123 -0.001355 0.005522 -10554 1 0.000197 1560.000000 0.003207 0.000468 0.005779 -10555 1 0.000221 1560.000000 -0.000878 0.000339 0.006356 -10556 1 0.000217 1560.000000 0.000378 0.003264 0.007709 -10557 1 0.000281 1560.000000 0.001477 0.003475 0.009622 -10558 1 0.000271 1560.000000 -0.001232 0.001780 0.004370 -10559 1 0.000214 1560.000000 -0.000443 -0.000124 0.002449 -10560 1 0.000193 1560.000000 -0.000579 -0.001290 0.001671 -10561 1 0.000276 1560.000000 -0.001908 -0.002745 0.000240 -10562 1 0.000264 1560.000000 -0.002191 -0.001769 0.004761 -10563 1 0.000217 1560.000000 -0.000121 0.002918 0.001839 -10564 1 0.000273 1560.000000 -0.001612 0.000182 0.004683 -10565 1 0.000234 1560.000000 -0.002043 0.000528 0.008450 -10566 1 0.000224 1560.000000 -0.002104 0.002670 0.008877 -10567 1 0.000210 1560.000000 0.002393 -0.000539 0.001768 -10568 1 0.000280 1560.000000 0.002313 0.000444 0.001082 -10569 1 0.000284 1560.000000 0.000702 -0.003519 0.002230 -10570 1 0.000253 1560.000000 -0.001173 -0.001797 0.009786 -10571 1 0.000248 1560.000000 0.002056 -0.000354 0.008540 -10572 1 0.000254 1560.000000 0.000886 -0.002660 0.006178 -10573 1 0.000226 1560.000000 0.002795 -0.001493 0.004440 -10574 1 0.000198 1560.000000 0.002509 0.000073 0.008748 -10575 1 0.000255 1560.000000 -0.000973 0.000552 0.001833 -10576 1 0.000199 1560.000000 -0.000925 -0.000568 0.004753 -10577 1 0.000247 1560.000000 0.000848 0.000727 0.005733 -10578 1 0.000255 1560.000000 0.002145 -0.002835 0.003887 -10579 1 0.000248 1560.000000 -0.003222 -0.001190 0.005254 -10580 1 0.000218 1560.000000 0.000156 0.001782 0.001641 -10581 1 0.000197 1560.000000 0.000928 0.002265 0.002363 -10582 1 0.000246 1560.000000 -0.003306 0.000912 0.006244 -10583 1 0.000268 1560.000000 -0.003458 0.001411 0.008200 -10584 1 0.000237 1560.000000 0.001701 -0.000113 0.000887 -10585 1 0.000281 1560.000000 -0.002372 -0.001766 0.000155 -10586 1 0.000242 1560.000000 -0.001205 -0.003361 0.000857 -10587 1 0.000252 1560.000000 0.002765 0.001128 0.008116 -10588 1 0.000235 1560.000000 -0.001802 -0.002678 0.004586 -10589 1 0.000286 1560.000000 0.000264 0.002647 0.009438 -10590 1 0.000206 1560.000000 0.003338 0.000409 0.001874 -10591 1 0.000204 1560.000000 0.000099 -0.003769 0.003599 -10592 1 0.000203 1560.000000 -0.000142 0.001366 0.000729 -10593 1 0.000200 1560.000000 -0.000977 -0.002557 0.008477 -10594 1 0.000209 1560.000000 0.003182 0.002078 0.001282 -10595 1 0.000212 1560.000000 0.000984 -0.000704 0.002847 -10596 1 0.000250 1560.000000 0.000334 -0.003801 0.000865 -10597 1 0.000228 1560.000000 -0.001069 0.001162 0.007435 -10598 1 0.000287 1560.000000 0.002701 -0.000525 0.005020 -10599 1 0.000244 1560.000000 0.000110 0.001070 0.001708 -10600 1 0.000196 1560.000000 -0.001113 0.001200 0.004718 -10601 1 0.000203 1560.000000 0.002140 -0.000835 0.004757 -10602 1 0.000243 1560.000000 0.002802 -0.001415 0.005273 -10603 1 0.000198 1560.000000 -0.001002 0.002632 0.001943 -10604 1 0.000230 1560.000000 0.001087 0.000125 0.006626 -10605 1 0.000195 1560.000000 -0.001774 -0.002415 0.003857 -10606 1 0.000249 1560.000000 0.002884 -0.002148 0.006725 -10607 1 0.000266 1560.000000 0.001583 0.002948 0.000646 -10608 1 0.000217 1560.000000 -0.000368 -0.002509 0.008860 -10609 1 0.000248 1560.000000 -0.001386 0.003572 0.007612 -10610 1 0.000196 1560.000000 0.001081 -0.000767 0.008655 -10611 1 0.000203 1560.000000 0.001625 -0.001158 0.005129 -10612 1 0.000208 1560.000000 0.001068 0.001515 0.005919 -10613 1 0.000218 1560.000000 -0.003047 -0.000518 0.008179 -10614 1 0.000193 1560.000000 -0.001184 -0.001598 0.005811 -10615 1 0.000237 1560.000000 -0.001878 -0.001805 0.009363 -10616 1 0.000227 1560.000000 0.001847 -0.002586 0.002339 -10617 1 0.000238 1560.000000 -0.000064 -0.001817 0.005986 -10618 1 0.000197 1560.000000 -0.002821 -0.001071 0.002900 -10619 1 0.000206 1560.000000 0.000433 0.002375 0.006698 -10620 1 0.000258 1560.000000 0.003378 -0.000651 0.007369 -10621 1 0.000238 1560.000000 0.000894 -0.002055 0.006892 -10622 1 0.000256 1560.000000 -0.001467 0.000795 0.002638 -10623 1 0.000261 1560.000000 -0.000698 0.002007 0.008195 -10624 1 0.000197 1560.000000 0.001885 -0.000506 0.000219 -10625 1 0.000229 1560.000000 0.003443 -0.001376 0.007590 -10626 1 0.000195 1560.000000 0.001977 0.001035 0.005998 -10627 1 0.000224 1560.000000 0.003833 0.000208 0.001273 -10628 1 0.000249 1560.000000 -0.002603 -0.002601 0.007208 -10629 1 0.000194 1560.000000 0.002211 -0.000304 0.005677 -10630 1 0.000197 1560.000000 -0.002464 0.000008 0.000500 -10631 1 0.000232 1560.000000 -0.002352 -0.001657 0.001064 -10632 1 0.000247 1560.000000 -0.001821 -0.001950 0.008563 -10633 1 0.000230 1560.000000 0.000075 -0.001455 0.006203 -10634 1 0.000213 1560.000000 -0.001362 -0.000347 0.002440 -10635 1 0.000207 1560.000000 -0.000095 0.000319 0.003155 -10636 1 0.000247 1560.000000 0.000521 -0.002821 0.002680 -10637 1 0.000214 1560.000000 -0.001268 -0.003055 0.007948 -10638 1 0.000231 1560.000000 0.000549 -0.003768 0.002672 -10639 1 0.000261 1560.000000 -0.000765 -0.000917 0.007091 -10640 1 0.000224 1560.000000 -0.000329 0.000643 0.000167 -10641 1 0.000223 1560.000000 0.000840 -0.001626 0.003169 -10642 1 0.000198 1560.000000 -0.002345 -0.000113 0.009237 -10643 1 0.000229 1560.000000 0.001555 -0.001919 0.007228 -10644 1 0.000196 1560.000000 0.000981 -0.002639 0.003015 -10645 1 0.000223 1560.000000 0.001505 0.000372 0.004853 -10646 1 0.000210 1560.000000 -0.001011 0.002988 0.007995 -10647 1 0.000201 1560.000000 0.000289 -0.003181 0.008027 -10648 1 0.000209 1560.000000 -0.001743 -0.000760 0.009034 -10649 1 0.000196 1560.000000 0.003151 0.000883 0.003956 -10650 1 0.000223 1560.000000 0.001911 0.002801 0.002545 -10651 1 0.000228 1560.000000 -0.000942 -0.000368 0.003725 -10652 1 0.000236 1560.000000 -0.000303 0.003747 0.006468 -10653 1 0.000266 1560.000000 0.003087 0.000653 0.005463 -10654 1 0.000232 1560.000000 0.003051 0.001082 0.006681 -10655 1 0.000209 1560.000000 -0.001047 -0.001767 0.003177 -10656 1 0.000277 1560.000000 0.003077 0.000450 0.002947 -10657 1 0.000259 1560.000000 0.002425 0.002212 0.007683 -10658 1 0.000236 1560.000000 -0.000580 0.003305 0.005180 -10659 1 0.000199 1560.000000 0.001820 -0.001511 0.005865 -10660 1 0.000280 1560.000000 0.002985 0.002201 0.001475 -10661 1 0.000223 1560.000000 0.000195 -0.001157 0.003451 -10662 1 0.000213 1560.000000 0.001432 -0.002920 0.003072 -10663 1 0.000225 1560.000000 0.002069 0.000330 0.009672 -10664 1 0.000229 1560.000000 0.001854 -0.001189 0.006960 -10665 1 0.000213 1560.000000 0.002515 -0.002913 0.001189 -10666 1 0.000281 1560.000000 0.002632 -0.000552 0.004401 -10667 1 0.000220 1560.000000 0.003187 0.002066 0.006216 -10668 1 0.000241 1560.000000 -0.001529 0.001409 0.005563 -10669 1 0.000201 1560.000000 0.002686 -0.000168 0.001879 -10670 1 0.000207 1560.000000 0.002078 0.002038 0.004014 -10671 1 0.000226 1560.000000 0.001429 -0.000230 0.001652 -10672 1 0.000241 1560.000000 -0.001478 0.000290 0.005875 -10673 1 0.000194 1560.000000 -0.000118 0.003096 0.005330 -10674 1 0.000221 1560.000000 0.001219 -0.003243 0.000306 -10675 1 0.000208 1560.000000 -0.001994 -0.001190 0.008813 -10676 1 0.000219 1560.000000 0.003411 0.001452 0.008903 -10677 1 0.000276 1560.000000 -0.002136 -0.000703 0.006633 -10678 1 0.000196 1560.000000 -0.000742 0.002116 0.001892 -10679 1 0.000244 1560.000000 0.001500 0.000066 0.009523 -10680 1 0.000219 1560.000000 0.001089 0.000493 0.008042 -10681 1 0.000285 1560.000000 0.003337 0.001152 0.005099 -10682 1 0.000203 1560.000000 0.003640 0.001139 0.008969 -10683 1 0.000202 1560.000000 0.000126 0.002142 0.005162 -10684 1 0.000245 1560.000000 0.000449 0.003045 0.000877 -10685 1 0.000263 1560.000000 0.000293 0.002104 0.002431 -10686 1 0.000265 1560.000000 0.000540 0.001407 0.008910 -10687 1 0.000212 1560.000000 -0.002470 0.001597 0.003148 -10688 1 0.000198 1560.000000 -0.002312 0.001599 0.007738 -10689 1 0.000215 1560.000000 -0.000700 0.003543 0.002689 -10690 1 0.000215 1560.000000 0.003143 -0.001223 0.000129 -10691 1 0.000197 1560.000000 0.003589 -0.001203 0.000817 -10692 1 0.000195 1560.000000 0.000477 0.000574 0.003326 -10693 1 0.000232 1560.000000 0.001296 0.002273 0.002867 -10694 1 0.000201 1560.000000 0.001619 0.002738 0.002131 -10695 1 0.000280 1560.000000 0.002593 0.002277 0.008906 -10696 1 0.000229 1560.000000 -0.001891 -0.001467 0.004864 -10697 1 0.000199 1560.000000 -0.002878 0.002457 0.000863 -10698 1 0.000230 1560.000000 -0.003711 0.000001 0.000482 -10699 1 0.000288 1560.000000 -0.002175 -0.002730 0.002415 -10700 1 0.000201 1560.000000 0.002443 0.002662 0.005423 -10701 1 0.000274 1560.000000 0.001163 -0.003566 0.007989 -10702 1 0.000218 1560.000000 -0.000806 -0.003440 0.008704 -10703 1 0.000234 1560.000000 0.003546 -0.001033 0.002079 -10704 1 0.000248 1560.000000 0.001616 0.002004 0.006396 -10705 1 0.000207 1560.000000 -0.001303 0.000117 0.004411 -10706 1 0.000237 1560.000000 0.000004 -0.003681 0.008306 -10707 1 0.000198 1560.000000 -0.002955 -0.001853 0.003440 -10708 1 0.000220 1560.000000 -0.000027 0.000351 0.001312 -10709 1 0.000234 1560.000000 0.003691 0.000817 0.007937 -10710 1 0.000251 1560.000000 0.000174 -0.003119 0.004830 -10711 1 0.000223 1560.000000 0.000380 0.001289 0.003410 -10712 1 0.000215 1560.000000 -0.003679 -0.001140 0.008606 -10713 1 0.000268 1560.000000 0.002090 -0.002080 0.007930 -10714 1 0.000285 1560.000000 -0.002657 0.000957 0.002643 -10715 1 0.000260 1560.000000 0.001082 0.000460 0.004342 -10716 1 0.000284 1560.000000 0.001167 0.002940 0.007010 -10717 1 0.000210 1560.000000 -0.001500 0.000380 0.001791 -10718 1 0.000258 1560.000000 0.000852 -0.003363 0.005474 -10719 1 0.000229 1560.000000 -0.002839 0.000858 0.002444 -10720 1 0.000255 1560.000000 0.000733 -0.003704 0.005984 -10721 1 0.000209 1560.000000 0.001681 -0.000915 0.005926 -10722 1 0.000200 1560.000000 0.001076 -0.000180 0.008344 -10723 1 0.000193 1560.000000 -0.001380 -0.002327 0.008689 -10724 1 0.000234 1560.000000 -0.002249 0.000348 0.008446 -10725 1 0.000240 1560.000000 0.001216 -0.003578 0.008293 -10726 1 0.000253 1560.000000 0.002351 0.001945 0.005790 -10727 1 0.000206 1560.000000 -0.000844 0.000766 0.001635 -10728 1 0.000193 1560.000000 0.002766 -0.002489 0.003042 -10729 1 0.000249 1560.000000 0.000280 -0.001165 0.004395 -10730 1 0.000207 1560.000000 0.003041 0.000576 0.009685 -10731 1 0.000193 1560.000000 -0.000355 -0.001063 0.003680 -10732 1 0.000210 1560.000000 -0.001809 -0.001896 0.009577 -10733 1 0.000264 1560.000000 0.003411 -0.000181 0.002188 -10734 1 0.000202 1560.000000 -0.002772 -0.001102 0.005552 -10735 1 0.000233 1560.000000 -0.002478 0.001406 0.004874 -10736 1 0.000234 1560.000000 0.002874 -0.001686 0.001981 -10737 1 0.000201 1560.000000 -0.000925 0.001164 0.003098 -10738 1 0.000203 1560.000000 0.001883 0.000857 0.002894 -10739 1 0.000255 1560.000000 0.000726 -0.002990 0.007487 -10740 1 0.000267 1560.000000 0.002428 -0.002350 0.006624 -10741 1 0.000215 1560.000000 -0.002779 0.002269 0.001796 -10742 1 0.000263 1560.000000 0.001123 -0.002662 0.000469 -10743 1 0.000205 1560.000000 -0.003116 0.002198 0.008163 -10744 1 0.000258 1560.000000 -0.002475 -0.001973 0.003063 -10745 1 0.000256 1560.000000 0.001915 0.001129 0.008065 -10746 1 0.000259 1560.000000 -0.002186 -0.000140 0.006264 -10747 1 0.000243 1560.000000 -0.001083 -0.001072 0.008353 -10748 1 0.000201 1560.000000 -0.000479 0.002185 0.002785 -10749 1 0.000193 1560.000000 -0.002380 -0.001568 0.009213 -10750 1 0.000272 1560.000000 -0.002772 0.000308 0.006602 -10751 1 0.000256 1560.000000 -0.001234 -0.001425 0.001458 -10752 1 0.000214 1560.000000 -0.000432 0.002877 0.000660 -10753 1 0.000201 1560.000000 -0.002623 0.001174 0.008681 -10754 1 0.000259 1560.000000 0.002623 0.001753 0.004171 -10755 1 0.000226 1560.000000 0.001677 0.003204 0.004041 -10756 1 0.000245 1560.000000 -0.002076 0.000188 0.001081 -10757 1 0.000249 1560.000000 -0.002931 -0.002362 0.003717 -10758 1 0.000193 1560.000000 0.000355 0.003171 0.000655 -10759 1 0.000212 1560.000000 -0.002340 0.000283 0.001764 -10760 1 0.000193 1560.000000 -0.001416 0.000533 0.001338 -10761 1 0.000284 1560.000000 -0.002712 -0.001524 0.001205 -10762 1 0.000260 1560.000000 -0.001860 -0.002298 0.009013 -10763 1 0.000206 1560.000000 0.002621 0.002706 0.005063 -10764 1 0.000235 1560.000000 0.002493 0.002940 0.002563 -10765 1 0.000263 1560.000000 0.001322 0.002752 0.004266 -10766 1 0.000215 1560.000000 0.002150 0.000966 0.004668 -10767 1 0.000284 1560.000000 -0.002742 -0.002644 0.009367 -10768 1 0.000209 1560.000000 0.000294 -0.000717 0.008676 -10769 1 0.000213 1560.000000 -0.001617 0.000632 0.006756 -10770 1 0.000246 1560.000000 0.002746 0.001504 0.003862 -10771 1 0.000225 1560.000000 0.001005 0.000796 0.001766 -10772 1 0.000286 1560.000000 -0.003220 -0.000207 0.001334 -10773 1 0.000251 1560.000000 -0.000359 0.001531 0.000703 -10774 1 0.000270 1560.000000 -0.000059 -0.003522 0.002204 -10775 1 0.000205 1560.000000 -0.000838 -0.000393 0.002813 -10776 1 0.000209 1560.000000 -0.001936 0.000869 0.008084 -10777 1 0.000233 1560.000000 0.001379 -0.001351 0.002815 -10778 1 0.000239 1560.000000 0.000416 0.002402 0.005341 -10779 1 0.000226 1560.000000 0.001756 -0.002315 0.006148 -10780 1 0.000227 1560.000000 0.002992 -0.002220 0.005713 -10781 1 0.000271 1560.000000 0.001788 -0.002660 0.007763 -10782 1 0.000193 1560.000000 -0.003114 0.001017 0.001824 -10783 1 0.000201 1560.000000 -0.001859 -0.002848 0.006035 -10784 1 0.000252 1560.000000 0.000542 0.000568 0.003859 -10785 1 0.000194 1560.000000 -0.000559 -0.003289 0.004646 -10786 1 0.000204 1560.000000 -0.001214 -0.003337 0.003332 -10787 1 0.000285 1560.000000 -0.002030 0.000206 0.003016 -10788 1 0.000216 1560.000000 0.001615 -0.001720 0.002174 -10789 1 0.000276 1560.000000 -0.000038 0.002462 0.004949 -10790 1 0.000215 1560.000000 0.003353 0.001144 0.004347 -10791 1 0.000244 1560.000000 -0.002111 -0.002257 0.004719 -10792 1 0.000238 1560.000000 0.000971 -0.001795 0.001242 -10793 1 0.000248 1560.000000 0.000231 -0.000512 0.004647 -10794 1 0.000222 1560.000000 0.000567 0.001553 0.008569 -10795 1 0.000207 1560.000000 -0.003636 0.000925 0.006872 -10796 1 0.000283 1560.000000 0.001733 0.003364 0.009852 -10797 1 0.000218 1560.000000 -0.002036 -0.000735 0.007243 -10798 1 0.000234 1560.000000 -0.001570 -0.001382 0.007823 -10799 1 0.000259 1560.000000 -0.002773 0.000130 0.004334 -10800 1 0.000217 1560.000000 0.001075 -0.002370 0.003258 -10801 1 0.000237 1560.000000 0.002120 0.000737 0.006398 -10802 1 0.000210 1560.000000 -0.001426 0.003447 0.003699 -10803 1 0.000198 1560.000000 -0.002786 -0.000209 0.000395 -10804 1 0.000264 1560.000000 -0.000198 0.000484 0.004484 -10805 1 0.000236 1560.000000 -0.000226 -0.003657 0.009214 -10806 1 0.000288 1560.000000 0.001158 -0.002129 0.008204 -10807 1 0.000196 1560.000000 -0.002774 -0.002614 0.007878 -10808 1 0.000217 1560.000000 -0.002528 -0.001144 0.002262 -10809 1 0.000221 1560.000000 -0.001985 -0.000475 0.005364 -10810 1 0.000238 1560.000000 -0.000123 0.003337 0.007684 -10811 1 0.000221 1560.000000 0.000390 -0.002532 0.008047 -10812 1 0.000285 1560.000000 0.001016 -0.003565 0.001218 -10813 1 0.000285 1560.000000 -0.003121 -0.001846 0.006727 -10814 1 0.000233 1560.000000 -0.002947 0.001678 0.006440 -10815 1 0.000225 1560.000000 -0.001270 -0.001451 0.006622 -10816 1 0.000251 1560.000000 0.001991 0.001207 0.006784 -10817 1 0.000236 1560.000000 0.001447 -0.003140 0.009330 -10818 1 0.000230 1560.000000 0.000856 0.003562 0.000152 -10819 1 0.000220 1560.000000 0.002061 -0.001238 0.005973 -10820 1 0.000251 1560.000000 -0.002835 -0.000071 0.005361 -10821 1 0.000206 1560.000000 -0.002156 -0.002888 0.009678 -10822 1 0.000241 1560.000000 -0.003485 -0.000368 0.004679 -10823 1 0.000217 1560.000000 -0.000882 0.003655 0.002030 -10824 1 0.000210 1560.000000 0.001320 -0.000939 0.000635 -10825 1 0.000200 1560.000000 -0.000943 0.002199 0.002694 -10826 1 0.000246 1560.000000 0.000936 0.001057 0.008087 -10827 1 0.000215 1560.000000 -0.000915 0.000148 0.000441 -10828 1 0.000195 1560.000000 -0.001855 0.002174 0.000839 -10829 1 0.000215 1560.000000 0.002593 -0.000484 0.007704 -10830 1 0.000239 1560.000000 -0.003163 0.002083 0.004254 -10831 1 0.000212 1560.000000 0.000298 -0.000430 0.008509 -10832 1 0.000249 1560.000000 -0.002351 0.001761 0.008727 -10833 1 0.000262 1560.000000 -0.001744 0.003068 0.002120 -10834 1 0.000245 1560.000000 -0.000321 -0.002569 0.006203 -10835 1 0.000284 1560.000000 -0.000589 0.003791 0.009103 -10836 1 0.000212 1560.000000 -0.000296 -0.000711 0.009071 -10837 1 0.000228 1560.000000 0.002231 0.002164 0.002573 -10838 1 0.000233 1560.000000 -0.003523 -0.000643 0.009234 -10839 1 0.000245 1560.000000 -0.002600 -0.000512 0.002294 -10840 1 0.000271 1560.000000 -0.001079 0.003686 0.001855 -10841 1 0.000206 1560.000000 -0.002258 -0.000261 0.006059 -10842 1 0.000204 1560.000000 0.001668 -0.001338 0.008531 -10843 1 0.000203 1560.000000 0.001695 0.001253 0.008630 -10844 1 0.000209 1560.000000 0.002868 0.000569 0.000573 -10845 1 0.000241 1560.000000 -0.001580 0.000802 0.003883 -10846 1 0.000198 1560.000000 -0.002811 0.000779 0.003243 -10847 1 0.000228 1560.000000 -0.001650 0.000325 0.001274 -10848 1 0.000275 1560.000000 0.003267 -0.000079 0.002887 -10849 1 0.000204 1560.000000 -0.003766 0.000787 0.000392 -10850 1 0.000205 1560.000000 0.000340 0.003185 0.001966 -10851 1 0.000196 1560.000000 -0.002000 0.003245 0.009735 -10852 1 0.000272 1560.000000 -0.001316 -0.002629 0.007983 -10853 1 0.000212 1560.000000 -0.000020 0.001503 0.006548 -10854 1 0.000204 1560.000000 0.001085 0.001032 0.008828 -10855 1 0.000239 1560.000000 -0.002821 0.000508 0.002111 -10856 1 0.000267 1560.000000 0.000732 -0.002140 0.008590 -10857 1 0.000233 1560.000000 -0.002176 -0.001008 0.006915 -10858 1 0.000267 1560.000000 0.003296 -0.001835 0.008588 -10859 1 0.000277 1560.000000 -0.002565 -0.000294 0.005319 -10860 1 0.000209 1560.000000 0.002201 -0.002764 0.009285 -10861 1 0.000232 1560.000000 0.000697 0.000335 0.007320 -10862 1 0.000251 1560.000000 -0.000358 -0.001343 0.008374 -10863 1 0.000234 1560.000000 0.000883 0.000025 0.004383 -10864 1 0.000211 1560.000000 0.003478 -0.000493 0.005499 -10865 1 0.000226 1560.000000 0.001942 -0.001520 0.009293 -10866 1 0.000239 1560.000000 -0.000855 0.003460 0.007954 -10867 1 0.000236 1560.000000 0.000516 0.001268 0.001549 -10868 1 0.000251 1560.000000 -0.001192 0.002822 0.005389 -10869 1 0.000260 1560.000000 0.000361 -0.002810 0.008857 -10870 1 0.000208 1560.000000 0.003178 -0.001190 0.005803 -10871 1 0.000194 1560.000000 0.000142 -0.002447 0.009423 -10872 1 0.000223 1560.000000 0.000974 -0.001390 0.000132 -10873 1 0.000271 1560.000000 -0.001158 0.002533 0.003337 -10874 1 0.000196 1560.000000 0.001143 -0.000919 0.005690 -10875 1 0.000278 1560.000000 -0.003003 -0.001850 0.007657 -10876 1 0.000194 1560.000000 -0.001680 -0.003157 0.000326 -10877 1 0.000285 1560.000000 0.000246 0.003567 0.003004 -10878 1 0.000199 1560.000000 -0.003502 0.001509 0.002812 -10879 1 0.000265 1560.000000 -0.002714 -0.000890 0.007850 -10880 1 0.000229 1560.000000 -0.001710 0.001934 0.007397 -10881 1 0.000195 1560.000000 -0.002305 -0.002607 0.006862 -10882 1 0.000193 1560.000000 -0.002205 0.000032 0.004229 -10883 1 0.000256 1560.000000 -0.001838 -0.000552 0.002590 -10884 1 0.000193 1560.000000 0.003288 -0.001639 0.003328 -10885 1 0.000256 1560.000000 -0.001850 -0.001917 0.002791 -10886 1 0.000200 1560.000000 -0.000643 0.002155 0.009793 -10887 1 0.000282 1560.000000 0.002817 -0.000509 0.006802 -10888 1 0.000203 1560.000000 0.000957 0.000825 0.009483 -10889 1 0.000278 1560.000000 0.002532 0.000345 0.009839 -10890 1 0.000242 1560.000000 0.002958 0.000004 0.001842 -10891 1 0.000194 1560.000000 0.000055 0.000991 0.009354 -10892 1 0.000263 1560.000000 0.001185 0.003570 0.006807 -10893 1 0.000285 1560.000000 -0.000371 -0.001935 0.000660 -10894 1 0.000287 1560.000000 0.001179 -0.003367 0.002969 -10895 1 0.000262 1560.000000 0.002065 0.000999 0.000966 -10896 1 0.000192 1560.000000 -0.000276 0.000678 0.008457 -10897 1 0.000205 1560.000000 0.000004 0.001248 0.008681 -10898 1 0.000262 1560.000000 0.002576 -0.001824 0.007402 -10899 1 0.000254 1560.000000 0.002417 -0.002845 0.007954 -10900 1 0.000263 1560.000000 -0.002816 0.001998 0.007566 -10901 1 0.000210 1560.000000 -0.001685 0.003342 0.009277 -10902 1 0.000263 1560.000000 0.002452 0.000381 0.005569 -10903 1 0.000286 1560.000000 -0.003083 -0.002299 0.008290 -10904 1 0.000240 1560.000000 0.000498 0.001976 0.000474 -10905 1 0.000210 1560.000000 -0.000113 0.002626 0.007709 -10906 1 0.000198 1560.000000 -0.003824 0.000127 0.005572 -10907 1 0.000253 1560.000000 0.000473 0.000089 0.003336 -10908 1 0.000210 1560.000000 -0.001629 0.002617 0.003442 -10909 1 0.000255 1560.000000 0.000879 -0.002939 0.008152 -10910 1 0.000202 1560.000000 -0.002357 -0.000931 0.003615 -10911 1 0.000210 1560.000000 0.002963 -0.001168 0.000735 -10912 1 0.000212 1560.000000 -0.001172 -0.002297 0.000507 -10913 1 0.000251 1560.000000 -0.001897 -0.002959 0.008818 -10914 1 0.000255 1560.000000 -0.001547 0.001122 0.006501 -10915 1 0.000256 1560.000000 -0.001657 0.003146 0.009047 -10916 1 0.000228 1560.000000 -0.000701 0.003734 0.006555 -10917 1 0.000257 1560.000000 -0.001154 0.001870 0.001158 -10918 1 0.000223 1560.000000 -0.000836 -0.000880 0.005689 -10919 1 0.000261 1560.000000 -0.001495 -0.000160 0.006117 -10920 1 0.000204 1560.000000 0.002771 0.000420 0.007013 -10921 1 0.000198 1560.000000 0.003670 0.000196 0.007135 -10922 1 0.000281 1560.000000 0.000286 -0.002175 0.000464 -10923 1 0.000235 1560.000000 -0.002506 -0.001731 0.004122 -10924 1 0.000267 1560.000000 0.002212 -0.000152 0.006764 -10925 1 0.000237 1560.000000 -0.002898 -0.001374 0.004364 -10926 1 0.000254 1560.000000 0.000217 0.001499 0.006897 -10927 1 0.000239 1560.000000 0.001480 0.001412 0.009310 -10928 1 0.000195 1560.000000 -0.000746 0.002500 0.009244 -10929 1 0.000241 1560.000000 -0.000485 -0.000913 0.000938 -10930 1 0.000220 1560.000000 -0.003522 0.001502 0.009595 -10931 1 0.000225 1560.000000 0.001109 0.001695 0.000773 -10932 1 0.000269 1560.000000 -0.001830 0.001903 0.008785 -10933 1 0.000214 1560.000000 -0.001417 0.001469 0.006097 -10934 1 0.000263 1560.000000 -0.000061 0.002591 0.006481 -10935 1 0.000228 1560.000000 -0.000114 -0.002573 0.009473 -10936 1 0.000193 1560.000000 0.000861 0.001621 0.005570 -10937 1 0.000202 1560.000000 0.001432 0.002364 0.005140 -10938 1 0.000244 1560.000000 -0.001061 0.002418 0.008051 -10939 1 0.000210 1560.000000 0.002613 -0.002544 0.000835 -10940 1 0.000234 1560.000000 0.000168 -0.001635 0.006553 -10941 1 0.000275 1560.000000 0.001130 0.001115 0.001946 -10942 1 0.000223 1560.000000 -0.003065 -0.000648 0.001794 -10943 1 0.000230 1560.000000 0.002626 -0.000839 0.002758 -10944 1 0.000276 1560.000000 -0.003791 -0.000261 0.000904 -10945 1 0.000210 1560.000000 0.000980 0.000761 0.002551 -10946 1 0.000229 1560.000000 0.001897 0.000380 0.005116 -10947 1 0.000227 1560.000000 -0.000385 0.001891 0.002342 -10948 1 0.000215 1560.000000 -0.001211 0.000099 0.009357 -10949 1 0.000232 1560.000000 0.001589 -0.000929 0.009539 -10950 1 0.000220 1560.000000 -0.002252 -0.002085 0.009205 -10951 1 0.000262 1560.000000 0.001907 0.003150 0.006458 -10952 1 0.000209 1560.000000 0.001580 0.002466 0.008392 -10953 1 0.000267 1560.000000 -0.000522 -0.002797 0.002120 -10954 1 0.000271 1560.000000 0.003621 0.001046 0.006716 -10955 1 0.000197 1560.000000 0.002889 -0.001945 0.008353 -10956 1 0.000276 1560.000000 0.001258 -0.002811 0.008339 -10957 1 0.000274 1560.000000 0.001936 -0.002414 0.007306 -10958 1 0.000197 1560.000000 -0.002150 -0.002883 0.006666 -10959 1 0.000208 1560.000000 -0.001741 -0.000367 0.008881 -10960 1 0.000261 1560.000000 -0.002066 0.001405 0.006991 -10961 1 0.000198 1560.000000 -0.002650 -0.001516 0.007260 -10962 1 0.000217 1560.000000 -0.003059 0.000564 0.004572 -10963 1 0.000231 1560.000000 -0.002080 0.000637 0.007779 -10964 1 0.000242 1560.000000 0.002628 -0.000998 0.007143 -10965 1 0.000284 1560.000000 0.003109 -0.001863 0.008291 -10966 1 0.000247 1560.000000 -0.000798 0.000655 0.006380 -10967 1 0.000278 1560.000000 0.001285 0.001582 0.008067 -10968 1 0.000202 1560.000000 -0.002793 0.002478 0.009308 -10969 1 0.000254 1560.000000 0.000169 0.002962 0.007075 -10970 1 0.000226 1560.000000 0.001500 0.002958 0.009796 -10971 1 0.000195 1560.000000 0.001930 -0.000816 0.004043 -10972 1 0.000251 1560.000000 -0.001659 0.003399 0.003994 -10973 1 0.000235 1560.000000 -0.001079 0.001255 0.005715 -10974 1 0.000226 1560.000000 0.001206 -0.000018 0.004891 -10975 1 0.000230 1560.000000 -0.003503 0.001588 0.003041 -10976 1 0.000243 1560.000000 -0.000751 -0.003731 0.005385 -10977 1 0.000277 1560.000000 -0.000103 -0.001880 0.008161 -10978 1 0.000203 1560.000000 0.002645 -0.001340 0.005974 -10979 1 0.000229 1560.000000 0.001700 0.003420 0.003570 -10980 1 0.000198 1560.000000 0.001738 0.002522 0.005365 -10981 1 0.000279 1560.000000 -0.000635 -0.001230 0.004428 -10982 1 0.000257 1560.000000 -0.001727 -0.000984 0.008613 -10983 1 0.000226 1560.000000 0.001942 0.001619 0.009079 -10984 1 0.000201 1560.000000 -0.000354 -0.001015 0.006423 -10985 1 0.000261 1560.000000 -0.001424 0.000621 0.004172 -10986 1 0.000219 1560.000000 -0.003412 0.000135 0.009393 -10987 1 0.000215 1560.000000 0.002513 0.001255 0.003530 -10988 1 0.000245 1560.000000 0.001929 0.002636 0.000380 -10989 1 0.000217 1560.000000 -0.000899 0.000715 0.000370 -10990 1 0.000206 1560.000000 0.000568 -0.000731 0.003369 -10991 1 0.000252 1560.000000 0.002983 0.002013 0.006048 -10992 1 0.000208 1560.000000 0.000945 -0.003458 0.008839 -10993 1 0.000203 1560.000000 -0.003023 0.001286 0.003792 -10994 1 0.000236 1560.000000 -0.003057 -0.001010 0.000369 -10995 1 0.000279 1560.000000 0.000039 -0.001140 0.001755 -10996 1 0.000220 1560.000000 -0.000419 -0.003830 0.000349 -10997 1 0.000254 1560.000000 -0.002976 -0.000263 0.006591 -10998 1 0.000262 1560.000000 0.002261 0.001431 0.003544 -10999 1 0.000207 1560.000000 -0.001258 0.003185 0.005581 -11000 1 0.000234 1560.000000 0.002039 0.002583 0.002506 -11001 1 0.000270 1560.000000 -0.001992 -0.002426 0.009577 -11002 1 0.000221 1560.000000 0.000665 0.001089 0.001896 -11003 1 0.000212 1560.000000 -0.001736 0.002444 0.007380 -11004 1 0.000209 1560.000000 0.000668 0.000271 0.008523 -11005 1 0.000199 1560.000000 -0.001822 -0.000148 0.001257 -11006 1 0.000217 1560.000000 0.000043 -0.002794 0.000665 -11007 1 0.000261 1560.000000 -0.001689 0.000260 0.003886 -11008 1 0.000223 1560.000000 -0.000513 -0.001288 0.001060 -11009 1 0.000283 1560.000000 -0.002449 -0.002537 0.006394 -11010 1 0.000197 1560.000000 -0.000958 -0.001103 0.002175 -11011 1 0.000224 1560.000000 0.003297 0.001178 0.005732 -11012 1 0.000207 1560.000000 0.001699 0.000647 0.000655 -11013 1 0.000218 1560.000000 0.001075 -0.003600 0.009037 -11014 1 0.000237 1560.000000 0.001236 0.001976 0.005095 -11015 1 0.000214 1560.000000 0.000275 0.001698 0.005779 -11016 1 0.000265 1560.000000 0.001513 -0.000107 0.008274 -11017 1 0.000212 1560.000000 0.002421 -0.001336 0.004294 -11018 1 0.000238 1560.000000 0.000458 -0.002750 0.009536 -11019 1 0.000245 1560.000000 -0.000680 -0.003331 0.005623 -11020 1 0.000260 1560.000000 -0.000226 -0.001054 0.005387 -11021 1 0.000210 1560.000000 -0.001561 0.003445 0.006912 -11022 1 0.000231 1560.000000 -0.001361 -0.003263 0.003550 -11023 1 0.000241 1560.000000 -0.002919 -0.002417 0.000166 -11024 1 0.000204 1560.000000 -0.002403 0.000849 0.008240 -11025 1 0.000287 1560.000000 0.001470 0.002872 0.008296 -11026 1 0.000206 1560.000000 -0.001275 0.000053 0.006773 -11027 1 0.000280 1560.000000 -0.001354 0.002611 0.009342 -11028 1 0.000195 1560.000000 -0.003591 0.001201 0.004581 -11029 1 0.000249 1560.000000 -0.003144 -0.000266 0.003265 -11030 1 0.000234 1560.000000 -0.003296 0.000539 0.003361 -11031 1 0.000196 1560.000000 0.000107 0.003267 0.001123 -11032 1 0.000192 1560.000000 -0.001117 -0.001213 0.002272 -11033 1 0.000200 1560.000000 -0.001067 0.001792 0.008628 -11034 1 0.000275 1560.000000 -0.002258 -0.002458 0.002056 -11035 1 0.000215 1560.000000 0.001578 -0.001851 0.006747 -11036 1 0.000207 1560.000000 0.000807 -0.000680 0.000814 -11037 1 0.000257 1560.000000 0.003381 -0.001189 0.000691 -11038 1 0.000268 1560.000000 0.002320 -0.001396 0.006954 -11039 1 0.000209 1560.000000 0.001954 -0.000776 0.006622 -11040 1 0.000244 1560.000000 -0.001243 -0.002241 0.007826 -11041 1 0.000266 1560.000000 0.003352 0.001488 0.004594 -11042 1 0.000236 1560.000000 -0.002785 -0.002376 0.004690 -11043 1 0.000201 1560.000000 -0.001388 0.003041 0.006230 -11044 1 0.000247 1560.000000 0.002740 -0.000424 0.003680 -11045 1 0.000228 1560.000000 -0.003202 -0.000412 0.009524 -11046 1 0.000270 1560.000000 -0.003781 -0.000419 0.006856 -11047 1 0.000210 1560.000000 -0.000780 0.002942 0.009814 -11048 1 0.000243 1560.000000 0.002156 0.002681 0.008441 -11049 1 0.000262 1560.000000 -0.003597 -0.000220 0.003404 -11050 1 0.000250 1560.000000 0.002248 -0.001421 0.006595 -11051 1 0.000202 1560.000000 -0.001825 -0.000328 0.009544 -11052 1 0.000284 1560.000000 -0.001964 0.003124 0.009343 -11053 1 0.000261 1560.000000 -0.000172 -0.003387 0.001477 -11054 1 0.000202 1560.000000 -0.002062 -0.001661 0.006285 -11055 1 0.000285 1560.000000 -0.000234 0.001682 0.002919 -11056 1 0.000208 1560.000000 -0.000807 0.000980 0.003179 -11057 1 0.000247 1560.000000 -0.000416 -0.003654 0.009040 -11058 1 0.000209 1560.000000 -0.001886 -0.002004 0.003039 -11059 1 0.000247 1560.000000 0.002342 -0.000241 0.009633 -11060 1 0.000202 1560.000000 -0.002117 0.001917 0.003619 -11061 1 0.000242 1560.000000 -0.000312 -0.003631 0.009573 -11062 1 0.000257 1560.000000 -0.000609 -0.002274 0.009575 -11063 1 0.000206 1560.000000 -0.002852 0.000569 0.007799 -11064 1 0.000256 1560.000000 -0.002968 0.001038 0.006265 -11065 1 0.000283 1560.000000 0.002228 -0.002872 0.008527 -11066 1 0.000273 1560.000000 0.001012 0.002728 0.002450 -11067 1 0.000260 1560.000000 0.002455 0.001880 0.007962 -11068 1 0.000250 1560.000000 -0.001417 -0.000033 0.009341 -11069 1 0.000247 1560.000000 -0.000383 -0.000344 0.008461 -11070 1 0.000203 1560.000000 0.003675 -0.000794 0.006290 -11071 1 0.000243 1560.000000 -0.002429 0.002322 0.005659 -11072 1 0.000231 1560.000000 0.003063 -0.001192 0.006613 -11073 1 0.000200 1560.000000 0.002140 -0.000331 0.000743 -11074 1 0.000213 1560.000000 -0.002808 0.000840 0.007202 -11075 1 0.000264 1560.000000 0.002878 -0.001693 0.005892 -11076 1 0.000210 1560.000000 -0.000708 0.002363 0.008458 -11077 1 0.000229 1560.000000 0.001436 -0.003018 0.001897 -11078 1 0.000277 1560.000000 -0.000438 -0.003389 0.002957 -11079 1 0.000272 1560.000000 -0.000773 -0.003739 0.003206 -11080 1 0.000196 1560.000000 -0.000456 -0.000400 0.003181 -11081 1 0.000222 1560.000000 -0.003349 -0.000866 0.006101 -11082 1 0.000229 1560.000000 -0.002886 0.001186 0.002110 -11083 1 0.000250 1560.000000 0.000259 0.000825 0.008229 -11084 1 0.000211 1560.000000 0.000064 0.002588 0.006250 -11085 1 0.000270 1560.000000 -0.000556 -0.003106 0.007657 -11086 1 0.000205 1560.000000 -0.001432 -0.000861 0.007159 -11087 1 0.000263 1560.000000 -0.003076 -0.000362 0.002350 -11088 1 0.000196 1560.000000 -0.000797 0.002772 0.004609 -11089 1 0.000227 1560.000000 -0.002644 -0.000384 0.001031 -11090 1 0.000258 1560.000000 -0.002769 -0.000796 0.003530 -11091 1 0.000214 1560.000000 -0.003656 0.000221 0.008469 -11092 1 0.000237 1560.000000 0.001308 0.001556 0.001814 -11093 1 0.000196 1560.000000 -0.001260 -0.001334 0.006112 -11094 1 0.000233 1560.000000 0.001456 -0.002458 0.004227 -11095 1 0.000195 1560.000000 0.000263 0.001568 0.008033 -11096 1 0.000261 1560.000000 0.001105 -0.001250 0.007708 -11097 1 0.000228 1560.000000 0.003613 -0.000234 0.002367 -11098 1 0.000279 1560.000000 -0.000626 0.002688 0.006085 -11099 1 0.000212 1560.000000 -0.001640 -0.001437 0.006505 -11100 1 0.000227 1560.000000 0.000848 -0.001117 0.004475 -11101 1 0.000228 1560.000000 -0.002424 0.000630 0.007625 -11102 1 0.000226 1560.000000 0.000098 -0.002318 0.006635 -11103 1 0.000230 1560.000000 -0.002757 -0.001315 0.004651 -11104 1 0.000269 1560.000000 -0.000036 0.003463 0.002368 -11105 1 0.000208 1560.000000 -0.000300 0.002830 0.008168 -11106 1 0.000199 1560.000000 0.002146 -0.002252 0.008723 -11107 1 0.000245 1560.000000 0.000501 0.002416 0.000883 -11108 1 0.000231 1560.000000 -0.000681 -0.001406 0.005491 -11109 1 0.000209 1560.000000 -0.000825 -0.002370 0.004060 -11110 1 0.000205 1560.000000 0.003181 -0.000764 0.007260 -11111 1 0.000196 1560.000000 -0.001494 -0.001634 0.004661 -11112 1 0.000253 1560.000000 -0.002177 -0.002416 0.005127 -11113 1 0.000250 1560.000000 0.002999 0.000641 0.003766 -11114 1 0.000196 1560.000000 0.000732 0.003608 0.005604 -11115 1 0.000193 1560.000000 -0.003287 0.000634 0.008918 -11116 1 0.000251 1560.000000 0.003099 0.000844 0.008782 -11117 1 0.000219 1560.000000 -0.002442 -0.001426 0.003870 -11118 1 0.000223 1560.000000 -0.002823 0.000125 0.002615 -11119 1 0.000237 1560.000000 -0.003382 -0.001851 0.003800 -11120 1 0.000210 1560.000000 0.000104 0.000736 0.008471 -11121 1 0.000196 1560.000000 0.001832 0.000470 0.003000 -11122 1 0.000217 1560.000000 -0.001212 0.002289 0.006569 -11123 1 0.000198 1560.000000 0.002306 -0.002441 0.005963 -11124 1 0.000238 1560.000000 -0.000900 -0.000392 0.005172 -11125 1 0.000202 1560.000000 -0.001548 -0.003303 0.001747 -11126 1 0.000215 1560.000000 -0.000478 -0.001185 0.000457 -11127 1 0.000214 1560.000000 0.000344 0.000101 0.009802 -11128 1 0.000195 1560.000000 0.002342 -0.002426 0.008779 -11129 1 0.000204 1560.000000 -0.000495 -0.002286 0.002544 -11130 1 0.000256 1560.000000 -0.002050 -0.000671 0.006053 -11131 1 0.000253 1560.000000 -0.003290 0.000523 0.000237 -11132 1 0.000223 1560.000000 0.002530 0.001759 0.003827 -11133 1 0.000230 1560.000000 -0.001163 -0.002468 0.004567 -11134 1 0.000255 1560.000000 0.000651 0.003446 0.003111 -11135 1 0.000270 1560.000000 0.000033 0.001709 0.007550 -11136 1 0.000195 1560.000000 0.003582 -0.000563 0.004665 -11137 1 0.000253 1560.000000 -0.003571 -0.000228 0.007371 -11138 1 0.000264 1560.000000 0.002294 -0.002634 0.003599 -11139 1 0.000227 1560.000000 -0.000067 0.002515 0.001504 -11140 1 0.000235 1560.000000 -0.001901 0.000551 0.009482 -11141 1 0.000211 1560.000000 0.002712 -0.001438 0.009587 -11142 1 0.000214 1560.000000 0.000523 0.001285 0.000405 -11143 1 0.000227 1560.000000 -0.003640 0.001122 0.007181 -11144 1 0.000275 1560.000000 0.001313 0.003040 0.008778 -11145 1 0.000253 1560.000000 -0.001242 0.003090 0.002157 -11146 1 0.000222 1560.000000 0.001420 -0.002399 0.001033 -11147 1 0.000193 1560.000000 0.001120 -0.003371 0.001911 -11148 1 0.000228 1560.000000 -0.000004 0.001695 0.009256 -11149 1 0.000260 1560.000000 -0.000100 -0.002509 0.004736 -11150 1 0.000236 1560.000000 -0.002067 -0.003044 0.008516 -11151 1 0.000218 1560.000000 -0.000027 -0.000892 0.001311 -11152 1 0.000239 1560.000000 -0.001752 0.000297 0.002554 -11153 1 0.000242 1560.000000 -0.001585 -0.000230 0.007395 -11154 1 0.000215 1560.000000 0.001425 -0.001866 0.003994 -11155 1 0.000262 1560.000000 -0.001705 -0.000585 0.000315 -11156 1 0.000265 1560.000000 -0.000701 0.001617 0.006983 -11157 1 0.000247 1560.000000 -0.000474 0.002495 0.002994 -11158 1 0.000229 1560.000000 0.002033 0.002946 0.000276 -11159 1 0.000233 1560.000000 0.002515 -0.001935 0.008246 -11160 1 0.000241 1560.000000 -0.001421 -0.000701 0.006970 -11161 1 0.000237 1560.000000 -0.001822 0.001955 0.007929 -11162 1 0.000264 1560.000000 -0.001182 0.001646 0.002468 -11163 1 0.000264 1560.000000 -0.002583 -0.001307 0.001403 -11164 1 0.000208 1560.000000 0.002907 -0.001540 0.000748 -11165 1 0.000234 1560.000000 0.001853 -0.000277 0.009354 -11166 1 0.000195 1560.000000 0.002093 -0.002318 0.001140 -11167 1 0.000208 1560.000000 -0.000164 0.001304 0.009787 -11168 1 0.000212 1560.000000 -0.001883 0.001602 0.007790 -11169 1 0.000203 1560.000000 -0.001194 -0.000390 0.003272 -11170 1 0.000234 1560.000000 0.002743 -0.001972 0.004099 -11171 1 0.000265 1560.000000 -0.002310 0.001107 0.005233 -11172 1 0.000227 1560.000000 -0.001566 -0.001849 0.008584 -11173 1 0.000209 1560.000000 -0.002247 -0.000365 0.001560 -11174 1 0.000221 1560.000000 -0.003249 -0.001558 0.005074 -11175 1 0.000193 1560.000000 0.002108 -0.000844 0.006825 -11176 1 0.000209 1560.000000 -0.002369 0.002362 0.001462 -11177 1 0.000208 1560.000000 -0.000004 0.002895 0.000711 -11178 1 0.000216 1560.000000 -0.001584 -0.003261 0.005183 -11179 1 0.000258 1560.000000 0.002352 0.002999 0.000252 -11180 1 0.000193 1560.000000 -0.001310 0.001419 0.001866 -11181 1 0.000208 1560.000000 -0.001409 -0.001297 0.008447 -11182 1 0.000197 1560.000000 -0.002554 -0.002769 0.004777 -11183 1 0.000198 1560.000000 -0.001497 -0.001404 0.003679 -11184 1 0.000213 1560.000000 -0.001988 0.001912 0.009160 -11185 1 0.000200 1560.000000 -0.001371 0.001885 0.001649 -11186 1 0.000245 1560.000000 0.002018 0.000942 0.001828 -11187 1 0.000238 1560.000000 0.002612 -0.001350 0.002916 -11188 1 0.000254 1560.000000 -0.001836 0.000547 0.007554 -11189 1 0.000271 1560.000000 -0.000230 0.003037 0.008004 -11190 1 0.000249 1560.000000 -0.000820 0.000281 0.003935 -11191 1 0.000255 1560.000000 -0.002172 0.001213 0.003269 -11192 1 0.000207 1560.000000 0.000509 0.003738 0.008194 -11193 1 0.000244 1560.000000 0.001096 -0.000315 0.000358 -11194 1 0.000245 1560.000000 0.002016 -0.003107 0.003489 -11195 1 0.000252 1560.000000 0.002465 -0.001669 0.003357 -11196 1 0.000254 1560.000000 -0.000789 -0.003189 0.003402 -11197 1 0.000239 1560.000000 -0.000574 0.002379 0.001199 -11198 1 0.000239 1560.000000 -0.001409 -0.002616 0.004506 -11199 1 0.000254 1560.000000 -0.000470 0.001421 0.007174 -11200 1 0.000249 1560.000000 -0.000686 -0.001358 0.008631 -11201 1 0.000193 1560.000000 -0.000106 -0.001446 0.005178 -11202 1 0.000288 1560.000000 0.003036 0.001227 0.007122 -11203 1 0.000205 1560.000000 -0.001269 0.002956 0.001643 -11204 1 0.000205 1560.000000 0.001390 -0.002550 0.009422 -11205 1 0.000236 1560.000000 0.001821 -0.000285 0.008075 -11206 1 0.000194 1560.000000 0.001286 -0.001078 0.008865 -11207 1 0.000270 1560.000000 -0.003688 0.000227 0.000163 -11208 1 0.000195 1560.000000 -0.001762 -0.001103 0.007124 -11209 1 0.000214 1560.000000 -0.003309 -0.000058 0.009492 -11210 1 0.000263 1560.000000 0.001190 -0.000490 0.008568 -11211 1 0.000207 1560.000000 0.001025 0.003093 0.006735 -11212 1 0.000230 1560.000000 0.000811 0.002379 0.009472 -11213 1 0.000244 1560.000000 -0.002032 -0.000663 0.002084 -11214 1 0.000193 1560.000000 -0.002128 0.002393 0.007311 -11215 1 0.000218 1560.000000 0.000588 -0.003668 0.008651 -11216 1 0.000241 1560.000000 -0.001030 -0.001891 0.007930 -11217 1 0.000266 1560.000000 0.003621 -0.001289 0.008319 -11218 1 0.000268 1560.000000 -0.001370 -0.000465 0.008795 -11219 1 0.000252 1560.000000 -0.002645 -0.001664 0.000484 -11220 1 0.000193 1560.000000 0.003008 0.001204 0.001720 -11221 1 0.000218 1560.000000 0.000559 0.002651 0.008599 -11222 1 0.000231 1560.000000 -0.000078 -0.001425 0.000339 -11223 1 0.000244 1560.000000 -0.000880 -0.000038 0.000249 -11224 1 0.000250 1560.000000 0.002915 0.000472 0.005773 -11225 1 0.000227 1560.000000 0.001109 -0.002441 0.004692 -11226 1 0.000261 1560.000000 0.002083 -0.002840 0.001589 -11227 1 0.000268 1560.000000 0.001039 0.000052 0.001608 -11228 1 0.000284 1560.000000 -0.000476 0.002452 0.008028 -11229 1 0.000224 1560.000000 -0.001808 0.000701 0.000721 -11230 1 0.000197 1560.000000 0.001139 0.002956 0.001960 -11231 1 0.000230 1560.000000 -0.002711 0.002710 0.009401 -11232 1 0.000199 1560.000000 0.000243 0.000412 0.006244 -11233 1 0.000257 1560.000000 -0.001232 -0.000833 0.007954 -11234 1 0.000236 1560.000000 0.003789 -0.000158 0.003023 -11235 1 0.000203 1560.000000 -0.001628 0.001280 0.009798 -11236 1 0.000243 1560.000000 -0.001083 0.000801 0.008924 -11237 1 0.000270 1560.000000 -0.002966 -0.000851 0.005719 -11238 1 0.000255 1560.000000 0.001065 -0.003699 0.009256 -11239 1 0.000217 1560.000000 -0.003595 0.000479 0.006226 -11240 1 0.000202 1560.000000 -0.002090 0.000514 0.008992 -11241 1 0.000281 1560.000000 0.000782 0.002966 0.003083 -11242 1 0.000263 1560.000000 -0.001683 0.002107 0.002404 -11243 1 0.000288 1560.000000 -0.001116 -0.002864 0.005048 -11244 1 0.000221 1560.000000 0.001033 0.000485 0.006559 -11245 1 0.000248 1560.000000 0.002431 0.001632 0.002451 -11246 1 0.000212 1560.000000 0.003271 -0.001900 0.004756 -11247 1 0.000218 1560.000000 -0.002531 -0.001541 0.007943 -11248 1 0.000238 1560.000000 0.001423 0.003573 0.000226 -11249 1 0.000282 1560.000000 0.001113 -0.000488 0.009210 -11250 1 0.000216 1560.000000 0.001253 -0.001092 0.007392 -11251 1 0.000199 1560.000000 -0.000015 0.001686 0.001172 -11252 1 0.000244 1560.000000 -0.002828 0.001167 0.003096 -11253 1 0.000198 1560.000000 -0.003319 -0.001576 0.008939 -11254 1 0.000209 1560.000000 -0.000289 0.003795 0.005988 -11255 1 0.000195 1560.000000 0.003439 -0.000809 0.004022 -11256 1 0.000223 1560.000000 0.003235 -0.001416 0.006968 -11257 1 0.000243 1560.000000 -0.001141 0.003024 0.000677 -11258 1 0.000231 1560.000000 -0.002248 0.002952 0.007460 -11259 1 0.000210 1560.000000 -0.002642 0.000050 0.007529 -11260 1 0.000218 1560.000000 0.003352 -0.001571 0.009079 -11261 1 0.000201 1560.000000 0.001311 -0.000287 0.008275 -11262 1 0.000193 1560.000000 0.002374 0.001889 0.006322 -11263 1 0.000260 1560.000000 -0.001863 -0.001626 0.005776 -11264 1 0.000239 1560.000000 -0.000263 0.000882 0.001279 -11265 1 0.000209 1560.000000 -0.001398 0.000296 0.008907 -11266 1 0.000224 1560.000000 0.002446 0.001044 0.008366 -11267 1 0.000220 1560.000000 -0.002588 -0.002805 0.000477 -11268 1 0.000235 1560.000000 -0.001184 -0.002952 0.001637 -11269 1 0.000209 1560.000000 0.000526 -0.001388 0.001552 -11270 1 0.000196 1560.000000 -0.000086 0.001825 0.004276 -11271 1 0.000278 1560.000000 0.001249 0.002528 0.007187 -11272 1 0.000210 1560.000000 0.002321 0.001940 0.004989 -11273 1 0.000237 1560.000000 0.002269 0.001986 0.004523 -11274 1 0.000241 1560.000000 0.000735 0.000678 0.009447 -11275 1 0.000274 1560.000000 0.001539 -0.001203 0.008353 -11276 1 0.000236 1560.000000 0.001933 -0.000154 0.004320 -11277 1 0.000230 1560.000000 -0.000237 -0.001143 0.000456 -11278 1 0.000215 1560.000000 0.003051 0.000479 0.008497 -11279 1 0.000287 1560.000000 0.000513 0.003629 0.008510 -11280 1 0.000245 1560.000000 0.002937 -0.001713 0.007286 -11281 1 0.000285 1560.000000 0.000878 -0.001459 0.009254 -11282 1 0.000231 1560.000000 -0.002956 0.002224 0.006152 -11283 1 0.000268 1560.000000 0.001170 0.001423 0.007141 -11284 1 0.000211 1560.000000 -0.002527 -0.000775 0.008699 -11285 1 0.000197 1560.000000 0.000861 -0.002152 0.006557 -11286 1 0.000245 1560.000000 0.001858 0.003368 0.004327 -11287 1 0.000201 1560.000000 -0.001186 0.001782 0.005237 -11288 1 0.000196 1560.000000 -0.001250 0.001435 0.006427 -11289 1 0.000199 1560.000000 0.000391 0.003768 0.005301 -11290 1 0.000214 1560.000000 0.000354 -0.001053 0.007325 -11291 1 0.000222 1560.000000 -0.000065 -0.002542 0.004211 -11292 1 0.000223 1560.000000 -0.001653 -0.003373 0.003863 -11293 1 0.000209 1560.000000 0.000046 -0.000382 0.000343 -11294 1 0.000210 1560.000000 -0.000439 -0.002055 0.004196 -11295 1 0.000262 1560.000000 -0.002727 -0.000090 0.002962 -11296 1 0.000195 1560.000000 0.000290 -0.002797 0.001922 -11297 1 0.000238 1560.000000 0.000045 -0.002706 0.004972 -11298 1 0.000245 1560.000000 -0.002480 -0.002708 0.003892 -11299 1 0.000216 1560.000000 -0.001498 0.001682 0.002380 -11300 1 0.000219 1560.000000 -0.000577 -0.000233 0.006077 -11301 1 0.000247 1560.000000 0.000881 0.003372 0.009346 -11302 1 0.000281 1560.000000 -0.001548 0.000448 0.000616 -11303 1 0.000193 1560.000000 0.002594 0.001012 0.003185 -11304 1 0.000212 1560.000000 0.000265 -0.003107 0.002059 -11305 1 0.000210 1560.000000 0.001634 -0.000501 0.002468 -11306 1 0.000212 1560.000000 -0.000228 0.000510 0.000981 -11307 1 0.000276 1560.000000 -0.000386 0.001271 0.007989 -11308 1 0.000196 1560.000000 -0.000313 -0.001172 0.001886 -11309 1 0.000229 1560.000000 -0.001632 0.001221 0.001918 -11310 1 0.000212 1560.000000 0.002738 0.002501 0.002653 -11311 1 0.000215 1560.000000 -0.000417 -0.002635 0.000171 -11312 1 0.000222 1560.000000 -0.001964 -0.000479 0.004300 -11313 1 0.000243 1560.000000 -0.003183 0.002099 0.000653 -11314 1 0.000204 1560.000000 0.000707 0.001556 0.004828 -11315 1 0.000262 1560.000000 0.001582 0.002314 0.007243 -11316 1 0.000239 1560.000000 0.001168 0.000325 0.006423 -11317 1 0.000245 1560.000000 -0.001609 -0.003470 0.006032 -11318 1 0.000208 1560.000000 -0.002939 -0.002390 0.006537 -11319 1 0.000207 1560.000000 0.001764 0.002258 0.004585 -11320 1 0.000242 1560.000000 -0.001377 0.002063 0.002605 -11321 1 0.000220 1560.000000 -0.003059 -0.000423 0.006177 -11322 1 0.000240 1560.000000 -0.002781 -0.000203 0.001486 -11323 1 0.000262 1560.000000 -0.000327 0.003414 0.007065 -11324 1 0.000261 1560.000000 0.001590 -0.003482 0.005091 -11325 1 0.000214 1560.000000 -0.001566 -0.000636 0.002834 -11326 1 0.000221 1560.000000 0.001911 0.000479 0.009032 -11327 1 0.000245 1560.000000 -0.000846 0.001792 0.004385 -11328 1 0.000282 1560.000000 0.000048 -0.002014 0.006463 -11329 1 0.000259 1560.000000 0.003161 0.002134 0.008125 -11330 1 0.000257 1560.000000 -0.003481 -0.000155 0.001077 -11331 1 0.000206 1560.000000 0.002842 -0.001177 0.005868 -11332 1 0.000192 1560.000000 0.000906 -0.000802 0.002555 -11333 1 0.000265 1560.000000 -0.001126 0.001952 0.001498 -11334 1 0.000228 1560.000000 0.001396 -0.001956 0.004439 -11335 1 0.000204 1560.000000 -0.003440 -0.000831 0.001064 -11336 1 0.000233 1560.000000 0.002240 -0.001482 0.008348 -11337 1 0.000263 1560.000000 0.003406 0.000272 0.004837 -11338 1 0.000258 1560.000000 0.002919 0.002233 0.006195 -11339 1 0.000202 1560.000000 0.000275 0.003693 0.003301 -11340 1 0.000225 1560.000000 -0.001660 0.001513 0.000500 -11341 1 0.000195 1560.000000 -0.003290 0.001870 0.002599 -11342 1 0.000254 1560.000000 0.002901 0.002283 0.007375 -11343 1 0.000212 1560.000000 0.001216 0.003127 0.004284 -11344 1 0.000234 1560.000000 -0.003254 -0.001609 0.000322 -11345 1 0.000222 1560.000000 0.002598 -0.001182 0.007863 -11346 1 0.000240 1560.000000 -0.000893 0.002331 0.007727 -11347 1 0.000207 1560.000000 -0.001386 0.001937 0.004578 -11348 1 0.000192 1560.000000 -0.002792 -0.000590 0.007068 -11349 1 0.000236 1560.000000 -0.001920 -0.002370 0.009313 -11350 1 0.000202 1560.000000 0.000795 -0.000892 0.002210 -11351 1 0.000282 1560.000000 0.001141 -0.000477 0.006604 -11352 1 0.000202 1560.000000 -0.000461 0.001228 0.005629 -11353 1 0.000258 1560.000000 0.003623 -0.000987 0.009249 -11354 1 0.000259 1560.000000 -0.002938 -0.000524 0.007810 -11355 1 0.000249 1560.000000 0.000343 0.001812 0.009355 -11356 1 0.000196 1560.000000 0.002022 -0.001789 0.008266 -11357 1 0.000204 1560.000000 -0.001487 0.001193 0.001344 -11358 1 0.000223 1560.000000 -0.002210 -0.001450 0.000245 -11359 1 0.000232 1560.000000 0.001263 -0.001772 0.004517 -11360 1 0.000218 1560.000000 -0.001504 0.003411 0.001815 -11361 1 0.000256 1560.000000 0.001078 0.003693 0.009669 -11362 1 0.000235 1560.000000 -0.001088 0.000809 0.009214 -11363 1 0.000241 1560.000000 -0.002032 -0.001392 0.005895 -11364 1 0.000253 1560.000000 -0.001788 -0.002318 0.001019 -11365 1 0.000240 1560.000000 -0.001898 -0.001445 0.007632 -11366 1 0.000234 1560.000000 0.000988 -0.002795 0.004909 -11367 1 0.000252 1560.000000 0.002021 -0.001755 0.005559 -11368 1 0.000193 1560.000000 0.000566 -0.003149 0.008356 -11369 1 0.000208 1560.000000 -0.002392 0.002111 0.009501 -11370 1 0.000194 1560.000000 0.000453 -0.000550 0.003822 -11371 1 0.000201 1560.000000 0.000276 -0.003288 0.004228 -11372 1 0.000205 1560.000000 -0.003144 0.002160 0.001046 -11373 1 0.000243 1560.000000 0.001786 -0.002530 0.001139 -11374 1 0.000194 1560.000000 0.001250 0.002072 0.004174 -11375 1 0.000256 1560.000000 -0.002122 -0.001411 0.001340 -11376 1 0.000278 1560.000000 -0.000705 0.002455 0.003583 -11377 1 0.000236 1560.000000 -0.000266 0.001498 0.008823 -11378 1 0.000285 1560.000000 0.002670 0.001895 0.000888 -11379 1 0.000256 1560.000000 -0.002234 0.003041 0.007786 -11380 1 0.000219 1560.000000 0.000557 0.003457 0.003981 -11381 1 0.000212 1560.000000 0.003629 -0.000450 0.007999 -11382 1 0.000199 1560.000000 -0.002921 -0.000162 0.003531 -11383 1 0.000264 1560.000000 -0.001664 0.002705 0.002125 -11384 1 0.000224 1560.000000 -0.003500 -0.001292 0.002698 -11385 1 0.000226 1560.000000 -0.000758 0.001937 0.006344 -11386 1 0.000272 1560.000000 -0.001475 0.002440 0.006864 -11387 1 0.000235 1560.000000 -0.002188 -0.001930 0.006424 -11388 1 0.000265 1560.000000 -0.001216 0.000943 0.009655 -11389 1 0.000200 1560.000000 0.001676 -0.003233 0.009385 -11390 1 0.000195 1560.000000 -0.002404 0.002895 0.006358 -11391 1 0.000218 1560.000000 0.000758 -0.002646 0.008950 -11392 1 0.000196 1560.000000 -0.003356 0.001434 0.007736 -11393 1 0.000248 1560.000000 -0.001235 0.003320 0.003684 -11394 1 0.000258 1560.000000 -0.002385 -0.001818 0.009204 -11395 1 0.000237 1560.000000 -0.001660 0.003404 0.003406 -11396 1 0.000272 1560.000000 0.001691 0.002848 0.007133 -11397 1 0.000231 1560.000000 0.002998 0.001703 0.003295 -11398 1 0.000237 1560.000000 0.000408 -0.000470 0.007430 -11399 1 0.000227 1560.000000 -0.000964 0.002753 0.005158 -11400 1 0.000199 1560.000000 0.002089 -0.001403 0.008849 -11401 1 0.000256 1560.000000 -0.002471 0.000004 0.004833 -11402 1 0.000263 1560.000000 0.000037 0.000678 0.002951 -11403 1 0.000238 1560.000000 -0.001445 -0.001571 0.001495 -11404 1 0.000245 1560.000000 -0.002978 0.001840 0.004763 -11405 1 0.000261 1560.000000 0.003105 -0.000020 0.009496 -11406 1 0.000278 1560.000000 -0.002554 0.000519 0.008771 -11407 1 0.000244 1560.000000 -0.000802 -0.000511 0.005636 -11408 1 0.000193 1560.000000 -0.002079 -0.000612 0.002935 -11409 1 0.000267 1560.000000 -0.001084 -0.002862 0.000289 -11410 1 0.000266 1560.000000 -0.000566 0.001113 0.001027 -11411 1 0.000210 1560.000000 -0.000286 -0.003221 0.009651 -11412 1 0.000201 1560.000000 0.002362 -0.002909 0.009453 -11413 1 0.000200 1560.000000 -0.001485 -0.001590 0.007408 -11414 1 0.000279 1560.000000 0.003526 -0.001304 0.002634 -11415 1 0.000234 1560.000000 -0.002274 -0.001198 0.008363 -11416 1 0.000285 1560.000000 0.000912 -0.001470 0.001433 -11417 1 0.000206 1560.000000 0.001492 0.001317 0.005007 -11418 1 0.000200 1560.000000 -0.003039 0.001765 0.008166 -11419 1 0.000246 1560.000000 -0.001399 0.003252 0.005795 -11420 1 0.000262 1560.000000 -0.000257 -0.001794 0.005022 -11421 1 0.000251 1560.000000 0.002799 0.002535 0.006317 -11422 1 0.000233 1560.000000 0.000170 0.003084 0.005671 -11423 1 0.000230 1560.000000 -0.000149 -0.003404 0.004348 -11424 1 0.000246 1560.000000 0.000839 0.001845 0.003853 -11425 1 0.000247 1560.000000 -0.002333 0.000800 0.000258 -11426 1 0.000247 1560.000000 -0.001489 0.003283 0.005363 -11427 1 0.000218 1560.000000 -0.002914 -0.000926 0.000774 -11428 1 0.000230 1560.000000 0.002452 0.002076 0.002501 -11429 1 0.000226 1560.000000 -0.003440 0.001385 0.006449 -11430 1 0.000225 1560.000000 0.001750 -0.002845 0.006585 -11431 1 0.000198 1560.000000 0.002556 0.000751 0.006014 -11432 1 0.000247 1560.000000 0.000811 0.000350 0.006645 -11433 1 0.000279 1560.000000 0.000697 0.001714 0.001252 -11434 1 0.000233 1560.000000 0.001115 -0.002560 0.006551 -11435 1 0.000272 1560.000000 0.000891 0.002647 0.000385 -11436 1 0.000219 1560.000000 0.001708 -0.003280 0.002782 -11437 1 0.000210 1560.000000 0.002367 -0.001022 0.001964 -11438 1 0.000211 1560.000000 0.001655 -0.002075 0.001452 -11439 1 0.000217 1560.000000 -0.000097 -0.001351 0.004657 -11440 1 0.000227 1560.000000 0.000620 -0.002228 0.005748 -11441 1 0.000202 1560.000000 -0.002743 -0.000366 0.006516 -11442 1 0.000266 1560.000000 0.000409 -0.003195 0.001428 -11443 1 0.000204 1560.000000 -0.003674 -0.000812 0.003317 -11444 1 0.000205 1560.000000 0.002096 -0.000287 0.003536 -11445 1 0.000242 1560.000000 0.001904 -0.002030 0.006189 -11446 1 0.000282 1560.000000 -0.000201 0.002906 0.002339 -11447 1 0.000275 1560.000000 0.002200 -0.000936 0.006474 -11448 1 0.000214 1560.000000 -0.000817 -0.003391 0.002641 -11449 1 0.000200 1560.000000 0.000577 -0.001280 0.008055 -11450 1 0.000288 1560.000000 0.002691 0.000536 0.008603 -11451 1 0.000274 1560.000000 0.002866 0.002539 0.003160 -11452 1 0.000199 1560.000000 -0.001139 0.002524 0.006000 -11453 1 0.000276 1560.000000 -0.002522 -0.002373 0.008575 -11454 1 0.000198 1560.000000 0.000085 0.001593 0.007296 -11455 1 0.000214 1560.000000 -0.002105 -0.001458 0.006119 -11456 1 0.000225 1560.000000 -0.003826 -0.000341 0.001213 -11457 1 0.000249 1560.000000 0.002419 -0.000900 0.000697 -11458 1 0.000268 1560.000000 -0.000987 -0.001027 0.005235 -11459 1 0.000267 1560.000000 -0.003743 -0.000855 0.007410 -11460 1 0.000198 1560.000000 0.002311 -0.000587 0.001096 -11461 1 0.000193 1560.000000 -0.003777 -0.000538 0.000555 -11462 1 0.000257 1560.000000 0.000497 0.002941 0.006002 -11463 1 0.000267 1560.000000 0.000540 0.003065 0.001900 -11464 1 0.000226 1560.000000 0.002949 0.002483 0.002917 -11465 1 0.000195 1560.000000 0.001743 0.001399 0.001115 -11466 1 0.000208 1560.000000 0.003296 0.001411 0.004123 -11467 1 0.000207 1560.000000 0.003385 -0.001808 0.001994 -11468 1 0.000211 1560.000000 -0.002724 -0.002601 0.006116 -11469 1 0.000237 1560.000000 0.001699 0.000409 0.001944 -11470 1 0.000199 1560.000000 0.001585 -0.000314 0.004560 -11471 1 0.000250 1560.000000 0.003101 0.001388 0.004309 -11472 1 0.000212 1560.000000 0.001448 0.003378 0.009205 -11473 1 0.000212 1560.000000 -0.000702 -0.002375 0.000443 -11474 1 0.000211 1560.000000 -0.000147 -0.002914 0.000371 -11475 1 0.000209 1560.000000 -0.003655 0.001128 0.004942 -11476 1 0.000193 1560.000000 -0.000108 -0.000795 0.002889 -11477 1 0.000204 1560.000000 -0.000810 0.000125 0.003219 -11478 1 0.000213 1560.000000 -0.001925 -0.001034 0.002742 -11479 1 0.000211 1560.000000 0.002797 0.001770 0.007225 -11480 1 0.000268 1560.000000 -0.000512 0.001981 0.006400 -11481 1 0.000225 1560.000000 0.001984 -0.000150 0.006263 -11482 1 0.000224 1560.000000 0.002162 -0.000220 0.002113 -11483 1 0.000199 1560.000000 -0.001408 -0.001326 0.000319 -11484 1 0.000199 1560.000000 -0.000024 0.001768 0.003186 -11485 1 0.000241 1560.000000 -0.000395 -0.002206 0.005703 -11486 1 0.000225 1560.000000 0.000047 0.002327 0.001279 -11487 1 0.000274 1560.000000 0.002782 -0.000972 0.008988 -11488 1 0.000220 1560.000000 0.002432 -0.002261 0.009726 -11489 1 0.000196 1560.000000 0.001744 0.000537 0.002695 -11490 1 0.000266 1560.000000 -0.000913 -0.001361 0.009799 -11491 1 0.000281 1560.000000 -0.001045 -0.003238 0.000635 -11492 1 0.000215 1560.000000 -0.001146 0.002638 0.002574 -11493 1 0.000272 1560.000000 0.003279 0.001910 0.008618 -11494 1 0.000280 1560.000000 0.002878 -0.002246 0.008254 -11495 1 0.000220 1560.000000 -0.002438 0.001882 0.000448 -11496 1 0.000224 1560.000000 -0.000434 -0.000435 0.000974 -11497 1 0.000276 1560.000000 0.002825 -0.002414 0.004063 -11498 1 0.000238 1560.000000 -0.001378 0.000743 0.001886 -11499 1 0.000262 1560.000000 -0.001869 -0.003319 0.008303 -11500 1 0.000196 1560.000000 -0.001232 -0.000158 0.005279 -11501 1 0.000269 1560.000000 0.001625 -0.000648 0.009520 -11502 1 0.000206 1560.000000 0.002536 0.000952 0.000842 -11503 1 0.000232 1560.000000 0.001405 -0.000236 0.003342 -11504 1 0.000224 1560.000000 -0.000683 0.000467 0.002187 -11505 1 0.000238 1560.000000 -0.001965 -0.002028 0.007795 -11506 1 0.000220 1560.000000 0.002205 -0.002172 0.003444 -11507 1 0.000201 1560.000000 -0.000194 0.000049 0.005255 -11508 1 0.000247 1560.000000 0.002268 -0.001440 0.001696 -11509 1 0.000198 1560.000000 -0.000626 0.002749 0.007262 -11510 1 0.000197 1560.000000 0.001097 0.000759 0.003474 -11511 1 0.000240 1560.000000 -0.001374 -0.003021 0.008771 -11512 1 0.000201 1560.000000 -0.000223 -0.000209 0.002403 -11513 1 0.000229 1560.000000 -0.000116 -0.001621 0.009824 -11514 1 0.000275 1560.000000 -0.001245 -0.003180 0.002170 -11515 1 0.000200 1560.000000 0.000796 0.000707 0.001222 -11516 1 0.000224 1560.000000 0.001200 -0.003174 0.000528 -11517 1 0.000227 1560.000000 0.000187 0.002748 0.003331 -11518 1 0.000283 1560.000000 0.003407 -0.001377 0.007307 -11519 1 0.000241 1560.000000 -0.001813 -0.001232 0.004870 -11520 1 0.000241 1560.000000 -0.000657 0.001973 0.002884 -11521 1 0.000235 1560.000000 -0.003411 -0.000696 0.003363 -11522 1 0.000245 1560.000000 0.002419 -0.001113 0.008657 -11523 1 0.000272 1560.000000 0.002153 0.002712 0.000193 -11524 1 0.000198 1560.000000 0.003578 0.000788 0.008496 -11525 1 0.000199 1560.000000 0.002770 0.002420 0.002396 -11526 1 0.000226 1560.000000 0.001103 0.001050 0.007876 -11527 1 0.000243 1560.000000 0.001725 -0.002372 0.008113 -11528 1 0.000202 1560.000000 0.002119 0.001937 0.000923 -11529 1 0.000270 1560.000000 -0.001140 0.003630 0.005427 -11530 1 0.000243 1560.000000 -0.000052 0.003513 0.008991 -11531 1 0.000265 1560.000000 0.003309 0.001537 0.001488 -11532 1 0.000285 1560.000000 0.001664 -0.003151 0.007375 -11533 1 0.000203 1560.000000 -0.000192 0.000366 0.009396 -11534 1 0.000239 1560.000000 -0.001124 -0.003621 0.008088 -11535 1 0.000229 1560.000000 -0.001825 0.002224 0.005283 -11536 1 0.000221 1560.000000 -0.001350 -0.000757 0.004810 -11537 1 0.000211 1560.000000 -0.000140 0.002570 0.000718 -11538 1 0.000254 1560.000000 0.000612 -0.003519 0.001425 -11539 1 0.000226 1560.000000 -0.001045 -0.000702 0.005630 -11540 1 0.000213 1560.000000 0.001954 -0.002799 0.004664 -11541 1 0.000247 1560.000000 -0.002277 -0.001619 0.007256 -11542 1 0.000216 1560.000000 0.001101 -0.003564 0.005275 -11543 1 0.000276 1560.000000 -0.002210 0.001063 0.003969 -11544 1 0.000212 1560.000000 -0.001678 0.001603 0.005562 -11545 1 0.000250 1560.000000 0.000631 0.002693 0.000748 -11546 1 0.000250 1560.000000 -0.002447 -0.002640 0.006002 -11547 1 0.000279 1560.000000 -0.002827 0.001760 0.003113 -11548 1 0.000196 1560.000000 0.001633 -0.001875 0.006116 -11549 1 0.000196 1560.000000 -0.002197 -0.000251 0.002483 -11550 1 0.000194 1560.000000 0.001056 0.002233 0.001065 -11551 1 0.000226 1560.000000 0.001670 0.001249 0.002881 -11552 1 0.000264 1560.000000 0.002324 0.000958 0.003792 -11553 1 0.000229 1560.000000 -0.000613 -0.000786 0.007854 -11554 1 0.000204 1560.000000 -0.000098 0.003248 0.006675 -11555 1 0.000194 1560.000000 0.000262 -0.003478 0.001840 -11556 1 0.000245 1560.000000 -0.001233 -0.003634 0.000375 -11557 1 0.000236 1560.000000 -0.001279 -0.000005 0.002692 -11558 1 0.000239 1560.000000 0.001046 0.003206 0.002249 -11559 1 0.000207 1560.000000 0.000481 0.001552 0.007945 -11560 1 0.000194 1560.000000 0.001552 -0.000854 0.008807 -11561 1 0.000203 1560.000000 0.003391 0.000315 0.007102 -11562 1 0.000204 1560.000000 0.000432 0.003079 0.007027 -11563 1 0.000257 1560.000000 -0.002841 0.000406 0.001804 -11564 1 0.000211 1560.000000 -0.000071 -0.002111 0.007369 -11565 1 0.000229 1560.000000 0.001500 0.000443 0.008540 -11566 1 0.000222 1560.000000 0.002413 0.000565 0.000140 -11567 1 0.000203 1560.000000 -0.003164 0.001705 0.006006 -11568 1 0.000195 1560.000000 -0.002240 0.000189 0.006350 -11569 1 0.000206 1560.000000 -0.000565 0.000390 0.002628 -11570 1 0.000260 1560.000000 -0.001609 0.002985 0.004978 -11571 1 0.000238 1560.000000 -0.001075 0.002088 0.006488 -11572 1 0.000198 1560.000000 -0.001576 0.001932 0.004818 -11573 1 0.000225 1560.000000 0.002490 -0.000056 0.002602 -11574 1 0.000257 1560.000000 0.003256 -0.000148 0.009174 -11575 1 0.000282 1560.000000 -0.000042 0.002668 0.002331 -11576 1 0.000208 1560.000000 0.003481 -0.001415 0.009691 -11577 1 0.000226 1560.000000 0.000820 0.001119 0.003956 -11578 1 0.000224 1560.000000 0.000565 0.003578 0.002696 -11579 1 0.000243 1560.000000 -0.001895 -0.000845 0.001616 -11580 1 0.000248 1560.000000 0.003071 0.001885 0.005174 -11581 1 0.000223 1560.000000 -0.001418 0.000191 0.001505 -11582 1 0.000199 1560.000000 -0.000364 0.003538 0.001799 -11583 1 0.000203 1560.000000 -0.001945 0.001459 0.005021 -11584 1 0.000254 1560.000000 0.001833 0.002931 0.001960 -11585 1 0.000268 1560.000000 -0.003423 0.000384 0.000537 -11586 1 0.000227 1560.000000 0.001553 0.002035 0.003349 -11587 1 0.000232 1560.000000 -0.002567 -0.001382 0.003008 -11588 1 0.000274 1560.000000 -0.003031 -0.002106 0.003243 -11589 1 0.000280 1560.000000 -0.001587 -0.001597 0.009661 -11590 1 0.000224 1560.000000 0.001133 0.002648 0.003766 -11591 1 0.000259 1560.000000 -0.002178 -0.001057 0.009131 -11592 1 0.000240 1560.000000 0.003469 -0.000171 0.001113 -11593 1 0.000241 1560.000000 -0.002463 -0.002466 0.000509 -11594 1 0.000281 1560.000000 0.000959 0.003213 0.008117 -11595 1 0.000194 1560.000000 -0.003136 0.001741 0.004060 -11596 1 0.000200 1560.000000 -0.000122 0.003732 0.001647 -11597 1 0.000217 1560.000000 -0.001969 -0.002462 0.005464 -11598 1 0.000194 1560.000000 -0.001858 0.001433 0.003533 -11599 1 0.000209 1560.000000 -0.000627 -0.000525 0.008841 -11600 1 0.000227 1560.000000 0.002589 -0.001924 0.003639 -11601 1 0.000249 1560.000000 -0.001999 0.000113 0.000414 -11602 1 0.000227 1560.000000 -0.001316 0.001850 0.000584 -11603 1 0.000202 1560.000000 -0.002542 0.002004 0.008162 -11604 1 0.000250 1560.000000 -0.000617 0.001812 0.001590 -11605 1 0.000211 1560.000000 0.000469 -0.000545 0.008145 -11606 1 0.000284 1560.000000 0.001198 -0.000471 0.008893 -11607 1 0.000217 1560.000000 0.002307 0.002285 0.002396 -11608 1 0.000274 1560.000000 -0.002323 -0.002940 0.006100 -11609 1 0.000224 1560.000000 0.002242 -0.002535 0.001292 -11610 1 0.000196 1560.000000 -0.001476 0.001795 0.005480 -11611 1 0.000286 1560.000000 0.001053 -0.002239 0.004855 -11612 1 0.000206 1560.000000 0.000858 0.002032 0.009359 -11613 1 0.000208 1560.000000 -0.000972 0.000258 0.008106 -11614 1 0.000198 1560.000000 -0.002078 0.002819 0.005215 -11615 1 0.000267 1560.000000 0.003405 -0.001682 0.007467 -11616 1 0.000245 1560.000000 0.002285 0.002509 0.000346 -11617 1 0.000198 1560.000000 0.003613 0.000919 0.002304 -11618 1 0.000264 1560.000000 -0.002399 -0.000511 0.004586 -11619 1 0.000199 1560.000000 0.002673 -0.002620 0.000400 -11620 1 0.000198 1560.000000 0.000739 0.002360 0.005510 -11621 1 0.000207 1560.000000 0.002061 0.000750 0.003121 -11622 1 0.000274 1560.000000 -0.003809 -0.000516 0.004436 -11623 1 0.000214 1560.000000 -0.002968 0.000227 0.005493 -11624 1 0.000247 1560.000000 0.001629 0.003344 0.000579 -11625 1 0.000246 1560.000000 -0.000964 0.002169 0.001830 -11626 1 0.000250 1560.000000 -0.002883 0.001219 0.004705 -11627 1 0.000286 1560.000000 -0.001724 0.000986 0.004639 -11628 1 0.000224 1560.000000 0.002228 0.000887 0.004962 -11629 1 0.000252 1560.000000 0.002833 -0.000261 0.002306 -11630 1 0.000205 1560.000000 0.003756 -0.000220 0.009036 -11631 1 0.000214 1560.000000 0.001816 0.002659 0.002768 -11632 1 0.000225 1560.000000 -0.002945 -0.000766 0.000118 -11633 1 0.000214 1560.000000 0.002443 -0.000805 0.003858 -11634 1 0.000215 1560.000000 0.000054 0.002723 0.001239 -11635 1 0.000238 1560.000000 -0.002880 0.000467 0.006846 -11636 1 0.000224 1560.000000 0.002653 -0.000099 0.002413 -11637 1 0.000221 1560.000000 0.002305 0.001456 0.007086 -11638 1 0.000231 1560.000000 -0.001240 0.000103 0.008059 -11639 1 0.000261 1560.000000 -0.001681 0.001838 0.004200 -11640 1 0.000213 1560.000000 -0.002869 -0.001434 0.007257 -11641 1 0.000212 1560.000000 -0.001861 -0.000552 0.007189 -11642 1 0.000252 1560.000000 -0.000579 -0.003183 0.009010 -11643 1 0.000227 1560.000000 0.001665 0.002355 0.006023 -11644 1 0.000240 1560.000000 -0.002942 -0.000233 0.004813 -11645 1 0.000246 1560.000000 -0.002113 0.001134 0.000961 -11646 1 0.000265 1560.000000 -0.000892 -0.003716 0.003679 -11647 1 0.000286 1560.000000 -0.003452 -0.000377 0.003941 -11648 1 0.000262 1560.000000 0.000210 0.002842 0.001949 -11649 1 0.000264 1560.000000 0.000495 0.001997 0.005856 -11650 1 0.000225 1560.000000 -0.002546 0.000504 0.000953 -11651 1 0.000282 1560.000000 0.000322 0.001360 0.008471 -11652 1 0.000250 1560.000000 -0.003364 0.000102 0.002074 -11653 1 0.000286 1560.000000 -0.003148 -0.001309 0.003067 -11654 1 0.000230 1560.000000 0.000599 -0.003363 0.008282 -11655 1 0.000225 1560.000000 0.000453 0.000694 0.004197 -11656 1 0.000204 1560.000000 0.000293 -0.001677 0.009604 -11657 1 0.000199 1560.000000 -0.002506 0.002262 0.007624 -11658 1 0.000195 1560.000000 -0.002943 -0.000485 0.001084 -11659 1 0.000229 1560.000000 -0.002402 0.000230 0.004440 -11660 1 0.000264 1560.000000 -0.000611 0.003768 0.005348 -11661 1 0.000195 1560.000000 -0.003451 0.001599 0.002483 -11662 1 0.000206 1560.000000 -0.001518 -0.000009 0.002642 -11663 1 0.000274 1560.000000 0.002207 -0.002063 0.006287 -11664 1 0.000211 1560.000000 0.000701 -0.001248 0.008764 -11665 1 0.000221 1560.000000 0.000721 -0.000147 0.003434 -11666 1 0.000232 1560.000000 -0.002053 -0.002367 0.007761 -11667 1 0.000221 1560.000000 0.000180 0.002200 0.004479 -11668 1 0.000254 1560.000000 -0.000975 -0.001860 0.002954 -11669 1 0.000199 1560.000000 -0.002699 -0.002008 0.005656 -11670 1 0.000254 1560.000000 -0.003572 0.001224 0.007537 -11671 1 0.000226 1560.000000 -0.000019 0.000671 0.003510 -11672 1 0.000248 1560.000000 -0.000438 0.002662 0.005882 -11673 1 0.000265 1560.000000 0.003414 0.001673 0.002982 -11674 1 0.000193 1560.000000 -0.001053 -0.000908 0.001735 -11675 1 0.000195 1560.000000 -0.001428 -0.003180 0.000466 -11676 1 0.000203 1560.000000 -0.000595 0.002389 0.006223 -11677 1 0.000237 1560.000000 -0.002122 -0.002953 0.005864 -11678 1 0.000251 1560.000000 -0.001762 -0.001248 0.003292 -11679 1 0.000249 1560.000000 -0.001077 0.001247 0.003881 -11680 1 0.000255 1560.000000 0.002314 -0.000426 0.002027 -11681 1 0.000267 1560.000000 -0.002748 0.000365 0.007615 -11682 1 0.000261 1560.000000 0.000931 -0.001699 0.008994 -11683 1 0.000192 1560.000000 -0.002621 -0.000433 0.004393 -11684 1 0.000284 1560.000000 -0.003069 -0.000722 0.003100 -11685 1 0.000226 1560.000000 -0.001918 -0.001202 0.003017 -11686 1 0.000227 1560.000000 0.002105 0.001880 0.004819 -11687 1 0.000252 1560.000000 -0.002365 0.003044 0.002867 -11688 1 0.000225 1560.000000 -0.003352 -0.001461 0.002871 -11689 1 0.000219 1560.000000 -0.003374 0.001546 0.004355 -11690 1 0.000201 1560.000000 -0.002272 0.000348 0.000604 -11691 1 0.000237 1560.000000 0.001525 0.002135 0.009315 -11692 1 0.000259 1560.000000 0.001564 -0.000404 0.002925 -11693 1 0.000223 1560.000000 0.000415 -0.002027 0.009195 -11694 1 0.000213 1560.000000 0.000716 0.002886 0.002352 -11695 1 0.000224 1560.000000 -0.001347 -0.002009 0.001587 -11696 1 0.000204 1560.000000 -0.001352 0.003588 0.004393 -11697 1 0.000229 1560.000000 -0.002588 0.001253 0.003682 -11698 1 0.000261 1560.000000 0.001740 -0.002663 0.009791 -11699 1 0.000202 1560.000000 -0.001821 0.001503 0.007213 -11700 1 0.000240 1560.000000 0.001893 0.002490 0.003435 -11701 1 0.000228 1560.000000 0.001950 -0.002118 0.009025 -11702 1 0.000245 1560.000000 0.003097 0.000934 0.009062 -11703 1 0.000200 1560.000000 -0.002773 -0.002250 0.005940 -11704 1 0.000257 1560.000000 0.000597 0.000005 0.001404 -11705 1 0.000193 1560.000000 0.002062 -0.003089 0.002673 -11706 1 0.000230 1560.000000 0.001322 0.002272 0.000909 -11707 1 0.000238 1560.000000 -0.002184 0.002495 0.006145 -11708 1 0.000208 1560.000000 0.001904 -0.003336 0.008760 -11709 1 0.000232 1560.000000 -0.001183 -0.002996 0.007251 -11710 1 0.000202 1560.000000 -0.002275 -0.003099 0.004730 -11711 1 0.000224 1560.000000 0.001671 0.000427 0.000986 -11712 1 0.000199 1560.000000 -0.001311 0.002959 0.008280 -11713 1 0.000241 1560.000000 -0.003529 0.000122 0.006990 -11714 1 0.000195 1560.000000 -0.000613 -0.002089 0.001154 -11715 1 0.000218 1560.000000 -0.003513 -0.001487 0.001045 -11716 1 0.000233 1560.000000 -0.000834 -0.002416 0.005241 -11717 1 0.000199 1560.000000 0.002222 -0.001012 0.003900 -11718 1 0.000197 1560.000000 -0.001980 0.002583 0.006678 -11719 1 0.000288 1560.000000 0.003614 -0.000688 0.003391 -11720 1 0.000210 1560.000000 -0.002265 0.001421 0.004661 -11721 1 0.000222 1560.000000 -0.002403 0.001684 0.009141 -11722 1 0.000223 1560.000000 -0.002980 0.001716 0.004295 -11723 1 0.000217 1560.000000 0.003127 -0.002231 0.008917 -11724 1 0.000257 1560.000000 -0.002208 0.000214 0.007565 -11725 1 0.000243 1560.000000 0.001785 -0.002126 0.007060 -11726 1 0.000215 1560.000000 0.002985 0.001425 0.000212 -11727 1 0.000208 1560.000000 0.001896 0.001333 0.004056 -11728 1 0.000202 1560.000000 0.000299 0.000072 0.007449 -11729 1 0.000218 1560.000000 -0.001192 0.002678 0.004553 -11730 1 0.000200 1560.000000 -0.003586 -0.000093 0.001808 -11731 1 0.000283 1560.000000 0.002888 -0.000934 0.009844 -11732 1 0.000198 1560.000000 0.001980 0.001009 0.009271 -11733 1 0.000231 1560.000000 -0.001605 0.002621 0.004586 -11734 1 0.000229 1560.000000 0.000423 -0.003373 0.006924 -11735 1 0.000196 1560.000000 0.001287 -0.002262 0.008901 -11736 1 0.000262 1560.000000 -0.000108 -0.003786 0.000276 -11737 1 0.000223 1560.000000 0.000856 -0.001310 0.007681 -11738 1 0.000271 1560.000000 0.002520 -0.002625 0.008997 -11739 1 0.000263 1560.000000 0.002900 0.000785 0.006519 -11740 1 0.000231 1560.000000 -0.002529 0.001773 0.007572 -11741 1 0.000201 1560.000000 0.001572 0.001248 0.001141 -11742 1 0.000193 1560.000000 0.003012 -0.001253 0.000956 -11743 1 0.000280 1560.000000 -0.000154 -0.002935 0.002383 -11744 1 0.000213 1560.000000 0.002959 0.001329 0.008858 -11745 1 0.000221 1560.000000 -0.002136 -0.002473 0.004345 -11746 1 0.000230 1560.000000 0.001168 0.002808 0.006670 -11747 1 0.000214 1560.000000 -0.003073 -0.000485 0.000741 -11748 1 0.000248 1560.000000 -0.002984 0.001429 0.007809 -11749 1 0.000276 1560.000000 0.002123 -0.000247 0.005996 -11750 1 0.000208 1560.000000 -0.000868 -0.001544 0.005403 -11751 1 0.000201 1560.000000 0.000632 0.000846 0.000799 -11752 1 0.000206 1560.000000 0.001777 0.001710 0.001896 -11753 1 0.000218 1560.000000 -0.000434 -0.000957 0.005601 -11754 1 0.000206 1560.000000 0.000274 0.003481 0.008408 -11755 1 0.000238 1560.000000 0.002227 0.003134 0.005711 -11756 1 0.000234 1560.000000 -0.002403 -0.002441 0.002726 -11757 1 0.000249 1560.000000 -0.000096 0.002990 0.000143 -11758 1 0.000268 1560.000000 -0.001531 0.000095 0.009755 -11759 1 0.000284 1560.000000 0.002201 -0.002328 0.003011 -11760 1 0.000255 1560.000000 0.002989 -0.002112 0.005961 -11761 1 0.000234 1560.000000 -0.000758 0.003521 0.001734 -11762 1 0.000254 1560.000000 0.001866 0.001394 0.007096 -11763 1 0.000264 1560.000000 -0.002062 -0.000532 0.000345 -11764 1 0.000212 1560.000000 -0.002666 -0.000785 0.007277 -11765 1 0.000213 1560.000000 -0.002929 -0.000687 0.002338 -11766 1 0.000194 1560.000000 -0.000641 0.003357 0.006003 -11767 1 0.000228 1560.000000 -0.002302 -0.002527 0.008911 -11768 1 0.000195 1560.000000 -0.000190 -0.000706 0.003414 -11769 1 0.000280 1560.000000 -0.003115 0.000110 0.002573 -11770 1 0.000237 1560.000000 0.000286 0.001944 0.000320 -11771 1 0.000276 1560.000000 -0.001119 -0.001480 0.000501 -11772 1 0.000209 1560.000000 -0.002319 -0.002871 0.001250 -11773 1 0.000229 1560.000000 -0.000674 -0.003613 0.000920 -11774 1 0.000209 1560.000000 0.001257 -0.001458 0.004555 -11775 1 0.000268 1560.000000 0.000707 0.001688 0.007346 -11776 1 0.000212 1560.000000 0.001718 0.000552 0.005686 -11777 1 0.000196 1560.000000 -0.001044 0.000603 0.007221 -11778 1 0.000219 1560.000000 -0.003047 -0.002274 0.009354 -11779 1 0.000199 1560.000000 -0.002542 -0.002409 0.007334 -11780 1 0.000202 1560.000000 -0.000443 -0.000100 0.009792 -11781 1 0.000219 1560.000000 -0.002395 0.001923 0.001026 -11782 1 0.000227 1560.000000 -0.002313 -0.001890 0.008490 -11783 1 0.000200 1560.000000 -0.002587 0.000934 0.006194 -11784 1 0.000212 1560.000000 0.002784 0.000206 0.001040 -11785 1 0.000233 1560.000000 0.003135 -0.000585 0.003534 -11786 1 0.000194 1560.000000 -0.000580 0.000920 0.008815 -11787 1 0.000264 1560.000000 -0.002725 0.002376 0.007315 -11788 1 0.000264 1560.000000 0.001741 -0.001751 0.008936 -11789 1 0.000210 1560.000000 -0.003085 -0.001817 0.003880 -11790 1 0.000194 1560.000000 0.000214 -0.001903 0.002516 -11791 1 0.000222 1560.000000 -0.000436 -0.003461 0.008078 -11792 1 0.000221 1560.000000 0.000891 0.001551 0.001359 -11793 1 0.000285 1560.000000 -0.000236 0.003484 0.000614 -11794 1 0.000231 1560.000000 -0.000557 0.001703 0.004244 -11795 1 0.000228 1560.000000 -0.000453 0.001026 0.000267 -11796 1 0.000225 1560.000000 -0.002819 -0.001094 0.007971 -11797 1 0.000196 1560.000000 0.001188 0.002589 0.003322 -11798 1 0.000260 1560.000000 -0.002967 0.002394 0.005208 -11799 1 0.000275 1560.000000 -0.003237 0.002066 0.006841 -11800 1 0.000271 1560.000000 0.001962 -0.002845 0.000845 -11801 1 0.000197 1560.000000 0.001318 0.001517 0.007369 -11802 1 0.000278 1560.000000 -0.000496 -0.001382 0.003090 -11803 1 0.000269 1560.000000 -0.000465 -0.001607 0.001210 -11804 1 0.000260 1560.000000 -0.000808 -0.003256 0.000412 -11805 1 0.000211 1560.000000 0.003314 -0.000916 0.001514 -11806 1 0.000194 1560.000000 -0.002474 0.002828 0.001795 -11807 1 0.000242 1560.000000 0.003263 -0.000435 0.006217 -11808 1 0.000246 1560.000000 -0.000751 -0.003086 0.005596 -11809 1 0.000229 1560.000000 0.001772 -0.002877 0.004009 -11810 1 0.000194 1560.000000 0.001346 -0.003168 0.008621 -11811 1 0.000259 1560.000000 -0.003528 -0.000206 0.008944 -11812 1 0.000216 1560.000000 0.001169 -0.003516 0.002116 -11813 1 0.000269 1560.000000 0.002598 0.001381 0.005345 -11814 1 0.000203 1560.000000 0.001883 0.002088 0.004967 -11815 1 0.000220 1560.000000 0.003217 -0.002118 0.009392 -11816 1 0.000205 1560.000000 -0.001693 -0.002017 0.003587 -11817 1 0.000248 1560.000000 0.001208 -0.001854 0.006658 -11818 1 0.000285 1560.000000 0.001794 -0.001363 0.001517 -11819 1 0.000230 1560.000000 -0.002316 0.001153 0.002203 -11820 1 0.000203 1560.000000 -0.000757 -0.001459 0.002014 -11821 1 0.000204 1560.000000 -0.001687 0.003451 0.000258 -11822 1 0.000254 1560.000000 0.001138 -0.000562 0.003419 -11823 1 0.000199 1560.000000 -0.000126 -0.002794 0.001239 -11824 1 0.000194 1560.000000 0.001912 0.002700 0.005745 -11825 1 0.000272 1560.000000 -0.003037 0.000961 0.007658 -11826 1 0.000267 1560.000000 -0.000057 0.003592 0.008165 -11827 1 0.000194 1560.000000 -0.003162 -0.000449 0.001240 -11828 1 0.000260 1560.000000 -0.002849 -0.001672 0.007276 -11829 1 0.000207 1560.000000 -0.001383 -0.002210 0.001084 -11830 1 0.000227 1560.000000 0.000394 0.002974 0.003850 -11831 1 0.000268 1560.000000 -0.001146 -0.001959 0.009508 -11832 1 0.000194 1560.000000 0.000727 0.001681 0.005257 -11833 1 0.000277 1560.000000 -0.001552 0.002567 0.001769 -11834 1 0.000270 1560.000000 0.000580 0.000397 0.007910 -11835 1 0.000258 1560.000000 -0.002216 0.001887 0.006423 -11836 1 0.000239 1560.000000 0.001071 0.003397 0.001449 -11837 1 0.000196 1560.000000 -0.000098 -0.002569 0.003545 -11838 1 0.000203 1560.000000 -0.001454 -0.000138 0.004265 -11839 1 0.000233 1560.000000 -0.001157 0.001573 0.006141 -11840 1 0.000202 1560.000000 0.001276 0.002866 0.000659 -11841 1 0.000227 1560.000000 -0.001052 0.000753 0.001001 -11842 1 0.000228 1560.000000 -0.000466 -0.001088 0.001355 -11843 1 0.000228 1560.000000 0.001840 0.002295 0.002481 -11844 1 0.000250 1560.000000 -0.000685 0.001658 0.008622 -11845 1 0.000247 1560.000000 -0.000469 0.001888 0.001822 -11846 1 0.000209 1560.000000 -0.001812 -0.002335 0.006482 -11847 1 0.000195 1560.000000 0.002301 -0.001594 0.004009 -11848 1 0.000192 1560.000000 0.001987 -0.000619 0.004367 -11849 1 0.000225 1560.000000 0.001967 -0.000495 0.007276 -11850 1 0.000206 1560.000000 -0.001137 -0.002027 0.009783 -11851 1 0.000195 1560.000000 0.000965 0.003236 0.008621 -11852 1 0.000251 1560.000000 -0.001127 -0.001004 0.002602 -11853 1 0.000234 1560.000000 -0.000640 0.000661 0.006094 -11854 1 0.000258 1560.000000 -0.002816 -0.000531 0.008897 -11855 1 0.000226 1560.000000 0.002646 -0.000121 0.001313 -11856 1 0.000223 1560.000000 0.000612 -0.001876 0.008629 -11857 1 0.000200 1560.000000 -0.000379 -0.002805 0.003977 -11858 1 0.000253 1560.000000 -0.001717 -0.003343 0.003423 -11859 1 0.000273 1560.000000 0.003203 0.002114 0.003755 -11860 1 0.000200 1560.000000 0.003725 -0.000182 0.009463 -11861 1 0.000279 1560.000000 -0.002519 0.002826 0.007278 -11862 1 0.000203 1560.000000 -0.003366 0.001659 0.003207 -11863 1 0.000215 1560.000000 0.002728 0.001758 0.002927 -11864 1 0.000276 1560.000000 -0.001773 0.000830 0.002678 -11865 1 0.000272 1560.000000 0.003295 0.001391 0.004895 -11866 1 0.000219 1560.000000 0.002270 0.001681 0.003101 -11867 1 0.000286 1560.000000 -0.000650 -0.001441 0.003364 -11868 1 0.000201 1560.000000 -0.001463 -0.002679 0.005749 -11869 1 0.000200 1560.000000 0.002535 0.002302 0.003434 -11870 1 0.000285 1560.000000 0.000303 0.003633 0.005513 -11871 1 0.000250 1560.000000 0.000407 0.001593 0.008777 -11872 1 0.000264 1560.000000 -0.000119 -0.001561 0.003660 -11873 1 0.000266 1560.000000 -0.003431 0.000757 0.000168 -11874 1 0.000210 1560.000000 -0.001896 -0.003247 0.001404 -11875 1 0.000288 1560.000000 -0.003320 0.000853 0.007891 -11876 1 0.000261 1560.000000 -0.002328 0.002712 0.006146 -11877 1 0.000192 1560.000000 -0.000747 0.000445 0.000951 -11878 1 0.000243 1560.000000 -0.001292 0.001304 0.005370 -11879 1 0.000214 1560.000000 0.001971 0.002616 0.001508 -11880 1 0.000232 1560.000000 -0.002581 -0.002588 0.003031 -11881 1 0.000224 1560.000000 -0.000098 -0.000277 0.002669 -11882 1 0.000204 1560.000000 -0.001147 0.003277 0.008753 -11883 1 0.000212 1560.000000 -0.001868 0.000230 0.007559 -11884 1 0.000223 1560.000000 0.001088 0.003515 0.007576 -11885 1 0.000227 1560.000000 0.001638 -0.002818 0.003591 -11886 1 0.000283 1560.000000 0.000454 0.003130 0.005129 -11887 1 0.000264 1560.000000 0.000534 0.002646 0.006087 -11888 1 0.000208 1560.000000 -0.001261 0.000765 0.002768 -11889 1 0.000240 1560.000000 -0.001178 0.002463 0.000418 -11890 1 0.000249 1560.000000 0.001235 -0.000741 0.005582 -11891 1 0.000214 1560.000000 -0.002702 -0.000343 0.008108 -11892 1 0.000274 1560.000000 -0.001018 0.002537 0.007238 -11893 1 0.000234 1560.000000 -0.000923 -0.003230 0.008696 -11894 1 0.000243 1560.000000 -0.000416 0.002761 0.004301 -11895 1 0.000278 1560.000000 -0.001167 0.001463 0.003126 -11896 1 0.000249 1560.000000 0.000063 0.003424 0.007979 -11897 1 0.000265 1560.000000 -0.001782 0.000723 0.001584 -11898 1 0.000253 1560.000000 -0.003548 -0.001254 0.009394 -11899 1 0.000249 1560.000000 -0.002888 0.000723 0.006657 -11900 1 0.000251 1560.000000 -0.003082 0.001356 0.008544 -11901 1 0.000203 1560.000000 0.000975 -0.002230 0.009550 -11902 1 0.000253 1560.000000 0.000664 0.003496 0.006130 -11903 1 0.000221 1560.000000 -0.000153 0.002745 0.002966 -11904 1 0.000194 1560.000000 -0.001997 0.000939 0.008278 -11905 1 0.000257 1560.000000 0.000354 0.001084 0.004618 -11906 1 0.000265 1560.000000 0.000951 0.002927 0.000764 -11907 1 0.000208 1560.000000 -0.000978 0.003573 0.002304 -11908 1 0.000237 1560.000000 -0.001861 -0.001159 0.002040 -11909 1 0.000198 1560.000000 0.001588 0.002254 0.006197 -11910 1 0.000212 1560.000000 -0.000533 -0.001318 0.005688 -11911 1 0.000230 1560.000000 -0.000591 -0.001152 0.002795 -11912 1 0.000215 1560.000000 -0.001797 0.002437 0.003879 -11913 1 0.000248 1560.000000 0.000188 -0.002628 0.005747 -11914 1 0.000253 1560.000000 -0.002938 -0.002361 0.009053 -11915 1 0.000263 1560.000000 -0.000366 -0.000997 0.006851 -11916 1 0.000270 1560.000000 -0.000574 -0.001360 0.009658 -11917 1 0.000208 1560.000000 -0.001031 -0.000875 0.002081 -11918 1 0.000197 1560.000000 0.000083 0.000255 0.007844 -11919 1 0.000205 1560.000000 -0.000241 0.002672 0.009464 -11920 1 0.000261 1560.000000 0.001066 0.002763 0.003530 -11921 1 0.000253 1560.000000 -0.002647 -0.002096 0.003782 -11922 1 0.000208 1560.000000 -0.000705 0.002733 0.009040 -11923 1 0.000211 1560.000000 0.001308 -0.000844 0.007680 -11924 1 0.000198 1560.000000 0.000597 0.002219 0.004022 -11925 1 0.000270 1560.000000 0.001240 0.002000 0.009781 -11926 1 0.000203 1560.000000 -0.000568 -0.001637 0.000895 -11927 1 0.000275 1560.000000 0.001111 -0.003165 0.004148 -11928 1 0.000210 1560.000000 0.001775 -0.002738 0.002153 -11929 1 0.000200 1560.000000 -0.002355 -0.001560 0.008653 -11930 1 0.000218 1560.000000 -0.000347 0.003366 0.005363 -11931 1 0.000249 1560.000000 0.003104 0.000783 0.001383 -11932 1 0.000271 1560.000000 -0.003112 0.002234 0.007831 -11933 1 0.000209 1560.000000 -0.001436 0.000762 0.009507 -11934 1 0.000242 1560.000000 0.000694 0.001479 0.003111 -11935 1 0.000265 1560.000000 -0.003150 -0.001419 0.001027 -11936 1 0.000268 1560.000000 0.003244 0.001735 0.000205 -11937 1 0.000222 1560.000000 0.000816 -0.003563 0.004863 -11938 1 0.000198 1560.000000 -0.001384 -0.000140 0.002403 -11939 1 0.000262 1560.000000 -0.002034 0.003120 0.000866 -11940 1 0.000256 1560.000000 -0.003345 0.000533 0.006340 -11941 1 0.000245 1560.000000 0.003280 -0.000435 0.002711 -11942 1 0.000235 1560.000000 -0.002108 -0.002311 0.000442 -11943 1 0.000196 1560.000000 -0.000942 -0.002849 0.006247 -11944 1 0.000197 1560.000000 0.002118 0.001008 0.008732 -11945 1 0.000282 1560.000000 -0.003617 -0.001088 0.007093 -11946 1 0.000210 1560.000000 -0.000177 -0.003015 0.001883 -11947 1 0.000246 1560.000000 0.000529 -0.003033 0.008005 -11948 1 0.000264 1560.000000 -0.001510 0.000833 0.003569 -11949 1 0.000285 1560.000000 0.000830 -0.000485 0.007835 -11950 1 0.000217 1560.000000 -0.000581 0.002714 0.003945 -11951 1 0.000243 1560.000000 0.003829 0.000222 0.009122 -11952 1 0.000244 1560.000000 0.001868 -0.003367 0.007283 -11953 1 0.000203 1560.000000 -0.001233 -0.003578 0.001106 -11954 1 0.000210 1560.000000 -0.000401 0.000075 0.000110 -11955 1 0.000218 1560.000000 0.001620 -0.001312 0.005644 -11956 1 0.000241 1560.000000 -0.000198 0.001459 0.007672 -11957 1 0.000235 1560.000000 0.001470 -0.000745 0.005174 -11958 1 0.000231 1560.000000 -0.002226 0.001664 0.006965 -11959 1 0.000204 1560.000000 -0.002775 -0.001689 0.006157 -11960 1 0.000277 1560.000000 -0.001500 0.000050 0.008404 -11961 1 0.000203 1560.000000 -0.002856 0.001860 0.002771 -11962 1 0.000198 1560.000000 0.002097 -0.000537 0.000600 -11963 1 0.000198 1560.000000 -0.001804 0.000163 0.005806 -11964 1 0.000236 1560.000000 -0.001968 -0.003082 0.002026 -11965 1 0.000237 1560.000000 -0.000208 0.002703 0.009200 -11966 1 0.000193 1560.000000 0.002077 0.001918 0.005164 -11967 1 0.000272 1560.000000 0.003355 -0.000570 0.001282 -11968 1 0.000263 1560.000000 -0.002238 -0.002038 0.006075 -11969 1 0.000199 1560.000000 0.003005 -0.000382 0.006549 -11970 1 0.000205 1560.000000 -0.000904 -0.001525 0.004090 -11971 1 0.000236 1560.000000 -0.001537 -0.002690 0.007526 -11972 1 0.000215 1560.000000 0.001876 -0.000429 0.001483 -11973 1 0.000238 1560.000000 0.000739 0.001677 0.005741 -11974 1 0.000212 1560.000000 0.000719 0.000636 0.004108 -11975 1 0.000193 1560.000000 -0.001005 0.000781 0.001298 -11976 1 0.000204 1560.000000 -0.002102 0.002066 0.000771 -11977 1 0.000204 1560.000000 -0.000572 -0.002817 0.008127 -11978 1 0.000244 1560.000000 0.002772 -0.000583 0.001213 -11979 1 0.000287 1560.000000 -0.001497 -0.002265 0.003667 -11980 1 0.000221 1560.000000 0.003245 -0.000088 0.005469 -11981 1 0.000208 1560.000000 0.001868 -0.002430 0.009070 -11982 1 0.000195 1560.000000 0.001337 0.000757 0.005810 -11983 1 0.000202 1560.000000 0.000363 0.003578 0.000627 -11984 1 0.000208 1560.000000 0.002893 -0.000718 0.000869 -11985 1 0.000271 1560.000000 -0.000338 0.002561 0.008938 -11986 1 0.000245 1560.000000 -0.000300 -0.002986 0.003796 -11987 1 0.000231 1560.000000 0.003393 0.000920 0.003373 -11988 1 0.000204 1560.000000 0.003266 0.001686 0.005864 -11989 1 0.000267 1560.000000 -0.000742 0.002238 0.005314 -11990 1 0.000209 1560.000000 -0.000191 0.003247 0.008578 -11991 1 0.000215 1560.000000 -0.000685 -0.000815 0.004436 -11992 1 0.000266 1560.000000 0.003232 0.000401 0.006625 -11993 1 0.000257 1560.000000 -0.002442 0.001006 0.005797 -11994 1 0.000213 1560.000000 -0.002506 0.000535 0.009270 -11995 1 0.000241 1560.000000 0.001940 0.002227 0.007412 -11996 1 0.000194 1560.000000 -0.001466 0.000751 0.006539 -11997 1 0.000230 1560.000000 -0.002902 0.000781 0.006925 -11998 1 0.000196 1560.000000 -0.000437 0.002315 0.007749 -11999 1 0.000213 1560.000000 0.000794 -0.003082 0.002362 -12000 1 0.000242 1560.000000 0.001368 0.000990 0.000139 -12001 1 0.000248 1560.000000 0.003474 -0.000255 0.005623 -12002 1 0.000238 1560.000000 -0.001766 -0.002915 0.002897 -12003 1 0.000205 1560.000000 0.001599 0.001100 0.000994 -12004 1 0.000198 1560.000000 -0.000546 0.000157 0.004916 -12005 1 0.000253 1560.000000 0.002559 0.002423 0.006349 -12006 1 0.000229 1560.000000 -0.000208 -0.003808 0.004636 -12007 1 0.000265 1560.000000 -0.000867 0.002151 0.000603 -12008 1 0.000213 1560.000000 -0.002239 -0.002362 0.008129 -12009 1 0.000210 1560.000000 -0.001524 0.002145 0.009109 -12010 1 0.000260 1560.000000 -0.000985 -0.002052 0.004906 -12011 1 0.000196 1560.000000 -0.001437 0.000325 0.007386 -12012 1 0.000217 1560.000000 0.002413 -0.001882 0.001113 -12013 1 0.000276 1560.000000 -0.000301 0.003804 0.003452 -12014 1 0.000213 1560.000000 -0.001531 0.001549 0.005108 -12015 1 0.000256 1560.000000 0.001129 0.002745 0.009352 -12016 1 0.000209 1560.000000 -0.002696 0.000137 0.002306 -12017 1 0.000221 1560.000000 -0.000841 -0.000605 0.001178 -12018 1 0.000235 1560.000000 -0.000148 0.003765 0.004324 -12019 1 0.000274 1560.000000 0.003177 -0.001701 0.006483 -12020 1 0.000202 1560.000000 0.000911 -0.000517 0.009075 -12021 1 0.000223 1560.000000 -0.000256 0.002453 0.008501 -12022 1 0.000220 1560.000000 -0.001264 -0.000576 0.006137 -12023 1 0.000279 1560.000000 -0.000604 0.001545 0.005344 -12024 1 0.000210 1560.000000 -0.002163 -0.001146 0.003588 -12025 1 0.000245 1560.000000 0.001840 -0.000741 0.003488 -12026 1 0.000209 1560.000000 0.000222 -0.003448 0.003019 -12027 1 0.000241 1560.000000 -0.000729 0.002957 0.001059 -12028 1 0.000193 1560.000000 -0.001715 0.003049 0.007066 -12029 1 0.000241 1560.000000 0.001121 0.002009 0.000898 -12030 1 0.000256 1560.000000 0.001751 0.000093 0.003587 -12031 1 0.000254 1560.000000 -0.002553 -0.002711 0.001603 -12032 1 0.000240 1560.000000 -0.001247 0.003606 0.000548 -12033 1 0.000229 1560.000000 -0.000711 0.003587 0.009365 -12034 1 0.000261 1560.000000 0.002552 0.002730 0.004570 -12035 1 0.000226 1560.000000 -0.002221 -0.000241 0.003186 -12036 1 0.000219 1560.000000 0.002306 -0.000846 0.000192 -12037 1 0.000251 1560.000000 0.002551 -0.001725 0.005234 -12038 1 0.000275 1560.000000 0.003068 0.001030 0.000881 -12039 1 0.000197 1560.000000 0.002313 0.000538 0.001561 -12040 1 0.000226 1560.000000 -0.000949 -0.000024 0.002805 -12041 1 0.000254 1560.000000 0.001843 -0.002788 0.005636 -12042 1 0.000223 1560.000000 0.003233 -0.000649 0.006810 -12043 1 0.000270 1560.000000 0.003179 -0.001837 0.003486 -12044 1 0.000203 1560.000000 0.001228 -0.000870 0.005386 -12045 1 0.000204 1560.000000 0.001821 0.003292 0.002680 -12046 1 0.000198 1560.000000 -0.000216 0.001749 0.007537 -12047 1 0.000198 1560.000000 0.003627 -0.001047 0.002908 -12048 1 0.000243 1560.000000 -0.001158 0.002790 0.003365 -12049 1 0.000226 1560.000000 -0.002901 -0.002305 0.004471 -12050 1 0.000224 1560.000000 0.001641 0.002635 0.000667 -12051 1 0.000256 1560.000000 -0.000365 -0.001754 0.001816 -12052 1 0.000198 1560.000000 -0.000501 -0.000143 0.005882 -12053 1 0.000212 1560.000000 -0.002904 0.001875 0.001718 -12054 1 0.000227 1560.000000 -0.000184 0.002368 0.001779 -12055 1 0.000205 1560.000000 -0.001247 -0.001790 0.004595 -12056 1 0.000244 1560.000000 -0.000142 -0.002375 0.009038 -12057 1 0.000253 1560.000000 0.001843 -0.002227 0.002797 -12058 1 0.000275 1560.000000 0.000665 0.002295 0.006104 -12059 1 0.000247 1560.000000 0.000020 -0.001335 0.008868 -12060 1 0.000284 1560.000000 -0.000658 0.001796 0.008932 -12061 1 0.000270 1560.000000 0.001412 -0.003284 0.007997 -12062 1 0.000209 1560.000000 0.001108 -0.002412 0.009777 -12063 1 0.000236 1560.000000 0.002577 -0.002622 0.005677 -12064 1 0.000196 1560.000000 -0.001269 -0.000409 0.003065 -12065 1 0.000198 1560.000000 0.003017 0.000038 0.005302 -12066 1 0.000217 1560.000000 -0.003320 0.001116 0.009718 -12067 1 0.000245 1560.000000 -0.001296 0.002320 0.003469 -12068 1 0.000234 1560.000000 0.000284 -0.002181 0.000129 -12069 1 0.000223 1560.000000 0.000643 0.002318 0.000628 -12070 1 0.000195 1560.000000 -0.001163 -0.001671 0.004904 -12071 1 0.000283 1560.000000 0.002583 0.002275 0.004701 -12072 1 0.000252 1560.000000 0.002713 -0.000719 0.007437 -12073 1 0.000194 1560.000000 -0.000202 0.001046 0.001588 -12074 1 0.000208 1560.000000 0.002884 0.001091 0.004886 -12075 1 0.000197 1560.000000 -0.001037 -0.000615 0.007124 -12076 1 0.000215 1560.000000 0.002845 0.002032 0.009599 -12077 1 0.000227 1560.000000 0.000044 -0.002862 0.008890 -12078 1 0.000247 1560.000000 -0.002297 -0.002856 0.007659 -12079 1 0.000237 1560.000000 0.003671 -0.000671 0.001663 -12080 1 0.000213 1560.000000 -0.001888 0.003083 0.005006 -12081 1 0.000196 1560.000000 -0.000459 -0.001749 0.002694 -12082 1 0.000201 1560.000000 -0.000842 0.003671 0.005299 -12083 1 0.000255 1560.000000 0.002225 -0.002955 0.003256 -12084 1 0.000264 1560.000000 -0.001864 0.002529 0.001777 -12085 1 0.000248 1560.000000 -0.000714 0.003153 0.003815 -12086 1 0.000264 1560.000000 -0.001049 -0.001248 0.009108 -12087 1 0.000240 1560.000000 -0.002087 -0.002291 0.005913 -12088 1 0.000252 1560.000000 0.002667 0.000586 0.005905 -12089 1 0.000219 1560.000000 0.001142 -0.002583 0.000705 -12090 1 0.000260 1560.000000 -0.003728 0.000652 0.001288 -12091 1 0.000237 1560.000000 0.000750 0.002471 0.009122 -12092 1 0.000236 1560.000000 0.002833 -0.000361 0.003423 -12093 1 0.000243 1560.000000 -0.002138 -0.001638 0.008905 -12094 1 0.000244 1560.000000 0.000828 -0.001966 0.001023 -12095 1 0.000244 1560.000000 0.000101 -0.001089 0.004889 -12096 1 0.000194 1560.000000 -0.002070 0.002802 0.008197 -12097 1 0.000267 1560.000000 0.002660 -0.000640 0.009277 -12098 1 0.000281 1560.000000 -0.003625 0.000924 0.004379 -12099 1 0.000209 1560.000000 0.001399 0.000932 0.007802 -12100 1 0.000205 1560.000000 -0.001371 -0.001465 0.003839 -12101 1 0.000262 1560.000000 0.002603 0.002751 0.006858 -12102 1 0.000251 1560.000000 -0.001845 -0.003095 0.004162 -12103 1 0.000237 1560.000000 -0.000331 -0.000627 0.005112 -12104 1 0.000201 1560.000000 -0.002374 0.001429 0.002380 -12105 1 0.000209 1560.000000 -0.001506 0.002858 0.005868 -12106 1 0.000194 1560.000000 0.000985 0.000728 0.008469 -12107 1 0.000243 1560.000000 -0.000392 -0.001495 0.002514 -12108 1 0.000224 1560.000000 0.002263 0.000801 0.001944 -12109 1 0.000273 1560.000000 -0.002059 0.001885 0.001781 -12110 1 0.000249 1560.000000 0.000727 -0.000218 0.009514 -12111 1 0.000196 1560.000000 -0.003202 -0.001253 0.009228 -12112 1 0.000201 1560.000000 -0.000534 0.000031 0.003131 -12113 1 0.000226 1560.000000 -0.001418 -0.003554 0.003399 -12114 1 0.000205 1560.000000 -0.000845 -0.000038 0.007256 -12115 1 0.000284 1560.000000 0.000457 0.002411 0.000150 -12116 1 0.000284 1560.000000 0.000710 0.001929 0.002883 -12117 1 0.000209 1560.000000 0.002514 -0.000265 0.005707 -12118 1 0.000242 1560.000000 -0.001854 0.002834 0.006206 -12119 1 0.000229 1560.000000 -0.002481 -0.000453 0.006533 -12120 1 0.000243 1560.000000 -0.001717 -0.001694 0.002319 -12121 1 0.000282 1560.000000 -0.001436 0.003318 0.006431 -12122 1 0.000211 1560.000000 0.000253 0.003759 0.009533 -12123 1 0.000286 1560.000000 -0.000949 0.002387 0.002509 -12124 1 0.000202 1560.000000 -0.000765 0.001636 0.009779 -12125 1 0.000218 1560.000000 -0.002548 -0.002597 0.009531 -12126 1 0.000201 1560.000000 -0.001429 -0.000048 0.007642 -12127 1 0.000227 1560.000000 -0.003023 -0.001140 0.001003 -12128 1 0.000288 1560.000000 -0.003801 -0.000169 0.008506 -12129 1 0.000239 1560.000000 -0.001393 -0.001029 0.001634 -12130 1 0.000256 1560.000000 -0.003164 -0.001903 0.004933 -12131 1 0.000258 1560.000000 -0.001945 -0.002597 0.002890 -12132 1 0.000234 1560.000000 0.001994 0.002109 0.005868 -12133 1 0.000242 1560.000000 0.000927 -0.000528 0.006851 -12134 1 0.000234 1560.000000 0.000675 0.002227 0.005197 -12135 1 0.000243 1560.000000 0.000754 -0.002731 0.002244 -12136 1 0.000229 1560.000000 -0.001426 -0.001331 0.001695 -12137 1 0.000200 1560.000000 0.002207 -0.002436 0.003444 -12138 1 0.000238 1560.000000 0.000787 0.003433 0.008748 -12139 1 0.000272 1560.000000 -0.002873 -0.000942 0.005174 -12140 1 0.000216 1560.000000 0.002970 0.000658 0.006255 -12141 1 0.000213 1560.000000 -0.000762 -0.002065 0.004347 -12142 1 0.000279 1560.000000 0.001843 -0.001027 0.000257 -12143 1 0.000202 1560.000000 -0.002178 0.000988 0.002002 -12144 1 0.000271 1560.000000 -0.000208 0.003178 0.002234 -12145 1 0.000266 1560.000000 0.002666 -0.001254 0.008649 -12146 1 0.000214 1560.000000 -0.002140 -0.002234 0.003424 -12147 1 0.000207 1560.000000 -0.003044 0.000030 0.003614 -12148 1 0.000226 1560.000000 0.001788 -0.003386 0.009803 -12149 1 0.000249 1560.000000 0.001214 -0.001391 0.008018 -12150 1 0.000198 1560.000000 -0.001200 -0.003425 0.000647 -12151 1 0.000204 1560.000000 -0.000734 0.002486 0.000149 -12152 1 0.000234 1560.000000 0.002007 -0.000756 0.008211 -12153 1 0.000198 1560.000000 0.000811 0.002272 0.007314 -12154 1 0.000201 1560.000000 0.003025 -0.000216 0.001300 -12155 1 0.000207 1560.000000 -0.001486 0.002917 0.006843 -12156 1 0.000192 1560.000000 0.000176 0.003784 0.006629 -12157 1 0.000283 1560.000000 0.003435 0.001110 0.007565 -12158 1 0.000217 1560.000000 -0.002056 -0.002895 0.002616 -12159 1 0.000240 1560.000000 -0.000580 0.000198 0.006694 -12160 1 0.000257 1560.000000 -0.001467 0.002361 0.004068 -12161 1 0.000196 1560.000000 0.000355 -0.001978 0.005728 -12162 1 0.000241 1560.000000 -0.000640 -0.002566 0.009817 -12163 1 0.000276 1560.000000 -0.000118 0.003062 0.006982 -12164 1 0.000260 1560.000000 -0.002489 0.000564 0.002990 -12165 1 0.000204 1560.000000 0.002922 0.001579 0.000401 -12166 1 0.000209 1560.000000 0.000254 0.003737 0.004328 -12167 1 0.000223 1560.000000 -0.000394 -0.002927 0.008269 -12168 1 0.000265 1560.000000 -0.002454 -0.001889 0.005986 -12169 1 0.000259 1560.000000 0.001149 -0.001136 0.009819 -12170 1 0.000252 1560.000000 -0.003063 -0.001422 0.000312 -12171 1 0.000252 1560.000000 -0.000217 -0.001672 0.008412 -12172 1 0.000227 1560.000000 0.001363 -0.000720 0.000354 -12173 1 0.000232 1560.000000 -0.000538 0.002811 0.009725 -12174 1 0.000231 1560.000000 -0.000948 0.003666 0.008552 -12175 1 0.000211 1560.000000 0.002364 0.002482 0.003640 -12176 1 0.000199 1560.000000 -0.000109 -0.002667 0.002469 -12177 1 0.000219 1560.000000 0.000219 -0.000870 0.007937 -12178 1 0.000208 1560.000000 -0.000237 -0.000431 0.008030 -12179 1 0.000228 1560.000000 -0.000432 -0.000542 0.004687 -12180 1 0.000228 1560.000000 0.003014 0.002342 0.002491 -12181 1 0.000238 1560.000000 0.003129 0.000103 0.000783 -12182 1 0.000206 1560.000000 -0.001285 -0.002367 0.009043 -12183 1 0.000204 1560.000000 0.002937 0.001943 0.005494 -12184 1 0.000201 1560.000000 -0.003215 0.000197 0.003737 -12185 1 0.000259 1560.000000 0.000360 -0.002694 0.004605 -12186 1 0.000251 1560.000000 -0.002063 -0.000814 0.005302 -12187 1 0.000278 1560.000000 -0.000576 -0.002998 0.006009 -12188 1 0.000234 1560.000000 -0.001384 0.001161 0.004838 -12189 1 0.000224 1560.000000 -0.000096 -0.001461 0.006410 -12190 1 0.000195 1560.000000 0.002465 0.000667 0.001521 -12191 1 0.000223 1560.000000 0.001964 -0.000109 0.004755 -12192 1 0.000253 1560.000000 0.001429 -0.000570 0.000868 -12193 1 0.000210 1560.000000 -0.000937 -0.000720 0.005970 -12194 1 0.000208 1560.000000 0.001285 -0.003119 0.003670 -12195 1 0.000287 1560.000000 -0.001648 -0.002193 0.005280 -12196 1 0.000231 1560.000000 0.000309 -0.003143 0.005483 -12197 1 0.000274 1560.000000 -0.000692 -0.002397 0.003100 -12198 1 0.000273 1560.000000 -0.001413 -0.000241 0.009776 -12199 1 0.000221 1560.000000 -0.000326 0.003839 0.000590 -12200 1 0.000266 1560.000000 0.002900 -0.000630 0.002990 -12201 1 0.000227 1560.000000 -0.002792 0.002274 0.002791 -12202 1 0.000281 1560.000000 -0.001941 -0.000425 0.001753 -12203 1 0.000235 1560.000000 0.003540 -0.001294 0.002233 -12204 1 0.000215 1560.000000 -0.003215 0.000357 0.005153 -12205 1 0.000198 1560.000000 -0.002119 0.000005 0.002315 -12206 1 0.000229 1560.000000 -0.002647 0.001069 0.003947 -12207 1 0.000200 1560.000000 -0.003467 -0.000096 0.002932 -12208 1 0.000221 1560.000000 0.002287 0.000322 0.001365 -12209 1 0.000217 1560.000000 -0.002590 -0.000893 0.000728 -12210 1 0.000199 1560.000000 -0.000969 -0.002187 0.007362 -12211 1 0.000226 1560.000000 -0.002273 -0.000454 0.003891 -12212 1 0.000233 1560.000000 0.001833 -0.003105 0.009263 -12213 1 0.000228 1560.000000 -0.001204 0.001221 0.005022 -12214 1 0.000232 1560.000000 0.002508 0.001374 0.007381 -12215 1 0.000229 1560.000000 -0.002022 -0.002687 0.006463 -12216 1 0.000195 1560.000000 0.002225 -0.000040 0.000401 -12217 1 0.000199 1560.000000 -0.001655 -0.002048 0.000954 -12218 1 0.000273 1560.000000 -0.001844 -0.000706 0.008483 -12219 1 0.000194 1560.000000 0.003071 0.001609 0.007118 -12220 1 0.000251 1560.000000 0.000283 -0.003535 0.003456 -12221 1 0.000281 1560.000000 0.002011 -0.003109 0.001242 -12222 1 0.000211 1560.000000 0.002987 -0.001841 0.007672 -12223 1 0.000217 1560.000000 0.003649 0.000214 0.003807 -12224 1 0.000257 1560.000000 -0.002266 -0.002538 0.001418 -12225 1 0.000288 1560.000000 0.001438 -0.002705 0.007635 -12226 1 0.000221 1560.000000 0.002180 -0.000660 0.007540 -12227 1 0.000227 1560.000000 -0.002490 -0.002675 0.002561 -12228 1 0.000239 1560.000000 -0.001991 0.001348 0.005722 -12229 1 0.000208 1560.000000 -0.002469 -0.001416 0.008483 -12230 1 0.000270 1560.000000 -0.001366 -0.001889 0.004117 -12231 1 0.000227 1560.000000 0.000630 0.001214 0.007468 -12232 1 0.000254 1560.000000 -0.001489 -0.000640 0.000558 -12233 1 0.000208 1560.000000 -0.000860 0.001961 0.001250 -12234 1 0.000206 1560.000000 -0.003656 -0.000054 0.009104 -12235 1 0.000199 1560.000000 0.002867 -0.002019 0.009399 -12236 1 0.000211 1560.000000 -0.000161 0.000759 0.006890 -12237 1 0.000205 1560.000000 0.003469 -0.000861 0.009724 -12238 1 0.000238 1560.000000 0.002796 -0.002100 0.007120 -12239 1 0.000192 1560.000000 0.000499 -0.003514 0.001658 -12240 1 0.000229 1560.000000 0.002087 -0.001936 0.004519 -12241 1 0.000233 1560.000000 -0.000984 -0.003567 0.006875 -12242 1 0.000218 1560.000000 -0.002334 -0.001076 0.005071 -12243 1 0.000237 1560.000000 0.002431 0.000825 0.009444 -12244 1 0.000209 1560.000000 -0.000880 0.000352 0.000526 -12245 1 0.000285 1560.000000 -0.000348 -0.002691 0.008173 -12246 1 0.000193 1560.000000 0.002488 -0.001445 0.002282 -12247 1 0.000224 1560.000000 -0.002006 -0.001832 0.009128 -12248 1 0.000208 1560.000000 -0.000373 -0.003713 0.008301 -12249 1 0.000220 1560.000000 -0.002315 0.000699 0.003090 -12250 1 0.000197 1560.000000 -0.003159 -0.001395 0.007885 -12251 1 0.000244 1560.000000 -0.001112 0.000337 0.007292 -12252 1 0.000198 1560.000000 0.000203 -0.003493 0.000205 -12253 1 0.000281 1560.000000 0.000744 -0.003011 0.005701 -12254 1 0.000263 1560.000000 -0.003228 -0.001227 0.006829 -12255 1 0.000277 1560.000000 0.002084 0.000523 0.006768 -12256 1 0.000255 1560.000000 -0.003625 -0.001271 0.001572 -12257 1 0.000246 1560.000000 -0.003837 -0.000185 0.009367 -12258 1 0.000269 1560.000000 0.002518 0.002654 0.003528 -12259 1 0.000223 1560.000000 -0.002515 -0.002892 0.005764 -12260 1 0.000223 1560.000000 -0.001999 -0.001286 0.008520 -12261 1 0.000204 1560.000000 0.003840 0.000035 0.001139 -12262 1 0.000210 1560.000000 0.002864 -0.001685 0.002670 -12263 1 0.000193 1560.000000 -0.000989 0.000741 0.000746 -12264 1 0.000196 1560.000000 -0.000556 0.003532 0.003042 -12265 1 0.000263 1560.000000 -0.002133 -0.002152 0.007636 -12266 1 0.000202 1560.000000 -0.000130 -0.002065 0.006249 -12267 1 0.000263 1560.000000 0.001161 0.002444 0.003536 -12268 1 0.000213 1560.000000 0.001594 -0.003434 0.007410 -12269 1 0.000232 1560.000000 0.003042 0.000215 0.002004 -12270 1 0.000213 1560.000000 -0.002030 0.000699 0.004829 -12271 1 0.000201 1560.000000 -0.003644 -0.000509 0.007795 -12272 1 0.000222 1560.000000 0.003826 -0.000421 0.001118 -12273 1 0.000233 1560.000000 0.002251 0.002266 0.001956 -12274 1 0.000237 1560.000000 0.001473 0.001066 0.004191 -12275 1 0.000245 1560.000000 -0.002404 0.002381 0.004702 -12276 1 0.000268 1560.000000 0.000337 0.003519 0.008007 -12277 1 0.000193 1560.000000 -0.001200 0.002936 0.001421 -12278 1 0.000213 1560.000000 -0.003426 0.001632 0.001197 -12279 1 0.000288 1560.000000 -0.000513 0.003047 0.000273 -12280 1 0.000198 1560.000000 0.002049 -0.003215 0.004835 -12281 1 0.000243 1560.000000 -0.000450 -0.002236 0.004909 -12282 1 0.000229 1560.000000 -0.001367 -0.000873 0.006684 -12283 1 0.000244 1560.000000 -0.003048 0.001974 0.007081 -12284 1 0.000211 1560.000000 0.002778 -0.002389 0.007255 -12285 1 0.000198 1560.000000 -0.001834 -0.003331 0.009012 -12286 1 0.000252 1560.000000 -0.002869 -0.000584 0.009318 -12287 1 0.000237 1560.000000 -0.003061 -0.000786 0.006697 -12288 1 0.000202 1560.000000 0.000509 -0.001589 0.005116 -12289 1 0.000242 1560.000000 0.002772 0.000556 0.007321 -12290 1 0.000255 1560.000000 -0.000021 -0.003172 0.001769 -12291 1 0.000245 1560.000000 0.003252 -0.000959 0.004197 -12292 1 0.000245 1560.000000 -0.003372 0.000452 0.004076 -12293 1 0.000237 1560.000000 0.000877 0.003368 0.006190 -12294 1 0.000196 1560.000000 0.000222 -0.002122 0.003998 -12295 1 0.000195 1560.000000 -0.001747 -0.001726 0.002925 -12296 1 0.000210 1560.000000 0.000889 0.000375 0.002018 -12297 1 0.000230 1560.000000 0.002310 -0.002799 0.007121 -12298 1 0.000196 1560.000000 0.001325 0.001607 0.001088 -12299 1 0.000199 1560.000000 -0.001087 -0.000768 0.009491 -12300 1 0.000221 1560.000000 0.002884 0.001144 0.003452 -12301 1 0.000264 1560.000000 -0.003070 -0.000170 0.008996 -12302 1 0.000285 1560.000000 -0.001439 0.001187 0.005806 -12303 1 0.000202 1560.000000 0.002827 -0.001460 0.006237 -12304 1 0.000198 1560.000000 0.003185 0.000620 0.006475 -12305 1 0.000232 1560.000000 0.001651 -0.003033 0.003273 -12306 1 0.000224 1560.000000 -0.001889 -0.003359 0.004206 -12307 1 0.000208 1560.000000 0.001733 0.001009 0.009008 -12308 1 0.000238 1560.000000 -0.001042 0.002058 0.005359 -12309 1 0.000243 1560.000000 0.000966 0.001266 0.005843 -12310 1 0.000202 1560.000000 -0.000961 0.000075 0.006130 -12311 1 0.000226 1560.000000 -0.003375 -0.000242 0.005727 -12312 1 0.000202 1560.000000 -0.000410 0.001417 0.006772 -12313 1 0.000221 1560.000000 0.000027 -0.003747 0.006720 -12314 1 0.000241 1560.000000 -0.001414 0.000905 0.002861 -12315 1 0.000225 1560.000000 0.002237 0.003128 0.002298 -12316 1 0.000202 1560.000000 0.000806 0.000747 0.003094 -12317 1 0.000210 1560.000000 -0.000108 -0.002004 0.008726 -12318 1 0.000280 1560.000000 0.002995 -0.002000 0.009196 -12319 1 0.000259 1560.000000 -0.003314 -0.001007 0.003088 -12320 1 0.000215 1560.000000 -0.000869 -0.001875 0.002208 -12321 1 0.000287 1560.000000 -0.001598 -0.000578 0.003793 -12322 1 0.000241 1560.000000 -0.003668 0.001163 0.001584 -12323 1 0.000270 1560.000000 -0.002031 0.002817 0.001555 -12324 1 0.000248 1560.000000 -0.000146 0.001142 0.007914 -12325 1 0.000196 1560.000000 -0.001789 -0.002466 0.004269 -12326 1 0.000242 1560.000000 0.002476 0.001407 0.004180 -12327 1 0.000267 1560.000000 -0.001054 0.002865 0.006069 -12328 1 0.000217 1560.000000 0.001006 0.003226 0.003525 -12329 1 0.000199 1560.000000 -0.003510 -0.000001 0.001461 -12330 1 0.000209 1560.000000 -0.002518 0.002844 0.006185 -12331 1 0.000228 1560.000000 -0.001455 0.001202 0.007455 -12332 1 0.000211 1560.000000 0.002198 -0.002134 0.003678 -12333 1 0.000206 1560.000000 -0.003189 0.000662 0.009413 -12334 1 0.000195 1560.000000 0.001002 0.001394 0.007803 -12335 1 0.000231 1560.000000 0.000126 -0.000506 0.008110 -12336 1 0.000203 1560.000000 0.003308 0.001913 0.000931 -12337 1 0.000258 1560.000000 0.000428 0.003282 0.003717 -12338 1 0.000206 1560.000000 0.000058 -0.003393 0.005179 -12339 1 0.000204 1560.000000 0.000683 0.003741 0.009320 -12340 1 0.000257 1560.000000 0.001945 0.000638 0.005503 -12341 1 0.000226 1560.000000 0.001420 0.003474 0.003435 -12342 1 0.000266 1560.000000 0.002054 0.002711 0.009535 -12343 1 0.000229 1560.000000 -0.002179 0.000489 0.001604 -12344 1 0.000241 1560.000000 0.000322 -0.003486 0.008137 -12345 1 0.000219 1560.000000 0.001944 0.002130 0.004613 -12346 1 0.000221 1560.000000 -0.003555 -0.000572 0.008395 -12347 1 0.000230 1560.000000 0.000685 -0.002618 0.006660 -12348 1 0.000224 1560.000000 0.003185 -0.000084 0.005916 -12349 1 0.000208 1560.000000 -0.000687 0.003732 0.003149 -12350 1 0.000237 1560.000000 -0.002691 0.001562 0.004124 -12351 1 0.000269 1560.000000 0.003324 -0.001517 0.003769 -12352 1 0.000257 1560.000000 -0.003210 0.001305 0.006655 -12353 1 0.000280 1560.000000 0.002187 0.002593 0.001907 -12354 1 0.000205 1560.000000 0.002585 0.000829 0.001717 -12355 1 0.000288 1560.000000 0.002893 0.001428 0.003559 -12356 1 0.000283 1560.000000 0.002239 -0.002259 0.007715 -12357 1 0.000192 1560.000000 -0.000947 -0.000990 0.003900 -12358 1 0.000218 1560.000000 -0.000760 -0.000700 0.008374 -12359 1 0.000193 1560.000000 0.002640 0.000867 0.001922 -12360 1 0.000205 1560.000000 0.000303 -0.003778 0.004927 -12361 1 0.000266 1560.000000 -0.000413 0.002053 0.000986 -12362 1 0.000240 1560.000000 -0.003696 0.000588 0.006988 -12363 1 0.000210 1560.000000 -0.001458 -0.002426 0.003938 -12364 1 0.000211 1560.000000 -0.003698 -0.000131 0.001567 -12365 1 0.000202 1560.000000 0.000998 -0.001341 0.009451 -12366 1 0.000268 1560.000000 0.001274 0.003075 0.007520 -12367 1 0.000193 1560.000000 0.003099 -0.002187 0.004904 -12368 1 0.000231 1560.000000 0.001127 0.003634 0.007953 -12369 1 0.000200 1560.000000 0.000162 -0.000128 0.006652 -12370 1 0.000243 1560.000000 -0.000498 -0.001066 0.007305 -12371 1 0.000235 1560.000000 0.002971 -0.000433 0.001784 -12372 1 0.000195 1560.000000 0.002558 -0.002672 0.009358 -12373 1 0.000210 1560.000000 -0.000210 -0.001038 0.004864 -12374 1 0.000234 1560.000000 0.002265 -0.000549 0.008542 -12375 1 0.000243 1560.000000 -0.000974 0.002799 0.000957 -12376 1 0.000242 1560.000000 -0.002755 0.001878 0.004981 -12377 1 0.000197 1560.000000 0.003558 0.001270 0.000671 -12378 1 0.000233 1560.000000 0.003557 0.001331 0.004664 -12379 1 0.000197 1560.000000 -0.001097 -0.002597 0.008776 -12380 1 0.000234 1560.000000 -0.000156 -0.002805 0.005540 -12381 1 0.000249 1560.000000 -0.001542 0.003479 0.001504 -12382 1 0.000201 1560.000000 -0.003230 0.000780 0.007505 -12383 1 0.000196 1560.000000 0.000704 0.001182 0.005737 -12384 1 0.000283 1560.000000 0.001183 -0.003453 0.000155 -12385 1 0.000207 1560.000000 0.000257 -0.001245 0.005458 -12386 1 0.000217 1560.000000 0.001125 0.000232 0.008965 -12387 1 0.000227 1560.000000 -0.001177 0.001689 0.009813 -12388 1 0.000212 1560.000000 -0.001320 -0.000528 0.003803 -12389 1 0.000217 1560.000000 -0.001799 0.002929 0.004297 -12390 1 0.000193 1560.000000 -0.000460 0.002301 0.003640 -12391 1 0.000214 1560.000000 0.000052 0.001062 0.003478 -12392 1 0.000279 1560.000000 -0.002423 -0.002241 0.003797 -12393 1 0.000221 1560.000000 -0.003454 0.000700 0.006205 -12394 1 0.000194 1560.000000 -0.001483 0.002480 0.003570 -12395 1 0.000210 1560.000000 0.002511 0.002715 0.009150 -12396 1 0.000278 1560.000000 0.000093 -0.000483 0.009803 -12397 1 0.000202 1560.000000 -0.001720 0.002947 0.007759 -12398 1 0.000255 1560.000000 0.000982 0.000202 0.009816 -12399 1 0.000207 1560.000000 0.001987 -0.002515 0.000622 -12400 1 0.000251 1560.000000 0.000271 -0.000731 0.000712 -12401 1 0.000271 1560.000000 -0.003457 0.000136 0.007385 -12402 1 0.000263 1560.000000 0.001225 0.003533 0.001023 -12403 1 0.000245 1560.000000 -0.001498 0.003311 0.001283 -12404 1 0.000212 1560.000000 0.003046 -0.001152 0.005577 -12405 1 0.000259 1560.000000 0.001058 0.001901 0.000620 -12406 1 0.000252 1560.000000 0.001837 -0.002357 0.004634 -12407 1 0.000271 1560.000000 -0.002487 0.002924 0.007876 -12408 1 0.000229 1560.000000 -0.000614 0.002950 0.007028 -12409 1 0.000239 1560.000000 -0.002194 -0.000934 0.004632 -12410 1 0.000192 1560.000000 -0.003510 0.000740 0.000523 -12411 1 0.000226 1560.000000 0.000102 0.001847 0.000183 -12412 1 0.000280 1560.000000 0.003306 -0.001907 0.005965 -12413 1 0.000258 1560.000000 0.000717 -0.002564 0.004504 -12414 1 0.000244 1560.000000 -0.002606 0.001115 0.009361 -12415 1 0.000232 1560.000000 0.002426 0.001244 0.005594 -12416 1 0.000198 1560.000000 -0.001394 -0.003289 0.009208 -12417 1 0.000285 1560.000000 -0.000448 -0.001777 0.002383 -12418 1 0.000216 1560.000000 -0.000042 0.002531 0.003977 -12419 1 0.000233 1560.000000 -0.000752 0.001751 0.002599 -12420 1 0.000252 1560.000000 0.002790 -0.002624 0.006497 -12421 1 0.000280 1560.000000 -0.002800 0.001550 0.005337 -12422 1 0.000273 1560.000000 0.001182 -0.001962 0.002781 -12423 1 0.000211 1560.000000 0.001164 -0.003324 0.003773 -12424 1 0.000272 1560.000000 0.001047 -0.000732 0.006709 -12425 1 0.000199 1560.000000 0.001414 0.002242 0.007618 -12426 1 0.000277 1560.000000 -0.000534 0.000917 0.007450 -12427 1 0.000200 1560.000000 -0.000844 0.002438 0.002123 -12428 1 0.000241 1560.000000 0.002019 0.001686 0.005569 -12429 1 0.000198 1560.000000 0.001804 0.002525 0.001920 -12430 1 0.000194 1560.000000 -0.001031 -0.000845 0.000122 -12431 1 0.000195 1560.000000 -0.000240 0.003347 0.009202 -12432 1 0.000208 1560.000000 0.002200 0.001243 0.007509 -12433 1 0.000206 1560.000000 -0.001383 0.003418 0.008685 -12434 1 0.000224 1560.000000 -0.001426 0.003241 0.000936 -12435 1 0.000262 1560.000000 0.002170 -0.003149 0.000711 -12436 1 0.000274 1560.000000 0.002895 -0.000905 0.006201 -12437 1 0.000245 1560.000000 0.000615 -0.000292 0.004815 -12438 1 0.000210 1560.000000 -0.002324 0.000474 0.005494 -12439 1 0.000244 1560.000000 -0.002948 -0.002126 0.006721 -12440 1 0.000274 1560.000000 -0.001691 0.002540 0.009563 -12441 1 0.000211 1560.000000 0.002999 -0.002041 0.008902 -12442 1 0.000247 1560.000000 -0.001990 0.000636 0.003259 -12443 1 0.000215 1560.000000 0.001930 0.001927 0.001466 -12444 1 0.000236 1560.000000 0.001350 0.001956 0.005684 -12445 1 0.000195 1560.000000 0.002346 0.001522 0.000519 -12446 1 0.000270 1560.000000 -0.001221 0.001357 0.004421 -12447 1 0.000279 1560.000000 0.002287 -0.001328 0.008112 -12448 1 0.000255 1560.000000 -0.000519 0.001930 0.009121 -12449 1 0.000197 1560.000000 0.001407 -0.002721 0.004462 -12450 1 0.000197 1560.000000 0.002053 0.001596 0.001172 -12451 1 0.000204 1560.000000 0.000529 0.001387 0.002581 -12452 1 0.000214 1560.000000 0.002308 0.001311 0.009301 -12453 1 0.000202 1560.000000 0.001719 0.000537 0.008872 -12454 1 0.000206 1560.000000 0.000192 0.003036 0.005079 -12455 1 0.000196 1560.000000 0.003332 -0.000880 0.006868 -12456 1 0.000195 1560.000000 -0.003371 0.000142 0.007994 -12457 1 0.000240 1560.000000 0.002076 0.000180 0.007438 -12458 1 0.000206 1560.000000 0.000791 0.001529 0.001094 -12459 1 0.000217 1560.000000 -0.003044 -0.001026 0.006635 -12460 1 0.000202 1560.000000 0.000412 0.001041 0.008396 -12461 1 0.000197 1560.000000 0.000418 -0.002117 0.004837 -12462 1 0.000205 1560.000000 0.002778 0.001348 0.004845 -12463 1 0.000219 1560.000000 -0.002587 0.001296 0.000475 -12464 1 0.000226 1560.000000 0.003182 0.000565 0.006097 -12465 1 0.000218 1560.000000 0.001460 -0.000858 0.000998 -12466 1 0.000276 1560.000000 -0.000855 -0.002039 0.003825 -12467 1 0.000198 1560.000000 0.000806 -0.000650 0.001353 -12468 1 0.000260 1560.000000 0.000066 -0.002354 0.000781 -12469 1 0.000256 1560.000000 -0.000576 0.001456 0.004843 -12470 1 0.000209 1560.000000 0.001914 0.000157 0.004993 -12471 1 0.000222 1560.000000 0.001768 0.001948 0.004466 -12472 1 0.000249 1560.000000 -0.001845 0.001449 0.008255 -12473 1 0.000195 1560.000000 0.002997 0.001895 0.001244 -12474 1 0.000253 1560.000000 -0.001368 0.002053 0.001294 -12475 1 0.000194 1560.000000 -0.001576 -0.001240 0.004078 -12476 1 0.000210 1560.000000 -0.000603 -0.000864 0.009721 -12477 1 0.000212 1560.000000 0.000940 -0.003430 0.004576 -12478 1 0.000199 1560.000000 -0.001227 -0.001323 0.008707 -12479 1 0.000222 1560.000000 -0.003311 -0.001863 0.000974 -12480 1 0.000279 1560.000000 -0.002004 0.002330 0.009677 -12481 1 0.000235 1560.000000 -0.000504 0.002387 0.005931 -12482 1 0.000274 1560.000000 -0.002796 0.001584 0.000542 -12483 1 0.000283 1560.000000 -0.002812 -0.002509 0.009809 -12484 1 0.000200 1560.000000 -0.003845 -0.000069 0.002940 -12485 1 0.000219 1560.000000 -0.003186 0.001548 0.004843 -12486 1 0.000251 1560.000000 -0.002564 0.002714 0.008664 -12487 1 0.000245 1560.000000 -0.002480 0.002855 0.003301 -12488 1 0.000257 1560.000000 -0.001947 -0.002835 0.004815 -12489 1 0.000263 1560.000000 -0.001976 -0.000528 0.009585 -12490 1 0.000231 1560.000000 -0.003189 -0.000295 0.003919 -12491 1 0.000247 1560.000000 -0.002077 -0.000558 0.000670 -12492 1 0.000270 1560.000000 -0.000768 0.000197 0.002423 -12493 1 0.000196 1560.000000 0.002423 0.001436 0.006241 -12494 1 0.000270 1560.000000 -0.001669 0.003259 0.008126 -12495 1 0.000231 1560.000000 0.003430 0.001642 0.007706 -12496 1 0.000193 1560.000000 0.002660 -0.000755 0.005575 -12497 1 0.000224 1560.000000 -0.000268 -0.000390 0.006440 -12498 1 0.000197 1560.000000 -0.000824 0.003361 0.006235 -12499 1 0.000249 1560.000000 -0.002738 0.000228 0.004068 -12500 1 0.000288 1560.000000 0.001479 -0.002628 0.002035 -12501 1 0.000280 1560.000000 0.003298 0.000703 0.004927 -12502 1 0.000212 1560.000000 -0.001781 0.002740 0.001081 -12503 1 0.000247 1560.000000 0.002020 0.001388 0.001738 -12504 1 0.000256 1560.000000 0.001507 -0.001327 0.002079 -12505 1 0.000284 1560.000000 -0.001692 0.003456 0.008962 -12506 1 0.000245 1560.000000 0.001035 -0.000016 0.003129 -12507 1 0.000208 1560.000000 -0.003586 -0.000767 0.006877 -12508 1 0.000262 1560.000000 0.001116 -0.002392 0.001821 -12509 1 0.000204 1560.000000 -0.003178 -0.000558 0.005021 -12510 1 0.000194 1560.000000 -0.000144 0.003298 0.008059 -12511 1 0.000230 1560.000000 -0.001372 0.000385 0.001169 -12512 1 0.000246 1560.000000 0.003427 -0.001282 0.008996 -12513 1 0.000221 1560.000000 -0.001013 0.000871 0.007981 -12514 1 0.000209 1560.000000 -0.003049 0.000915 0.000998 -12515 1 0.000268 1560.000000 -0.000856 0.000249 0.009838 -12516 1 0.000198 1560.000000 0.002020 0.000667 0.005873 -12517 1 0.000195 1560.000000 0.000289 0.003570 0.000179 -12518 1 0.000246 1560.000000 0.000037 -0.002002 0.004842 -12519 1 0.000236 1560.000000 0.002350 0.002245 0.005843 -12520 1 0.000270 1560.000000 -0.000094 0.002927 0.001472 -12521 1 0.000243 1560.000000 -0.001864 -0.001482 0.002264 -12522 1 0.000256 1560.000000 -0.000099 -0.001759 0.006674 -12523 1 0.000232 1560.000000 0.000086 -0.002314 0.002701 -12524 1 0.000261 1560.000000 -0.001823 -0.000746 0.003796 -12525 1 0.000224 1560.000000 0.002728 -0.001353 0.000965 -12526 1 0.000202 1560.000000 -0.001539 0.001235 0.002164 -12527 1 0.000275 1560.000000 0.001740 -0.002760 0.000144 -12528 1 0.000242 1560.000000 -0.000417 -0.002165 0.007706 -12529 1 0.000274 1560.000000 0.000764 -0.002836 0.004724 -12530 1 0.000250 1560.000000 0.002381 0.002932 0.003444 -12531 1 0.000265 1560.000000 0.002769 0.001160 0.006427 -12532 1 0.000275 1560.000000 -0.000611 -0.000261 0.003697 -12533 1 0.000197 1560.000000 -0.000552 -0.001069 0.009687 -12534 1 0.000212 1560.000000 0.001698 0.002952 0.002332 -12535 1 0.000232 1560.000000 -0.001838 0.001610 0.002658 -12536 1 0.000199 1560.000000 0.000334 0.002588 0.000624 -12537 1 0.000219 1560.000000 -0.000511 -0.000003 0.001569 -12538 1 0.000221 1560.000000 -0.001639 0.000058 0.001436 -12539 1 0.000215 1560.000000 -0.001180 0.001820 0.000881 -12540 1 0.000203 1560.000000 0.002064 0.001868 0.006991 -12541 1 0.000201 1560.000000 0.002475 0.000943 0.008974 -12542 1 0.000201 1560.000000 0.001311 -0.001510 0.005024 -12543 1 0.000230 1560.000000 0.000502 0.003310 0.004460 -12544 1 0.000233 1560.000000 0.002682 0.002263 0.007687 -12545 1 0.000267 1560.000000 0.003493 0.001621 0.000412 -12546 1 0.000268 1560.000000 0.001989 0.002930 0.001480 -12547 1 0.000216 1560.000000 0.001851 -0.001566 0.005664 -12548 1 0.000262 1560.000000 0.001021 0.003308 0.001123 -12549 1 0.000281 1560.000000 -0.001746 0.003404 0.004350 -12550 1 0.000215 1560.000000 -0.001509 0.001078 0.006832 -12551 1 0.000235 1560.000000 -0.002869 -0.001766 0.004338 -12552 1 0.000199 1560.000000 -0.001073 0.000255 0.006261 -12553 1 0.000232 1560.000000 0.001923 0.001235 0.001439 -12554 1 0.000274 1560.000000 -0.001246 -0.003009 0.004073 -12555 1 0.000255 1560.000000 -0.002430 0.001891 0.004408 -12556 1 0.000217 1560.000000 0.003357 -0.000317 0.006430 -12557 1 0.000218 1560.000000 0.002025 -0.002427 0.007723 -12558 1 0.000204 1560.000000 -0.002121 0.001360 0.005215 -12559 1 0.000228 1560.000000 -0.001888 -0.002982 0.000834 -12560 1 0.000264 1560.000000 0.002080 0.000981 0.004362 -12561 1 0.000284 1560.000000 0.002505 0.002800 0.008128 -12562 1 0.000195 1560.000000 -0.000651 -0.000033 0.009013 -12563 1 0.000231 1560.000000 0.002022 0.001392 0.006540 -12564 1 0.000285 1560.000000 0.001472 0.003283 0.001685 -12565 1 0.000265 1560.000000 -0.003525 -0.001346 0.006521 -12566 1 0.000226 1560.000000 -0.001810 0.001300 0.006164 -12567 1 0.000195 1560.000000 -0.001322 -0.000849 0.009426 -12568 1 0.000224 1560.000000 0.002266 -0.001276 0.008497 -12569 1 0.000230 1560.000000 0.002768 -0.002170 0.007927 -12570 1 0.000196 1560.000000 0.002430 0.000847 0.004564 -12571 1 0.000214 1560.000000 -0.000217 0.001742 0.003464 -12572 1 0.000245 1560.000000 -0.000047 0.001463 0.003509 -12573 1 0.000286 1560.000000 -0.002014 -0.001934 0.009812 -12574 1 0.000196 1560.000000 -0.000603 -0.003664 0.001726 -12575 1 0.000235 1560.000000 0.002853 -0.000960 0.008659 -12576 1 0.000202 1560.000000 0.000638 -0.002254 0.003139 -12577 1 0.000194 1560.000000 0.003620 0.000444 0.005633 -12578 1 0.000197 1560.000000 -0.000298 0.002160 0.007070 -12579 1 0.000266 1560.000000 -0.000626 -0.002654 0.001568 -12580 1 0.000250 1560.000000 -0.002421 -0.001913 0.006583 -12581 1 0.000198 1560.000000 -0.000682 -0.000125 0.004684 -12582 1 0.000280 1560.000000 -0.003096 0.002100 0.002916 -12583 1 0.000207 1560.000000 -0.000598 -0.003408 0.008794 -12584 1 0.000221 1560.000000 -0.000142 -0.003058 0.005534 -12585 1 0.000195 1560.000000 -0.003676 0.000150 0.009453 -12586 1 0.000213 1560.000000 -0.003377 0.000367 0.003511 -12587 1 0.000249 1560.000000 0.002423 -0.001968 0.007910 -12588 1 0.000213 1560.000000 -0.002544 0.002434 0.008763 -12589 1 0.000232 1560.000000 0.002829 -0.001249 0.009473 -12590 1 0.000226 1560.000000 0.000883 -0.001265 0.004651 -12591 1 0.000195 1560.000000 -0.002278 0.001502 0.008811 -12592 1 0.000207 1560.000000 -0.001763 0.002344 0.009321 -12593 1 0.000237 1560.000000 -0.003178 -0.000329 0.005043 -12594 1 0.000231 1560.000000 -0.003339 0.001848 0.003692 -12595 1 0.000223 1560.000000 0.001277 0.000939 0.005697 -12596 1 0.000260 1560.000000 -0.001443 0.000941 0.009321 -12597 1 0.000236 1560.000000 0.002038 -0.002402 0.008188 -12598 1 0.000193 1560.000000 0.000840 0.002121 0.008879 -12599 1 0.000213 1560.000000 -0.003259 -0.000633 0.007236 -12600 1 0.000237 1560.000000 -0.002201 0.001614 0.003852 -12601 1 0.000282 1560.000000 -0.002397 0.001669 0.002243 -12602 1 0.000282 1560.000000 0.002757 -0.002547 0.001715 -12603 1 0.000208 1560.000000 -0.002989 -0.002223 0.000717 -12604 1 0.000224 1560.000000 -0.001922 0.003341 0.007562 -12605 1 0.000249 1560.000000 0.001319 -0.003049 0.001143 -12606 1 0.000242 1560.000000 0.002373 -0.003015 0.003642 -12607 1 0.000198 1560.000000 -0.000372 0.003045 0.007231 -12608 1 0.000246 1560.000000 -0.000784 -0.002137 0.001423 -12609 1 0.000225 1560.000000 0.001855 -0.000482 0.009242 -12610 1 0.000252 1560.000000 0.000810 0.003367 0.004446 -12611 1 0.000210 1560.000000 -0.002437 -0.000078 0.006262 -12612 1 0.000216 1560.000000 0.000162 -0.002020 0.001514 -12613 1 0.000211 1560.000000 0.003671 0.000228 0.007565 -12614 1 0.000201 1560.000000 0.002060 -0.003033 0.006234 -12615 1 0.000204 1560.000000 0.001047 0.003507 0.003321 -12616 1 0.000274 1560.000000 -0.000679 0.001664 0.007917 -12617 1 0.000194 1560.000000 -0.001163 0.000979 0.009432 -12618 1 0.000240 1560.000000 0.000636 0.002480 0.007138 -12619 1 0.000216 1560.000000 -0.000375 0.000869 0.003258 -12620 1 0.000260 1560.000000 -0.000031 -0.003394 0.003494 -12621 1 0.000200 1560.000000 -0.002749 -0.002200 0.007222 -12622 1 0.000205 1560.000000 -0.003317 -0.000764 0.005496 -12623 1 0.000215 1560.000000 -0.001875 -0.000883 0.005005 -12624 1 0.000211 1560.000000 -0.002674 0.001962 0.009513 -12625 1 0.000234 1560.000000 0.002645 -0.001875 0.002948 -12626 1 0.000270 1560.000000 0.001467 -0.002146 0.006322 -12627 1 0.000275 1560.000000 0.000647 -0.003752 0.005198 -12628 1 0.000221 1560.000000 0.002714 -0.001731 0.009737 -12629 1 0.000211 1560.000000 -0.002963 0.001278 0.006916 -12630 1 0.000261 1560.000000 -0.000696 -0.000230 0.004132 -12631 1 0.000219 1560.000000 0.000333 -0.000336 0.000112 -12632 1 0.000214 1560.000000 -0.001314 0.002290 0.005988 -12633 1 0.000230 1560.000000 -0.002945 -0.001825 0.009707 -12634 1 0.000226 1560.000000 -0.001406 -0.002382 0.005344 -12635 1 0.000210 1560.000000 -0.003364 0.000788 0.002634 -12636 1 0.000242 1560.000000 -0.003205 -0.000645 0.009369 -12637 1 0.000262 1560.000000 -0.001517 0.000233 0.003601 -12638 1 0.000261 1560.000000 0.002920 0.001239 0.002177 -12639 1 0.000194 1560.000000 0.002496 0.002797 0.000183 -12640 1 0.000267 1560.000000 -0.002658 0.000903 0.005472 -12641 1 0.000207 1560.000000 0.000783 0.003635 0.005249 -12642 1 0.000271 1560.000000 -0.001158 0.001462 0.000310 -12643 1 0.000201 1560.000000 -0.001533 0.002101 0.007454 -12644 1 0.000209 1560.000000 0.001789 -0.003368 0.001169 -12645 1 0.000235 1560.000000 -0.001114 0.000383 0.003764 -12646 1 0.000196 1560.000000 0.003582 0.000277 0.006225 -12647 1 0.000203 1560.000000 -0.000889 0.001893 0.003856 -12648 1 0.000275 1560.000000 0.000087 0.000952 0.008068 -12649 1 0.000277 1560.000000 -0.001459 0.002954 0.007257 -12650 1 0.000286 1560.000000 0.002901 0.000945 0.005659 -12651 1 0.000287 1560.000000 -0.000415 0.003089 0.009826 -12652 1 0.000215 1560.000000 0.001791 -0.002834 0.005914 -12653 1 0.000200 1560.000000 0.001487 0.001153 0.006579 -12654 1 0.000196 1560.000000 -0.001110 0.001896 0.000431 -12655 1 0.000225 1560.000000 0.002044 -0.000966 0.001228 -12656 1 0.000195 1560.000000 0.000152 -0.002482 0.003387 -12657 1 0.000220 1560.000000 -0.002724 0.000249 0.004976 -12658 1 0.000194 1560.000000 0.000889 0.000062 0.003941 -12659 1 0.000240 1560.000000 -0.002582 0.001536 0.008829 -12660 1 0.000223 1560.000000 -0.001453 -0.002962 0.004222 -12661 1 0.000213 1560.000000 -0.000043 0.003621 0.000714 -12662 1 0.000204 1560.000000 -0.002792 0.002568 0.009600 -12663 1 0.000255 1560.000000 0.003766 -0.000034 0.008792 -12664 1 0.000199 1560.000000 -0.000815 0.000180 0.004791 -12665 1 0.000200 1560.000000 0.002064 0.000628 0.008358 -12666 1 0.000273 1560.000000 -0.000083 -0.003552 0.006199 -12667 1 0.000278 1560.000000 -0.002622 -0.002410 0.008200 -12668 1 0.000215 1560.000000 0.001855 0.001124 0.007675 -12669 1 0.000206 1560.000000 0.000630 -0.000502 0.007314 -12670 1 0.000234 1560.000000 0.000883 0.001642 0.000141 -12671 1 0.000247 1560.000000 0.000136 -0.001869 0.009350 -12672 1 0.000195 1560.000000 0.003318 0.001953 0.007045 -12673 1 0.000217 1560.000000 -0.002152 -0.003089 0.002774 -12674 1 0.000251 1560.000000 0.000358 0.000979 0.009016 -12675 1 0.000275 1560.000000 -0.002064 -0.000169 0.000859 -12676 1 0.000221 1560.000000 -0.000874 0.000337 0.002231 -12677 1 0.000201 1560.000000 0.000623 0.003451 0.006690 -12678 1 0.000266 1560.000000 -0.000024 -0.003757 0.008597 -12679 1 0.000215 1560.000000 0.000822 -0.003733 0.009011 -12680 1 0.000197 1560.000000 -0.000650 -0.002794 0.003235 -12681 1 0.000243 1560.000000 0.003430 -0.000151 0.009767 -12682 1 0.000229 1560.000000 -0.001098 0.002006 0.005077 -12683 1 0.000229 1560.000000 0.001720 -0.001235 0.002576 -12684 1 0.000281 1560.000000 -0.003053 0.001115 0.003250 -12685 1 0.000222 1560.000000 -0.000908 -0.002605 0.001324 -12686 1 0.000224 1560.000000 -0.001327 -0.001733 0.005591 -12687 1 0.000206 1560.000000 -0.001509 -0.001920 0.009542 -12688 1 0.000208 1560.000000 0.002996 -0.000638 0.007297 -12689 1 0.000264 1560.000000 0.000218 0.002699 0.002955 -12690 1 0.000197 1560.000000 0.001236 -0.001207 0.004027 -12691 1 0.000205 1560.000000 0.000181 -0.001402 0.008350 -12692 1 0.000197 1560.000000 0.000274 0.003453 0.009174 -12693 1 0.000228 1560.000000 -0.000087 0.001853 0.002299 -12694 1 0.000249 1560.000000 0.003318 0.001808 0.009324 -12695 1 0.000237 1560.000000 0.002473 -0.002876 0.005294 -12696 1 0.000274 1560.000000 -0.003515 -0.001118 0.001010 -12697 1 0.000211 1560.000000 0.000479 -0.003017 0.007111 -12698 1 0.000248 1560.000000 -0.000288 -0.001951 0.007176 -12699 1 0.000193 1560.000000 -0.003031 -0.001844 0.006046 -12700 1 0.000199 1560.000000 -0.000815 0.002357 0.007261 -12701 1 0.000210 1560.000000 0.001681 -0.002916 0.001653 -12702 1 0.000236 1560.000000 -0.002804 0.000175 0.008841 -12703 1 0.000221 1560.000000 0.000902 -0.000232 0.005741 -12704 1 0.000214 1560.000000 -0.002406 -0.001888 0.007014 -12705 1 0.000220 1560.000000 -0.001621 0.002382 0.003434 -12706 1 0.000252 1560.000000 -0.000084 0.001222 0.009416 -12707 1 0.000226 1560.000000 0.001995 -0.000871 0.006008 -12708 1 0.000227 1560.000000 0.003022 0.002261 0.009695 -12709 1 0.000216 1560.000000 0.000523 -0.003359 0.001103 -12710 1 0.000197 1560.000000 0.000660 -0.002173 0.000527 -12711 1 0.000282 1560.000000 -0.002039 0.002234 0.002732 -12712 1 0.000224 1560.000000 0.001926 -0.002932 0.002977 -12713 1 0.000217 1560.000000 -0.000242 0.000307 0.009605 -12714 1 0.000282 1560.000000 0.002171 0.001124 0.006451 -12715 1 0.000231 1560.000000 -0.002757 -0.000103 0.001854 -12716 1 0.000200 1560.000000 0.000162 -0.000209 0.000160 -12717 1 0.000213 1560.000000 0.001827 -0.002904 0.009029 -12718 1 0.000277 1560.000000 0.002691 -0.000237 0.005431 -12719 1 0.000228 1560.000000 0.000680 0.000554 0.007164 -12720 1 0.000257 1560.000000 -0.000890 -0.002571 0.003737 -12721 1 0.000214 1560.000000 -0.002471 -0.000149 0.001535 -12722 1 0.000220 1560.000000 -0.000950 -0.000101 0.004958 -12723 1 0.000260 1560.000000 -0.001337 0.003604 0.005804 -12724 1 0.000201 1560.000000 0.003091 0.001205 0.009623 -12725 1 0.000254 1560.000000 0.001029 0.003196 0.000171 -12726 1 0.000231 1560.000000 -0.000164 -0.001628 0.003364 -12727 1 0.000231 1560.000000 0.001968 0.001103 0.004952 -12728 1 0.000281 1560.000000 -0.000339 0.003448 0.005045 -12729 1 0.000264 1560.000000 -0.003775 -0.000535 0.001030 -12730 1 0.000192 1560.000000 0.002050 -0.002704 0.007714 -12731 1 0.000205 1560.000000 -0.001685 0.001003 0.007891 -12732 1 0.000285 1560.000000 0.001487 0.001724 0.000293 -12733 1 0.000208 1560.000000 0.000105 -0.001201 0.000765 -12734 1 0.000195 1560.000000 0.003683 -0.000064 0.008272 -12735 1 0.000210 1560.000000 -0.003502 -0.000880 0.002385 -12736 1 0.000249 1560.000000 -0.000282 0.001652 0.002390 -12737 1 0.000199 1560.000000 -0.001391 0.000046 0.005029 -12738 1 0.000251 1560.000000 0.001112 0.001849 0.005334 -12739 1 0.000250 1560.000000 -0.001829 -0.000455 0.002346 -12740 1 0.000208 1560.000000 0.000157 -0.001385 0.000467 -12741 1 0.000254 1560.000000 -0.003809 -0.000074 0.004414 -12742 1 0.000258 1560.000000 0.003204 -0.001740 0.000600 -12743 1 0.000207 1560.000000 0.002703 0.000627 0.006643 -12744 1 0.000213 1560.000000 0.001607 -0.003208 0.000108 -12745 1 0.000236 1560.000000 -0.003299 0.000721 0.001862 -12746 1 0.000230 1560.000000 -0.001629 0.003330 0.003639 -12747 1 0.000253 1560.000000 0.001895 0.003034 0.005320 -12748 1 0.000202 1560.000000 -0.000447 0.003271 0.006358 -12749 1 0.000249 1560.000000 0.000939 -0.002467 0.008805 -12750 1 0.000273 1560.000000 -0.000085 -0.001760 0.007636 -12751 1 0.000284 1560.000000 0.002958 -0.002295 0.001536 -12752 1 0.000270 1560.000000 -0.000663 -0.003700 0.008585 -12753 1 0.000244 1560.000000 0.003322 -0.001478 0.000778 -12754 1 0.000208 1560.000000 0.000029 -0.000675 0.003842 -12755 1 0.000234 1560.000000 0.002646 0.000324 0.009217 -12756 1 0.000228 1560.000000 -0.003538 0.000413 0.000295 -12757 1 0.000196 1560.000000 -0.002491 -0.000067 0.002617 -12758 1 0.000194 1560.000000 0.002482 0.002465 0.007895 -12759 1 0.000214 1560.000000 -0.000590 -0.002868 0.000964 -12760 1 0.000273 1560.000000 -0.001460 -0.001804 0.009825 -12761 1 0.000258 1560.000000 -0.002561 0.002772 0.009727 -12762 1 0.000246 1560.000000 0.002104 -0.002296 0.004578 -12763 1 0.000194 1560.000000 -0.003125 -0.002052 0.001621 -12764 1 0.000196 1560.000000 -0.000825 -0.000149 0.006485 -12765 1 0.000195 1560.000000 0.002720 0.001256 0.006653 -12766 1 0.000218 1560.000000 0.000440 0.000271 0.005605 -12767 1 0.000199 1560.000000 -0.002109 -0.001690 0.001417 -12768 1 0.000196 1560.000000 -0.001781 0.003081 0.004048 -12769 1 0.000287 1560.000000 -0.001925 -0.001479 0.006456 -12770 1 0.000235 1560.000000 0.000524 0.003761 0.007333 -12771 1 0.000262 1560.000000 -0.000361 0.002629 0.006200 -12772 1 0.000242 1560.000000 0.001979 -0.002074 0.003580 -12773 1 0.000194 1560.000000 0.001149 -0.001964 0.006370 -12774 1 0.000210 1560.000000 -0.001766 -0.001194 0.007441 -12775 1 0.000215 1560.000000 -0.001514 -0.001604 0.003371 -12776 1 0.000217 1560.000000 0.002056 -0.000367 0.004733 -12777 1 0.000215 1560.000000 -0.002218 -0.001068 0.000213 -12778 1 0.000257 1560.000000 0.002328 -0.002457 0.002748 -12779 1 0.000212 1560.000000 0.003007 -0.000902 0.000918 -12780 1 0.000221 1560.000000 -0.002869 -0.000664 0.003280 -12781 1 0.000232 1560.000000 0.001115 -0.002690 0.009124 -12782 1 0.000200 1560.000000 -0.002741 0.000632 0.004591 -12783 1 0.000282 1560.000000 0.002543 -0.000639 0.008214 -12784 1 0.000254 1560.000000 0.002575 -0.002640 0.006673 -12785 1 0.000274 1560.000000 -0.000039 -0.003400 0.007339 -12786 1 0.000251 1560.000000 0.003209 -0.001214 0.005302 -12787 1 0.000197 1560.000000 -0.001796 0.000833 0.007354 -12788 1 0.000239 1560.000000 -0.001030 0.003517 0.006325 -12789 1 0.000243 1560.000000 -0.002063 0.002323 0.008249 -12790 1 0.000238 1560.000000 -0.001743 0.001569 0.009146 -12791 1 0.000205 1560.000000 -0.002784 0.001398 0.009126 -12792 1 0.000278 1560.000000 -0.002111 -0.002539 0.008708 -12793 1 0.000196 1560.000000 0.002929 0.000374 0.005358 -12794 1 0.000223 1560.000000 -0.001306 0.003542 0.006764 -12795 1 0.000209 1560.000000 -0.001925 -0.002009 0.003568 -12796 1 0.000193 1560.000000 -0.001575 0.001233 0.003232 -12797 1 0.000229 1560.000000 0.000900 0.000153 0.009496 -12798 1 0.000234 1560.000000 -0.001325 0.003580 0.008905 -12799 1 0.000257 1560.000000 0.000603 -0.002831 0.007228 -12800 1 0.000196 1560.000000 -0.002241 0.002817 0.008963 -12801 1 0.000228 1560.000000 0.002460 0.000016 0.005318 -12802 1 0.000233 1560.000000 -0.002280 0.001841 0.004009 -12803 1 0.000193 1560.000000 0.002527 -0.002015 0.004287 -12804 1 0.000241 1560.000000 -0.000253 0.001031 0.005967 -12805 1 0.000259 1560.000000 0.001725 0.000388 0.007527 -12806 1 0.000200 1560.000000 0.000453 -0.003141 0.009041 -12807 1 0.000209 1560.000000 -0.000757 0.002458 0.005535 -12808 1 0.000212 1560.000000 -0.002441 0.002930 0.004578 -12809 1 0.000205 1560.000000 0.002112 0.002162 0.002336 -12810 1 0.000217 1560.000000 0.002740 -0.001446 0.006493 -12811 1 0.000279 1560.000000 -0.001633 -0.002484 0.000691 -12812 1 0.000214 1560.000000 -0.002804 0.001375 0.003578 -12813 1 0.000225 1560.000000 0.003302 0.001905 0.004719 -12814 1 0.000240 1560.000000 -0.000491 -0.002713 0.007919 -12815 1 0.000216 1560.000000 0.001777 0.002174 0.005830 -12816 1 0.000226 1560.000000 0.001594 0.002568 0.009593 -12817 1 0.000198 1560.000000 -0.003119 0.001404 0.007618 -12818 1 0.000271 1560.000000 0.002621 0.001118 0.000437 -12819 1 0.000208 1560.000000 -0.002149 0.000637 0.001098 -12820 1 0.000240 1560.000000 0.000173 0.003390 0.009774 -12821 1 0.000263 1560.000000 -0.000210 0.003449 0.001133 -12822 1 0.000233 1560.000000 0.001853 -0.000428 0.005573 -12823 1 0.000218 1560.000000 -0.000454 0.003786 0.006931 -12824 1 0.000224 1560.000000 0.001909 -0.001494 0.003042 -12825 1 0.000196 1560.000000 -0.001497 -0.000586 0.004686 -12826 1 0.000245 1560.000000 0.001687 0.002562 0.002481 -12827 1 0.000219 1560.000000 -0.002244 -0.002738 0.009094 -12828 1 0.000236 1560.000000 0.002664 -0.001039 0.009313 -12829 1 0.000231 1560.000000 0.003305 -0.001191 0.003820 -12830 1 0.000220 1560.000000 -0.003428 0.001361 0.004188 -12831 1 0.000212 1560.000000 0.000714 0.001001 0.000680 -12832 1 0.000205 1560.000000 -0.000272 -0.000658 0.000968 -12833 1 0.000235 1560.000000 0.000729 0.000556 0.007552 -12834 1 0.000270 1560.000000 -0.000031 -0.002116 0.003256 -12835 1 0.000224 1560.000000 -0.001142 0.000233 0.006912 -12836 1 0.000287 1560.000000 0.001252 -0.001664 0.007517 -12837 1 0.000250 1560.000000 -0.002226 -0.002970 0.003315 -12838 1 0.000212 1560.000000 0.001975 -0.001041 0.003296 -12839 1 0.000248 1560.000000 -0.002745 0.000750 0.008130 -12840 1 0.000275 1560.000000 0.000861 -0.000891 0.003217 -12841 1 0.000248 1560.000000 -0.000846 -0.002819 0.001047 -12842 1 0.000211 1560.000000 0.002368 0.000504 0.005369 -12843 1 0.000269 1560.000000 -0.003754 0.000040 0.008302 -12844 1 0.000265 1560.000000 0.003032 -0.000452 0.001201 -12845 1 0.000233 1560.000000 -0.001764 0.002670 0.004865 -12846 1 0.000208 1560.000000 0.001037 0.001465 0.008930 -12847 1 0.000233 1560.000000 0.003450 0.001576 0.002261 -12848 1 0.000240 1560.000000 -0.001604 0.001344 0.000884 -12849 1 0.000219 1560.000000 -0.000568 -0.003262 0.001625 -12850 1 0.000207 1560.000000 -0.001162 -0.002353 0.008653 -12851 1 0.000196 1560.000000 -0.002900 -0.001454 0.002018 -12852 1 0.000210 1560.000000 0.000828 0.002039 0.001410 -12853 1 0.000207 1560.000000 -0.003769 0.000756 0.008041 -12854 1 0.000221 1560.000000 0.003090 -0.001870 0.002163 -12855 1 0.000250 1560.000000 -0.000825 0.002446 0.006014 -12856 1 0.000203 1560.000000 0.000723 0.001683 0.001511 -12857 1 0.000241 1560.000000 0.002470 -0.002694 0.002454 -12858 1 0.000196 1560.000000 -0.001743 -0.001798 0.003853 -12859 1 0.000247 1560.000000 0.001561 -0.000078 0.000328 -12860 1 0.000227 1560.000000 0.001480 0.003516 0.005154 -12861 1 0.000209 1560.000000 0.000531 -0.001045 0.001197 -12862 1 0.000264 1560.000000 0.002309 0.002953 0.001771 -12863 1 0.000239 1560.000000 -0.002225 -0.001544 0.002141 -12864 1 0.000230 1560.000000 0.000035 0.002389 0.008679 -12865 1 0.000261 1560.000000 -0.002037 -0.000222 0.004516 -12866 1 0.000214 1560.000000 -0.003492 0.001514 0.009025 -12867 1 0.000204 1560.000000 -0.000091 -0.000473 0.006554 -12868 1 0.000228 1560.000000 -0.001913 0.001342 0.000453 -12869 1 0.000236 1560.000000 0.000971 -0.003626 0.002879 -12870 1 0.000267 1560.000000 -0.003772 -0.000750 0.001748 -12871 1 0.000226 1560.000000 -0.002990 0.001062 0.008155 -12872 1 0.000267 1560.000000 0.001552 -0.002707 0.009246 -12873 1 0.000220 1560.000000 0.000948 -0.002917 0.003471 -12874 1 0.000224 1560.000000 0.000002 0.003814 0.006446 -12875 1 0.000247 1560.000000 -0.002104 0.001593 0.000768 -12876 1 0.000209 1560.000000 -0.001300 -0.003617 0.006047 -12877 1 0.000208 1560.000000 0.000685 -0.002796 0.008385 -12878 1 0.000252 1560.000000 -0.002325 0.002783 0.008751 -12879 1 0.000264 1560.000000 -0.002108 0.001096 0.007774 -12880 1 0.000260 1560.000000 0.002970 0.000266 0.006967 -12881 1 0.000287 1560.000000 -0.003825 0.000454 0.000824 -12882 1 0.000193 1560.000000 -0.000543 0.003667 0.004626 -12883 1 0.000200 1560.000000 0.001150 0.002132 0.009045 -12884 1 0.000238 1560.000000 0.002738 -0.002365 0.004797 -12885 1 0.000230 1560.000000 0.003461 -0.001680 0.005856 -12886 1 0.000216 1560.000000 0.000785 -0.001534 0.008640 -12887 1 0.000205 1560.000000 0.002590 0.001880 0.005118 -12888 1 0.000210 1560.000000 -0.000828 -0.001805 0.002609 -12889 1 0.000262 1560.000000 0.001658 0.001428 0.000235 -12890 1 0.000212 1560.000000 0.002503 0.002233 0.001951 -12891 1 0.000208 1560.000000 -0.001506 0.001179 0.004338 -12892 1 0.000231 1560.000000 -0.000247 -0.000836 0.003708 -12893 1 0.000276 1560.000000 0.000339 -0.002576 0.005112 -12894 1 0.000240 1560.000000 -0.003463 0.000411 0.008623 -12895 1 0.000263 1560.000000 0.002964 0.001596 0.008108 -12896 1 0.000194 1560.000000 -0.000181 -0.002034 0.000982 -12897 1 0.000229 1560.000000 0.000700 0.001035 0.001198 -12898 1 0.000218 1560.000000 -0.000371 0.000649 0.006053 -12899 1 0.000272 1560.000000 -0.000951 -0.002352 0.009423 -12900 1 0.000230 1560.000000 0.001941 -0.000164 0.000335 -12901 1 0.000201 1560.000000 -0.001889 -0.002152 0.005940 -12902 1 0.000254 1560.000000 0.002988 0.000808 0.002141 -12903 1 0.000202 1560.000000 0.000073 -0.003731 0.004131 -12904 1 0.000273 1560.000000 -0.002314 0.000793 0.006918 -12905 1 0.000278 1560.000000 -0.001838 0.001914 0.003775 -12906 1 0.000239 1560.000000 0.000413 0.002046 0.002173 -12907 1 0.000224 1560.000000 -0.001706 0.001547 0.000723 -12908 1 0.000255 1560.000000 0.001287 -0.001471 0.008350 -12909 1 0.000242 1560.000000 -0.001107 -0.002690 0.005867 -12910 1 0.000282 1560.000000 -0.002676 0.002577 0.000627 -12911 1 0.000256 1560.000000 0.001236 0.001458 0.003327 -12912 1 0.000208 1560.000000 0.001939 0.001311 0.005648 -12913 1 0.000192 1560.000000 -0.001179 -0.003407 0.005095 -12914 1 0.000210 1560.000000 0.000403 -0.001708 0.006139 -12915 1 0.000250 1560.000000 0.001446 0.000639 0.003273 -12916 1 0.000268 1560.000000 -0.003510 0.001306 0.008628 -12917 1 0.000250 1560.000000 -0.000080 -0.002416 0.006411 -12918 1 0.000204 1560.000000 -0.000281 -0.000516 0.006738 -12919 1 0.000258 1560.000000 0.002907 0.002441 0.002049 -12920 1 0.000284 1560.000000 -0.001390 -0.002972 0.005137 -12921 1 0.000250 1560.000000 0.001818 -0.001676 0.003770 -12922 1 0.000195 1560.000000 0.000666 -0.002387 0.003561 -12923 1 0.000213 1560.000000 -0.000728 -0.000800 0.008907 -12924 1 0.000195 1560.000000 0.003220 0.000428 0.003167 -12925 1 0.000207 1560.000000 -0.001207 -0.003029 0.000444 -12926 1 0.000207 1560.000000 0.001583 0.002018 0.003920 -12927 1 0.000210 1560.000000 0.002454 0.001148 0.004181 -12928 1 0.000258 1560.000000 0.000472 0.001759 0.003784 -12929 1 0.000223 1560.000000 -0.000170 -0.003565 0.003861 -12930 1 0.000221 1560.000000 0.002254 0.002631 0.009018 -12931 1 0.000203 1560.000000 -0.001806 0.001234 0.002073 -12932 1 0.000217 1560.000000 0.000458 -0.001133 0.000140 -12933 1 0.000200 1560.000000 0.000676 -0.003787 0.000455 -12934 1 0.000205 1560.000000 -0.002459 0.000941 0.001734 -12935 1 0.000218 1560.000000 -0.001234 -0.002794 0.003905 -12936 1 0.000255 1560.000000 -0.000971 -0.002506 0.007383 -12937 1 0.000267 1560.000000 0.001694 -0.001706 0.005953 -12938 1 0.000195 1560.000000 -0.002545 0.001694 0.004512 -12939 1 0.000213 1560.000000 -0.002840 -0.001953 0.006359 -12940 1 0.000235 1560.000000 0.001045 -0.002492 0.005939 -12941 1 0.000262 1560.000000 -0.000001 -0.002169 0.003591 -12942 1 0.000198 1560.000000 0.002847 -0.000516 0.008844 -12943 1 0.000261 1560.000000 -0.001866 0.000627 0.006586 -12944 1 0.000267 1560.000000 0.001232 -0.000522 0.000232 -12945 1 0.000204 1560.000000 0.001124 -0.002163 0.006866 -12946 1 0.000199 1560.000000 0.002558 0.000677 0.008801 -12947 1 0.000220 1560.000000 0.000189 0.002587 0.001079 -12948 1 0.000192 1560.000000 -0.002382 0.001252 0.007058 -12949 1 0.000234 1560.000000 0.003325 0.000329 0.001589 -12950 1 0.000265 1560.000000 0.000801 -0.002117 0.004001 -12951 1 0.000243 1560.000000 -0.000457 -0.001718 0.009047 -12952 1 0.000279 1560.000000 -0.000472 0.003470 0.008408 -12953 1 0.000239 1560.000000 0.001550 -0.000506 0.006720 -12954 1 0.000256 1560.000000 0.001988 -0.003098 0.007045 -12955 1 0.000201 1560.000000 0.002388 0.000389 0.003419 -12956 1 0.000194 1560.000000 0.001251 0.000139 0.002837 -12957 1 0.000229 1560.000000 0.001377 -0.003302 0.002032 -12958 1 0.000281 1560.000000 0.000288 -0.003377 0.006227 -12959 1 0.000193 1560.000000 -0.000051 0.001465 0.006822 -12960 1 0.000223 1560.000000 -0.002842 0.000698 0.003703 -12961 1 0.000256 1560.000000 -0.000785 0.003729 0.004127 -12962 1 0.000219 1560.000000 0.003071 -0.000087 0.006972 -12963 1 0.000253 1560.000000 0.001213 -0.002474 0.000942 -12964 1 0.000280 1560.000000 0.001467 0.000483 0.000457 -12965 1 0.000212 1560.000000 -0.000816 -0.001572 0.005158 -12966 1 0.000211 1560.000000 -0.000599 -0.001540 0.006490 -12967 1 0.000201 1560.000000 0.000858 0.002055 0.005203 -12968 1 0.000249 1560.000000 -0.001885 0.001317 0.009141 -12969 1 0.000239 1560.000000 0.000751 -0.000799 0.004831 -12970 1 0.000261 1560.000000 -0.003664 0.000350 0.006445 -12971 1 0.000261 1560.000000 0.000394 -0.003819 0.003317 -12972 1 0.000230 1560.000000 -0.003041 -0.000654 0.006957 -12973 1 0.000194 1560.000000 -0.001517 -0.002087 0.009416 -12974 1 0.000274 1560.000000 -0.001150 0.001082 0.002227 -12975 1 0.000262 1560.000000 -0.003765 -0.000649 0.002508 -12976 1 0.000271 1560.000000 0.002137 0.002397 0.007277 -12977 1 0.000217 1560.000000 -0.002522 -0.001712 0.003368 -12978 1 0.000239 1560.000000 -0.000572 -0.002417 0.006571 -12979 1 0.000224 1560.000000 -0.000116 -0.003825 0.003446 -12980 1 0.000233 1560.000000 -0.001666 -0.002623 0.000405 -12981 1 0.000199 1560.000000 -0.003719 -0.000421 0.005395 -12982 1 0.000231 1560.000000 -0.002169 0.002067 0.005502 -12983 1 0.000248 1560.000000 0.000095 0.002814 0.009080 -12984 1 0.000224 1560.000000 0.003733 0.000225 0.005272 -12985 1 0.000225 1560.000000 -0.000053 0.003599 0.003529 -12986 1 0.000236 1560.000000 -0.000167 0.002155 0.004225 -12987 1 0.000200 1560.000000 0.001358 -0.002577 0.000517 -12988 1 0.000278 1560.000000 -0.000354 0.002586 0.009840 -12989 1 0.000258 1560.000000 0.001776 -0.000530 0.002068 -12990 1 0.000263 1560.000000 0.001065 0.001071 0.004618 -12991 1 0.000223 1560.000000 0.000951 -0.001983 0.002650 -12992 1 0.000211 1560.000000 0.001269 0.003404 0.009395 -12993 1 0.000255 1560.000000 -0.001095 0.002448 0.006923 -12994 1 0.000212 1560.000000 -0.000288 -0.001827 0.005812 -12995 1 0.000278 1560.000000 0.002551 -0.002851 0.008351 -12996 1 0.000194 1560.000000 0.000811 -0.003245 0.000642 -12997 1 0.000250 1560.000000 0.000822 0.003599 0.001028 -12998 1 0.000200 1560.000000 0.003549 -0.000730 0.004945 -12999 1 0.000241 1560.000000 -0.003731 0.000087 0.006465 -13000 1 0.000193 1560.000000 0.000059 0.000502 0.000766 -13001 1 0.000246 1560.000000 -0.002955 0.000335 0.008500 -13002 1 0.000206 1560.000000 0.000941 0.000840 0.006970 -13003 1 0.000264 1560.000000 0.003449 -0.001640 0.008333 -13004 1 0.000200 1560.000000 -0.001745 -0.000372 0.000737 -13005 1 0.000226 1560.000000 -0.002174 -0.003136 0.006332 -13006 1 0.000207 1560.000000 0.000045 -0.000535 0.008329 -13007 1 0.000212 1560.000000 0.000533 0.000747 0.001108 -13008 1 0.000204 1560.000000 -0.000124 -0.000249 0.008787 -13009 1 0.000231 1560.000000 -0.001958 -0.002468 0.008254 -13010 1 0.000193 1560.000000 0.001611 -0.001360 0.002852 -13011 1 0.000274 1560.000000 0.002279 -0.001674 0.006792 -13012 1 0.000274 1560.000000 -0.003212 0.000987 0.004142 -13013 1 0.000257 1560.000000 0.003696 0.000663 0.004349 -13014 1 0.000206 1560.000000 0.000523 0.001811 0.003054 -13015 1 0.000237 1560.000000 -0.000837 -0.001661 0.008700 -13016 1 0.000278 1560.000000 0.001233 -0.003145 0.008907 -13017 1 0.000198 1560.000000 -0.000650 0.003614 0.003923 -13018 1 0.000253 1560.000000 -0.002230 0.002616 0.006523 -13019 1 0.000204 1560.000000 -0.000447 -0.000423 0.006831 -13020 1 0.000225 1560.000000 -0.002577 0.001719 0.000221 -13021 1 0.000260 1560.000000 0.000202 -0.003005 0.009512 -13022 1 0.000274 1560.000000 0.003513 -0.000862 0.003068 -13023 1 0.000266 1560.000000 0.003205 -0.000523 0.007175 -13024 1 0.000202 1560.000000 -0.003660 0.000182 0.008690 -13025 1 0.000195 1560.000000 -0.002229 0.000451 0.003680 -13026 1 0.000216 1560.000000 -0.001975 -0.000060 0.002106 -13027 1 0.000227 1560.000000 0.003289 0.001612 0.007045 -13028 1 0.000200 1560.000000 0.001068 -0.002900 0.003204 -13029 1 0.000267 1560.000000 -0.000203 0.003766 0.002472 -13030 1 0.000260 1560.000000 0.001493 0.002888 0.006944 -13031 1 0.000235 1560.000000 0.000604 0.002887 0.005778 -13032 1 0.000204 1560.000000 0.001163 -0.001362 0.005088 -13033 1 0.000202 1560.000000 -0.001999 0.002966 0.002343 -13034 1 0.000203 1560.000000 0.000979 -0.002310 0.007665 -13035 1 0.000268 1560.000000 0.002941 0.001465 0.002653 -13036 1 0.000238 1560.000000 0.000433 0.003192 0.009046 -13037 1 0.000225 1560.000000 -0.001059 -0.003610 0.005669 -13038 1 0.000254 1560.000000 0.001411 0.003132 0.000142 -13039 1 0.000254 1560.000000 0.001793 0.002844 0.008170 -13040 1 0.000212 1560.000000 -0.000970 -0.001232 0.002799 -13041 1 0.000193 1560.000000 -0.001909 0.002407 0.006398 -13042 1 0.000271 1560.000000 0.000636 0.000112 0.008326 -13043 1 0.000233 1560.000000 -0.000879 -0.003341 0.004126 -13044 1 0.000266 1560.000000 -0.002626 0.002477 0.006674 -13045 1 0.000204 1560.000000 0.001985 0.002782 0.009781 -13046 1 0.000206 1560.000000 0.001818 -0.002645 0.006200 -13047 1 0.000268 1560.000000 0.000169 0.001003 0.009818 -13048 1 0.000266 1560.000000 0.001657 0.003444 0.006645 -13049 1 0.000248 1560.000000 0.002256 0.001682 0.006321 -13050 1 0.000199 1560.000000 -0.000295 0.002106 0.002272 -13051 1 0.000208 1560.000000 -0.001200 -0.001709 0.007653 -13052 1 0.000217 1560.000000 0.002102 -0.002772 0.000421 -13053 1 0.000251 1560.000000 -0.002664 0.002619 0.006013 -13054 1 0.000237 1560.000000 -0.000862 -0.000162 0.008189 -13055 1 0.000225 1560.000000 -0.002038 0.002313 0.001070 -13056 1 0.000248 1560.000000 -0.003443 0.001459 0.006102 -13057 1 0.000203 1560.000000 0.000366 0.003380 0.005107 -13058 1 0.000222 1560.000000 -0.002011 0.001007 0.005942 -13059 1 0.000211 1560.000000 -0.003456 -0.000995 0.009507 -13060 1 0.000205 1560.000000 0.002735 0.000804 0.003023 -13061 1 0.000279 1560.000000 0.002191 0.000012 0.006210 -13062 1 0.000201 1560.000000 -0.000513 -0.000543 0.001561 -13063 1 0.000273 1560.000000 0.001812 -0.002296 0.005145 -13064 1 0.000216 1560.000000 0.001034 -0.001588 0.007849 -13065 1 0.000279 1560.000000 0.001089 0.001954 0.009488 -13066 1 0.000254 1560.000000 -0.000011 0.001954 0.008468 -13067 1 0.000215 1560.000000 0.001201 0.000390 0.004739 -13068 1 0.000276 1560.000000 -0.003093 0.001407 0.005162 -13069 1 0.000200 1560.000000 -0.000216 0.003761 0.003829 -13070 1 0.000220 1560.000000 0.002168 -0.000052 0.009815 -13071 1 0.000222 1560.000000 0.001801 -0.001171 0.005404 -13072 1 0.000273 1560.000000 0.001840 0.002632 0.009366 -13073 1 0.000202 1560.000000 -0.000447 0.000397 0.005271 -13074 1 0.000228 1560.000000 -0.001131 -0.000911 0.001445 -13075 1 0.000202 1560.000000 0.000912 -0.000530 0.003573 -13076 1 0.000235 1560.000000 -0.000926 -0.003652 0.001741 -13077 1 0.000227 1560.000000 0.003509 -0.001564 0.002734 -13078 1 0.000194 1560.000000 -0.000747 -0.003710 0.004178 -13079 1 0.000231 1560.000000 -0.001520 0.001020 0.003069 -13080 1 0.000224 1560.000000 0.003804 0.000421 0.001990 -13081 1 0.000229 1560.000000 -0.001494 0.002195 0.008221 -13082 1 0.000198 1560.000000 -0.001192 -0.003218 0.001764 -13083 1 0.000248 1560.000000 0.000269 -0.001481 0.002561 -13084 1 0.000205 1560.000000 -0.001961 -0.002104 0.000420 -13085 1 0.000255 1560.000000 -0.003208 0.000479 0.003781 -13086 1 0.000256 1560.000000 -0.001570 -0.000822 0.003982 -13087 1 0.000222 1560.000000 -0.001926 -0.001357 0.007203 -13088 1 0.000203 1560.000000 0.001173 -0.000307 0.006803 -13089 1 0.000234 1560.000000 -0.000049 0.001339 0.007095 -13090 1 0.000242 1560.000000 0.001372 -0.001181 0.001921 -13091 1 0.000196 1560.000000 -0.001068 -0.000634 0.004321 -13092 1 0.000252 1560.000000 -0.001540 -0.000270 0.001068 -13093 1 0.000198 1560.000000 0.002417 0.000577 0.004586 -13094 1 0.000194 1560.000000 0.000938 -0.000582 0.006057 -13095 1 0.000210 1560.000000 -0.000734 -0.001679 0.006636 -13096 1 0.000206 1560.000000 0.001719 0.001909 0.003553 -13097 1 0.000285 1560.000000 -0.002675 0.000319 0.001442 -13098 1 0.000239 1560.000000 -0.000429 0.003314 0.002378 -13099 1 0.000222 1560.000000 0.002781 0.000239 0.008434 -13100 1 0.000206 1560.000000 -0.003070 -0.001954 0.001412 -13101 1 0.000218 1560.000000 -0.000776 -0.000959 0.006041 -13102 1 0.000208 1560.000000 0.003649 -0.000784 0.006867 -13103 1 0.000211 1560.000000 0.000313 0.001145 0.005464 -13104 1 0.000200 1560.000000 0.001527 -0.001674 0.001602 -13105 1 0.000212 1560.000000 0.000634 0.002884 0.008841 -13106 1 0.000206 1560.000000 0.000098 0.001594 0.000171 -13107 1 0.000196 1560.000000 -0.000943 0.003515 0.009254 -13108 1 0.000218 1560.000000 -0.002843 0.002523 0.002014 -13109 1 0.000252 1560.000000 -0.003503 -0.001542 0.008148 -13110 1 0.000199 1560.000000 -0.003746 0.000012 0.004170 -13111 1 0.000211 1560.000000 0.000709 0.002262 0.008361 -13112 1 0.000254 1560.000000 0.000961 -0.000388 0.009461 -13113 1 0.000281 1560.000000 -0.001614 0.000515 0.008807 -13114 1 0.000280 1560.000000 0.001531 -0.003241 0.003017 -13115 1 0.000207 1560.000000 0.003385 0.000704 0.000155 -13116 1 0.000214 1560.000000 0.000765 0.001667 0.001857 -13117 1 0.000210 1560.000000 0.001218 -0.002040 0.005500 -13118 1 0.000216 1560.000000 0.002554 -0.000506 0.007033 -13119 1 0.000193 1560.000000 -0.001769 0.002827 0.003190 -13120 1 0.000274 1560.000000 0.001846 0.003338 0.002963 -13121 1 0.000261 1560.000000 -0.002780 0.000458 0.002958 -13122 1 0.000271 1560.000000 0.002079 -0.001685 0.004840 -13123 1 0.000264 1560.000000 0.003722 0.000897 0.008802 -13124 1 0.000279 1560.000000 0.001705 0.002485 0.006860 -13125 1 0.000266 1560.000000 -0.002292 -0.001721 0.003944 -13126 1 0.000245 1560.000000 0.001114 0.002194 0.001308 -13127 1 0.000209 1560.000000 -0.000964 -0.001312 0.007723 -13128 1 0.000271 1560.000000 0.002654 -0.000743 0.008827 -13129 1 0.000245 1560.000000 0.001403 0.001980 0.008366 -13130 1 0.000210 1560.000000 0.002195 -0.000320 0.005014 -13131 1 0.000274 1560.000000 -0.000860 -0.003402 0.008207 -13132 1 0.000205 1560.000000 -0.002695 -0.002729 0.002741 -13133 1 0.000214 1560.000000 -0.001697 -0.002511 0.007322 -13134 1 0.000206 1560.000000 -0.001580 -0.002672 0.004276 -13135 1 0.000219 1560.000000 0.001155 0.002300 0.007341 -13136 1 0.000227 1560.000000 -0.003333 -0.000670 0.001269 -13137 1 0.000247 1560.000000 0.001314 0.000280 0.008541 -13138 1 0.000203 1560.000000 0.001765 -0.000965 0.008945 -13139 1 0.000260 1560.000000 0.001914 -0.003112 0.003768 -13140 1 0.000221 1560.000000 -0.002075 -0.001223 0.000138 -13141 1 0.000215 1560.000000 -0.001140 0.000371 0.002995 -13142 1 0.000284 1560.000000 0.002132 -0.000353 0.004325 -13143 1 0.000205 1560.000000 0.001595 0.000962 0.005993 -13144 1 0.000234 1560.000000 0.000228 -0.000486 0.002337 -13145 1 0.000257 1560.000000 0.002599 0.001698 0.008723 -13146 1 0.000273 1560.000000 0.001633 0.002071 0.004875 -13147 1 0.000223 1560.000000 0.001568 -0.000740 0.002395 -13148 1 0.000200 1560.000000 -0.002395 -0.000836 0.007665 -13149 1 0.000220 1560.000000 -0.000814 0.003031 0.008478 -13150 1 0.000193 1560.000000 -0.003753 -0.000802 0.000606 -13151 1 0.000266 1560.000000 0.002226 -0.000078 0.001723 -13152 1 0.000239 1560.000000 0.001362 0.003098 0.000643 -13153 1 0.000249 1560.000000 -0.000204 0.001130 0.000135 -13154 1 0.000233 1560.000000 0.002097 0.002545 0.004689 -13155 1 0.000242 1560.000000 -0.000380 -0.003812 0.002210 -13156 1 0.000212 1560.000000 0.001835 -0.002522 0.005742 -13157 1 0.000208 1560.000000 -0.001155 -0.002801 0.003143 -13158 1 0.000269 1560.000000 0.001787 0.000219 0.005810 -13159 1 0.000247 1560.000000 -0.002391 0.002523 0.004190 -13160 1 0.000279 1560.000000 0.000423 0.003714 0.009232 -13161 1 0.000216 1560.000000 -0.000280 0.001750 0.000209 -13162 1 0.000206 1560.000000 -0.003535 -0.001197 0.007744 -13163 1 0.000200 1560.000000 0.003233 0.000792 0.001070 -13164 1 0.000212 1560.000000 0.001857 0.001966 0.005341 -13165 1 0.000248 1560.000000 0.003013 0.001019 0.007636 -13166 1 0.000209 1560.000000 -0.001535 -0.001652 0.005519 -13167 1 0.000213 1560.000000 -0.000103 -0.002962 0.004176 -13168 1 0.000195 1560.000000 0.002431 0.000605 0.005109 -13169 1 0.000241 1560.000000 0.001636 0.001657 0.006332 -13170 1 0.000234 1560.000000 -0.002647 0.002743 0.007639 -13171 1 0.000220 1560.000000 -0.000126 0.000743 0.002269 -13172 1 0.000205 1560.000000 0.000191 -0.002948 0.006603 -13173 1 0.000277 1560.000000 0.002665 0.001614 0.001122 -13174 1 0.000248 1560.000000 -0.000904 -0.001274 0.003227 -13175 1 0.000201 1560.000000 0.002874 0.000399 0.000387 -13176 1 0.000202 1560.000000 0.002421 0.000860 0.009732 -13177 1 0.000212 1560.000000 0.003026 0.000534 0.007604 -13178 1 0.000231 1560.000000 -0.002507 -0.002354 0.006779 -13179 1 0.000227 1560.000000 0.001618 -0.000454 0.001474 -13180 1 0.000201 1560.000000 -0.001692 0.001691 0.008961 -13181 1 0.000217 1560.000000 0.001921 -0.000714 0.001791 -13182 1 0.000207 1560.000000 -0.002033 0.002996 0.003700 -13183 1 0.000219 1560.000000 0.002459 -0.000134 0.007237 -13184 1 0.000200 1560.000000 -0.001827 0.001974 0.006451 -13185 1 0.000216 1560.000000 0.001500 0.002188 0.004126 -13186 1 0.000230 1560.000000 0.000642 -0.001071 0.009150 -13187 1 0.000218 1560.000000 -0.001502 0.002135 0.006998 -13188 1 0.000247 1560.000000 0.001284 0.000432 0.006090 -13189 1 0.000216 1560.000000 0.002473 -0.000987 0.006284 -13190 1 0.000202 1560.000000 -0.000931 -0.002301 0.001859 -13191 1 0.000210 1560.000000 -0.003723 0.000112 0.005391 -13192 1 0.000268 1560.000000 -0.000621 0.001933 0.003774 -13193 1 0.000196 1560.000000 -0.002495 -0.001740 0.001742 -13194 1 0.000267 1560.000000 0.001265 0.000474 0.007213 -13195 1 0.000276 1560.000000 -0.002993 -0.000965 0.008525 -13196 1 0.000250 1560.000000 0.002632 0.001509 0.002756 -13197 1 0.000278 1560.000000 0.002611 -0.000970 0.006065 -13198 1 0.000223 1560.000000 -0.001905 -0.001016 0.003336 -13199 1 0.000224 1560.000000 -0.003115 0.000286 0.005808 -13200 1 0.000221 1560.000000 -0.001228 0.002503 0.000661 -13201 1 0.000198 1560.000000 0.002582 0.002735 0.009367 -13202 1 0.000283 1560.000000 -0.000935 -0.001471 0.008440 -13203 1 0.000252 1560.000000 -0.003027 0.002011 0.009605 -13204 1 0.000229 1560.000000 -0.002041 0.002043 0.000225 -13205 1 0.000216 1560.000000 0.001308 0.003136 0.005957 -13206 1 0.000226 1560.000000 -0.000341 0.000920 0.004702 -13207 1 0.000232 1560.000000 0.002773 0.000803 0.000690 -13208 1 0.000216 1560.000000 -0.000746 -0.002943 0.002902 -13209 1 0.000237 1560.000000 -0.002755 -0.001257 0.006553 -13210 1 0.000196 1560.000000 0.003431 0.000698 0.009680 -13211 1 0.000215 1560.000000 0.003019 -0.002309 0.003730 -13212 1 0.000278 1560.000000 0.001424 0.000081 0.002316 -13213 1 0.000194 1560.000000 0.003446 0.000279 0.003878 -13214 1 0.000222 1560.000000 -0.000530 0.000006 0.007471 -13215 1 0.000229 1560.000000 -0.000949 0.003670 0.006828 -13216 1 0.000230 1560.000000 0.001355 -0.003571 0.001972 -13217 1 0.000243 1560.000000 -0.003461 -0.000122 0.004736 -13218 1 0.000232 1560.000000 -0.003405 0.000568 0.009130 -13219 1 0.000251 1560.000000 0.003313 -0.001324 0.006352 -13220 1 0.000261 1560.000000 0.000418 0.001737 0.001655 -13221 1 0.000193 1560.000000 -0.000099 -0.001358 0.008273 -13222 1 0.000224 1560.000000 -0.000775 0.001334 0.005301 -13223 1 0.000209 1560.000000 0.000404 0.000697 0.003613 -13224 1 0.000219 1560.000000 -0.002235 -0.000709 0.002610 -13225 1 0.000193 1560.000000 -0.000720 -0.001824 0.002361 -13226 1 0.000202 1560.000000 0.000186 0.002572 0.005921 -13227 1 0.000261 1560.000000 -0.002691 0.001471 0.008566 -13228 1 0.000203 1560.000000 -0.000546 0.003175 0.008741 -13229 1 0.000214 1560.000000 0.000067 0.002805 0.004018 -13230 1 0.000261 1560.000000 -0.001425 -0.002367 0.001822 -13231 1 0.000218 1560.000000 -0.001285 -0.001968 0.006070 -13232 1 0.000208 1560.000000 0.001456 0.003039 0.000355 -13233 1 0.000196 1560.000000 0.000054 -0.002552 0.001524 -13234 1 0.000258 1560.000000 -0.000438 0.002720 0.002630 -13235 1 0.000201 1560.000000 -0.000738 -0.000772 0.004182 -13236 1 0.000244 1560.000000 0.003338 -0.001917 0.005386 -13237 1 0.000231 1560.000000 0.001604 0.000119 0.003856 -13238 1 0.000243 1560.000000 -0.003736 -0.000852 0.006357 -13239 1 0.000280 1560.000000 0.002930 0.001664 0.006526 -13240 1 0.000242 1560.000000 0.000956 0.000611 0.000592 -13241 1 0.000223 1560.000000 0.001395 0.000029 0.001060 -13242 1 0.000193 1560.000000 -0.000576 -0.000836 0.001294 -13243 1 0.000261 1560.000000 0.003600 -0.001230 0.001095 -13244 1 0.000251 1560.000000 -0.000051 -0.002233 0.007584 -13245 1 0.000237 1560.000000 0.001374 -0.000207 0.007915 -13246 1 0.000219 1560.000000 -0.001943 0.001928 0.003132 -13247 1 0.000243 1560.000000 -0.000432 0.001180 0.006195 -13248 1 0.000279 1560.000000 -0.002085 -0.001982 0.002599 -13249 1 0.000286 1560.000000 0.002823 0.001607 0.009853 -13250 1 0.000258 1560.000000 -0.000609 -0.003094 0.002385 -13251 1 0.000219 1560.000000 -0.000467 -0.003569 0.006929 -13252 1 0.000272 1560.000000 -0.002213 -0.002126 0.005256 -13253 1 0.000261 1560.000000 -0.001156 -0.000528 0.008977 -13254 1 0.000227 1560.000000 0.001705 -0.001816 0.002428 -13255 1 0.000242 1560.000000 -0.002139 0.002669 0.001783 -13256 1 0.000218 1560.000000 -0.000653 -0.002512 0.008500 -13257 1 0.000197 1560.000000 0.000579 -0.002241 0.000850 -13258 1 0.000263 1560.000000 -0.002401 0.002967 0.005180 -13259 1 0.000228 1560.000000 0.000288 -0.002987 0.009250 -13260 1 0.000286 1560.000000 0.001687 -0.003373 0.006016 -13261 1 0.000265 1560.000000 -0.003447 0.001594 0.004854 -13262 1 0.000210 1560.000000 -0.002252 -0.000657 0.001126 -13263 1 0.000246 1560.000000 0.002973 -0.001656 0.000375 -13264 1 0.000214 1560.000000 0.001234 -0.002871 0.001408 -13265 1 0.000237 1560.000000 -0.001732 -0.002584 0.006679 -13266 1 0.000237 1560.000000 0.001247 0.001890 0.008861 -13267 1 0.000271 1560.000000 0.002868 0.001515 0.004252 -13268 1 0.000232 1560.000000 0.000223 0.000238 0.002341 -13269 1 0.000193 1560.000000 0.000752 -0.000156 0.004458 -13270 1 0.000274 1560.000000 -0.003755 -0.000842 0.005342 -13271 1 0.000247 1560.000000 -0.002821 0.000272 0.008209 -13272 1 0.000203 1560.000000 0.001001 0.002703 0.009562 -13273 1 0.000275 1560.000000 -0.000356 0.000896 0.007772 -13274 1 0.000227 1560.000000 0.002017 -0.002992 0.005630 -13275 1 0.000265 1560.000000 0.002563 -0.000274 0.007587 -13276 1 0.000201 1560.000000 0.001926 -0.001545 0.008206 -13277 1 0.000200 1560.000000 -0.000915 0.001276 0.005905 -13278 1 0.000198 1560.000000 -0.000038 -0.003085 0.006676 -13279 1 0.000210 1560.000000 -0.002900 -0.002254 0.005184 -13280 1 0.000202 1560.000000 -0.002149 0.002914 0.009333 -13281 1 0.000274 1560.000000 0.000767 0.002610 0.004732 -13282 1 0.000220 1560.000000 -0.003069 0.002250 0.006963 -13283 1 0.000227 1560.000000 0.003165 0.001806 0.001993 -13284 1 0.000221 1560.000000 -0.001508 0.002939 0.009411 -13285 1 0.000271 1560.000000 0.000978 0.002372 0.008598 -13286 1 0.000241 1560.000000 -0.000057 0.002958 0.003885 -13287 1 0.000246 1560.000000 -0.003603 -0.000110 0.007672 -13288 1 0.000194 1560.000000 0.000010 0.003803 0.004863 -13289 1 0.000232 1560.000000 0.002260 -0.001266 0.001446 -13290 1 0.000228 1560.000000 -0.001426 0.000445 0.004874 -13291 1 0.000235 1560.000000 -0.000498 0.000961 0.001841 -13292 1 0.000209 1560.000000 0.002473 -0.001868 0.004054 -13293 1 0.000259 1560.000000 -0.001050 -0.002702 0.009290 -13294 1 0.000286 1560.000000 -0.000140 0.002165 0.006515 -13295 1 0.000195 1560.000000 -0.001181 -0.002629 0.007262 -13296 1 0.000271 1560.000000 0.000139 0.002961 0.004418 -13297 1 0.000199 1560.000000 -0.003075 -0.000572 0.009204 -13298 1 0.000232 1560.000000 0.000609 0.002836 0.009685 -13299 1 0.000242 1560.000000 -0.003307 -0.001188 0.001462 -13300 1 0.000233 1560.000000 -0.002688 0.001437 0.003820 -13301 1 0.000210 1560.000000 -0.001516 -0.002683 0.008579 -13302 1 0.000194 1560.000000 0.001430 0.000626 0.005468 -13303 1 0.000280 1560.000000 -0.000034 -0.003153 0.008393 -13304 1 0.000207 1560.000000 0.002805 -0.001761 0.007904 -13305 1 0.000207 1560.000000 0.003044 -0.000616 0.007650 -13306 1 0.000248 1560.000000 0.000270 -0.002589 0.000253 -13307 1 0.000205 1560.000000 0.001944 -0.000725 0.000948 -13308 1 0.000204 1560.000000 -0.001253 0.002832 0.003570 -13309 1 0.000195 1560.000000 0.000003 0.002454 0.009687 -13310 1 0.000211 1560.000000 0.001789 0.003349 0.005603 -13311 1 0.000237 1560.000000 0.002873 0.001996 0.004801 -13312 1 0.000269 1560.000000 -0.002458 -0.002069 0.000607 -13313 1 0.000279 1560.000000 0.001271 -0.001488 0.007745 -13314 1 0.000265 1560.000000 -0.003515 -0.001488 0.006251 -13315 1 0.000218 1560.000000 -0.001975 -0.001503 0.004245 -13316 1 0.000204 1560.000000 0.001136 0.001114 0.003482 -13317 1 0.000286 1560.000000 -0.002937 0.000440 0.009024 -13318 1 0.000266 1560.000000 -0.001332 0.001144 0.008717 -13319 1 0.000280 1560.000000 0.001118 -0.000958 0.004979 -13320 1 0.000195 1560.000000 -0.003190 -0.001903 0.000132 -13321 1 0.000221 1560.000000 0.000458 -0.003382 0.005907 -13322 1 0.000203 1560.000000 -0.002549 0.001759 0.009809 -13323 1 0.000225 1560.000000 -0.001890 0.001701 0.005692 -13324 1 0.000241 1560.000000 -0.001576 0.000350 0.002250 -13325 1 0.000222 1560.000000 0.002398 -0.002606 0.003194 -13326 1 0.000259 1560.000000 0.002321 0.000900 0.005895 -13327 1 0.000215 1560.000000 0.001573 0.001241 0.000389 -13328 1 0.000212 1560.000000 0.001968 -0.002478 0.001884 -13329 1 0.000239 1560.000000 0.002593 -0.000548 0.000258 -13330 1 0.000221 1560.000000 0.000926 -0.001380 0.005959 -13331 1 0.000260 1560.000000 -0.002118 0.001072 0.004547 -13332 1 0.000272 1560.000000 -0.001058 -0.002497 0.009083 -13333 1 0.000285 1560.000000 0.002351 -0.002091 0.006552 -13334 1 0.000227 1560.000000 0.000415 0.001184 0.001760 -13335 1 0.000257 1560.000000 -0.001717 -0.003006 0.000565 -13336 1 0.000228 1560.000000 -0.003154 0.000246 0.001035 -13337 1 0.000223 1560.000000 0.000209 -0.001435 0.009658 -13338 1 0.000254 1560.000000 -0.002901 -0.001064 0.006349 -13339 1 0.000201 1560.000000 -0.001652 -0.000580 0.004341 -13340 1 0.000218 1560.000000 -0.000927 -0.000543 0.009540 -13341 1 0.000287 1560.000000 -0.002988 0.000859 0.003459 -13342 1 0.000237 1560.000000 -0.002213 -0.001022 0.002279 -13343 1 0.000286 1560.000000 0.000581 -0.001669 0.008841 -13344 1 0.000206 1560.000000 0.003028 -0.001703 0.006859 -13345 1 0.000252 1560.000000 -0.003082 -0.000692 0.006302 -13346 1 0.000203 1560.000000 0.002711 0.001530 0.009410 -13347 1 0.000192 1560.000000 0.001362 0.001851 0.009079 -13348 1 0.000199 1560.000000 0.003197 -0.001531 0.007878 -13349 1 0.000253 1560.000000 -0.002366 0.001894 0.001903 -13350 1 0.000206 1560.000000 -0.000633 0.002771 0.006445 -13351 1 0.000195 1560.000000 0.000643 0.001697 0.008429 -13352 1 0.000211 1560.000000 0.001603 -0.001063 0.002084 -13353 1 0.000202 1560.000000 -0.001008 0.001266 0.008833 -13354 1 0.000212 1560.000000 0.000753 -0.001238 0.007953 -13355 1 0.000248 1560.000000 -0.001643 0.000134 0.002848 -13356 1 0.000224 1560.000000 0.001560 -0.002365 0.008466 -13357 1 0.000222 1560.000000 0.000460 -0.003631 0.009489 -13358 1 0.000223 1560.000000 -0.000662 -0.003784 0.006472 -13359 1 0.000274 1560.000000 -0.000518 -0.002380 0.000237 -13360 1 0.000245 1560.000000 -0.003277 -0.001575 0.003863 -13361 1 0.000202 1560.000000 -0.000755 -0.002157 0.009785 -13362 1 0.000203 1560.000000 0.001679 0.002896 0.001750 -13363 1 0.000200 1560.000000 -0.000546 0.001214 0.007445 -13364 1 0.000226 1560.000000 -0.000629 0.001161 0.007732 -13365 1 0.000207 1560.000000 -0.001009 0.001169 0.002641 -13366 1 0.000205 1560.000000 0.001337 -0.000679 0.005376 -13367 1 0.000234 1560.000000 -0.000459 -0.001078 0.003109 -13368 1 0.000199 1560.000000 -0.001996 0.002533 0.000202 -13369 1 0.000283 1560.000000 -0.003346 -0.001597 0.009200 -13370 1 0.000214 1560.000000 0.002259 0.001213 0.006708 -13371 1 0.000215 1560.000000 -0.000081 0.002120 0.001201 -13372 1 0.000283 1560.000000 0.003819 0.000518 0.001215 -13373 1 0.000228 1560.000000 0.001305 -0.000852 0.001560 -13374 1 0.000262 1560.000000 0.003737 -0.000424 0.003473 -13375 1 0.000268 1560.000000 0.002479 -0.002893 0.005556 -13376 1 0.000202 1560.000000 -0.000777 0.003706 0.007354 -13377 1 0.000257 1560.000000 -0.003081 -0.002052 0.007058 -13378 1 0.000246 1560.000000 0.001299 -0.000717 0.002853 -13379 1 0.000278 1560.000000 0.003086 -0.000916 0.003479 -13380 1 0.000251 1560.000000 0.001298 0.000957 0.000816 -13381 1 0.000242 1560.000000 -0.002781 0.001190 0.001748 -13382 1 0.000225 1560.000000 0.000318 -0.002767 0.006550 -13383 1 0.000206 1560.000000 -0.000841 0.003174 0.008836 -13384 1 0.000210 1560.000000 0.000303 0.001177 0.004015 -13385 1 0.000196 1560.000000 -0.002272 0.000214 0.000947 -13386 1 0.000239 1560.000000 0.001053 -0.000088 0.008796 -13387 1 0.000232 1560.000000 -0.003707 -0.000406 0.008606 -13388 1 0.000226 1560.000000 0.001036 -0.001020 0.000907 -13389 1 0.000197 1560.000000 0.000690 0.003410 0.001819 -13390 1 0.000263 1560.000000 -0.002886 -0.001786 0.000137 -13391 1 0.000210 1560.000000 -0.001558 -0.001472 0.001828 -13392 1 0.000210 1560.000000 0.001955 0.002832 0.007510 -13393 1 0.000194 1560.000000 0.003771 -0.000568 0.004121 -13394 1 0.000199 1560.000000 0.003192 0.001758 0.008448 -13395 1 0.000245 1560.000000 -0.000518 0.003055 0.002913 -13396 1 0.000260 1560.000000 -0.001099 -0.003255 0.003085 -13397 1 0.000272 1560.000000 0.003762 -0.000690 0.002953 -13398 1 0.000210 1560.000000 -0.002854 -0.002329 0.008044 -13399 1 0.000215 1560.000000 -0.001338 -0.000046 0.008232 -13400 1 0.000204 1560.000000 0.000745 -0.002533 0.001354 -13401 1 0.000219 1560.000000 0.003283 0.000089 0.006845 -13402 1 0.000255 1560.000000 -0.002366 0.002477 0.009785 -13403 1 0.000280 1560.000000 -0.000713 0.000101 0.007103 -13404 1 0.000212 1560.000000 -0.003062 0.001452 0.008186 -13405 1 0.000231 1560.000000 -0.001852 -0.000134 0.003601 -13406 1 0.000210 1560.000000 0.002483 -0.000962 0.008043 -13407 1 0.000235 1560.000000 -0.000184 0.000751 0.006264 -13408 1 0.000216 1560.000000 0.000176 0.000561 0.009535 -13409 1 0.000213 1560.000000 -0.001554 0.002919 0.003651 -13410 1 0.000286 1560.000000 0.001371 0.000949 0.007113 -13411 1 0.000227 1560.000000 0.000084 -0.003768 0.007863 -13412 1 0.000231 1560.000000 -0.002569 -0.000592 0.007006 -13413 1 0.000248 1560.000000 0.003773 0.000731 0.001928 -13414 1 0.000206 1560.000000 -0.003365 -0.000028 0.005581 -13415 1 0.000252 1560.000000 -0.000768 0.001424 0.007314 -13416 1 0.000276 1560.000000 -0.002570 0.000797 0.003280 -13417 1 0.000214 1560.000000 -0.000925 -0.001313 0.003747 -13418 1 0.000216 1560.000000 0.001277 -0.003581 0.001620 -13419 1 0.000267 1560.000000 -0.000608 -0.002370 0.005368 -13420 1 0.000207 1560.000000 -0.001798 0.002037 0.002807 -13421 1 0.000222 1560.000000 -0.003214 -0.000001 0.007951 -13422 1 0.000257 1560.000000 0.003574 -0.000320 0.004009 -13423 1 0.000243 1560.000000 -0.002129 -0.001283 0.004445 -13424 1 0.000281 1560.000000 -0.001295 -0.001505 0.009844 -13425 1 0.000276 1560.000000 0.001055 0.000162 0.003764 -13426 1 0.000271 1560.000000 -0.002750 0.000311 0.005875 -13427 1 0.000252 1560.000000 -0.001151 0.001789 0.007368 -13428 1 0.000275 1560.000000 -0.003232 0.001806 0.001705 -13429 1 0.000233 1560.000000 0.000521 -0.000991 0.005251 -13430 1 0.000232 1560.000000 0.001827 -0.000972 0.008648 -13431 1 0.000238 1560.000000 -0.002801 0.000489 0.008023 -13432 1 0.000224 1560.000000 -0.000934 0.001378 0.007498 -13433 1 0.000196 1560.000000 0.000610 0.000554 0.002893 -13434 1 0.000233 1560.000000 -0.001099 0.001380 0.003373 -13435 1 0.000236 1560.000000 0.000724 -0.003596 0.009403 -13436 1 0.000193 1560.000000 0.000734 0.002507 0.008649 -13437 1 0.000272 1560.000000 -0.003043 -0.001157 0.002103 -13438 1 0.000195 1560.000000 -0.003599 0.000680 0.004095 -13439 1 0.000281 1560.000000 -0.001287 0.003084 0.003242 -13440 1 0.000211 1560.000000 -0.000574 -0.000579 0.005158 -13441 1 0.000227 1560.000000 0.002426 0.000176 0.003123 -13442 1 0.000227 1560.000000 -0.003169 0.001022 0.000397 -13443 1 0.000255 1560.000000 0.002294 -0.000556 0.003628 -13444 1 0.000256 1560.000000 0.002184 0.002647 0.005438 -13445 1 0.000221 1560.000000 -0.001282 -0.002788 0.001140 -13446 1 0.000226 1560.000000 0.001161 -0.000624 0.007620 -13447 1 0.000212 1560.000000 -0.000383 0.001869 0.005594 -13448 1 0.000200 1560.000000 0.000219 0.003258 0.002972 -13449 1 0.000214 1560.000000 -0.003029 0.001364 0.009733 -13450 1 0.000239 1560.000000 0.003423 -0.000864 0.006274 -13451 1 0.000285 1560.000000 0.002799 -0.000108 0.009232 -13452 1 0.000279 1560.000000 -0.002932 -0.002178 0.009784 -13453 1 0.000261 1560.000000 -0.002249 -0.000437 0.001932 -13454 1 0.000239 1560.000000 0.001465 0.002436 0.004931 -13455 1 0.000250 1560.000000 -0.001635 0.001022 0.008171 -13456 1 0.000239 1560.000000 0.001481 0.000758 0.006925 -13457 1 0.000204 1560.000000 -0.001583 -0.000834 0.009236 -13458 1 0.000253 1560.000000 -0.002417 -0.001189 0.008584 -13459 1 0.000277 1560.000000 -0.002287 0.000390 0.002748 -13460 1 0.000259 1560.000000 0.002015 -0.000978 0.003025 -13461 1 0.000258 1560.000000 -0.001598 0.002978 0.009659 -13462 1 0.000228 1560.000000 -0.003718 0.000510 0.004311 -13463 1 0.000242 1560.000000 0.002625 0.002502 0.008241 -13464 1 0.000262 1560.000000 -0.000319 -0.001957 0.004435 -13465 1 0.000261 1560.000000 -0.003461 0.000361 0.002081 -13466 1 0.000255 1560.000000 0.002627 -0.001600 0.006280 -13467 1 0.000207 1560.000000 0.001234 0.000628 0.000253 -13468 1 0.000275 1560.000000 -0.001762 0.003334 0.001244 -13469 1 0.000252 1560.000000 0.003518 -0.001494 0.001520 -13470 1 0.000239 1560.000000 0.002574 0.002303 0.002331 -13471 1 0.000203 1560.000000 -0.000125 0.002222 0.005070 -13472 1 0.000200 1560.000000 0.001122 -0.000157 0.000601 -13473 1 0.000203 1560.000000 -0.000688 -0.000941 0.005371 -13474 1 0.000211 1560.000000 -0.001921 0.003336 0.000530 -13475 1 0.000216 1560.000000 -0.001462 -0.001194 0.007921 -13476 1 0.000227 1560.000000 -0.001037 -0.003188 0.003586 -13477 1 0.000220 1560.000000 0.000545 0.001419 0.002244 -13478 1 0.000282 1560.000000 -0.000973 0.001966 0.002130 -13479 1 0.000198 1560.000000 0.003463 0.000422 0.009794 -13480 1 0.000255 1560.000000 0.000232 0.002401 0.000797 -13481 1 0.000249 1560.000000 0.000657 -0.003625 0.008181 -13482 1 0.000229 1560.000000 0.001862 -0.000305 0.006555 -13483 1 0.000193 1560.000000 0.002959 0.001199 0.006884 -13484 1 0.000240 1560.000000 -0.001373 0.000878 0.007664 -13485 1 0.000252 1560.000000 0.001337 -0.000050 0.007333 -13486 1 0.000218 1560.000000 0.002856 0.002515 0.007608 -13487 1 0.000207 1560.000000 -0.001700 0.001301 0.007760 -13488 1 0.000229 1560.000000 0.000103 -0.002902 0.000455 -13489 1 0.000247 1560.000000 -0.002147 0.001962 0.004852 -13490 1 0.000227 1560.000000 0.001389 -0.000607 0.001574 -13491 1 0.000211 1560.000000 0.001144 0.001108 0.009784 -13492 1 0.000208 1560.000000 -0.003040 0.001763 0.008479 -13493 1 0.000231 1560.000000 0.002515 -0.000623 0.005879 -13494 1 0.000208 1560.000000 -0.001630 0.000740 0.005074 -13495 1 0.000242 1560.000000 -0.000299 -0.000135 0.003080 -13496 1 0.000211 1560.000000 0.001352 0.001435 0.002152 -13497 1 0.000217 1560.000000 -0.002882 0.000145 0.007064 -13498 1 0.000230 1560.000000 -0.000654 -0.001150 0.004724 -13499 1 0.000198 1560.000000 -0.001960 -0.000216 0.004791 -13500 1 0.000228 1560.000000 0.003341 0.001027 0.002085 -13501 1 0.000217 1560.000000 -0.000230 0.001712 0.004070 -13502 1 0.000217 1560.000000 -0.000835 -0.002635 0.004227 -13503 1 0.000211 1560.000000 -0.003356 -0.000037 0.008154 -13504 1 0.000199 1560.000000 -0.000636 -0.003344 0.002086 -13505 1 0.000230 1560.000000 -0.000098 0.000751 0.003260 -13506 1 0.000218 1560.000000 0.002836 -0.002608 0.009630 -13507 1 0.000273 1560.000000 -0.003063 0.000007 0.008229 -13508 1 0.000195 1560.000000 0.002365 -0.000088 0.003156 -13509 1 0.000196 1560.000000 0.002595 -0.002706 0.000181 -13510 1 0.000236 1560.000000 -0.000812 -0.000927 0.002060 -13511 1 0.000196 1560.000000 -0.002031 -0.000360 0.003308 -13512 1 0.000209 1560.000000 0.002390 0.002140 0.008548 -13513 1 0.000193 1560.000000 -0.002301 -0.003091 0.005338 -13514 1 0.000226 1560.000000 0.001061 -0.002160 0.002315 -13515 1 0.000230 1560.000000 -0.000339 0.002459 0.004306 -13516 1 0.000219 1560.000000 -0.001198 0.003254 0.006726 -13517 1 0.000194 1560.000000 0.000380 -0.002237 0.002511 -13518 1 0.000218 1560.000000 0.000933 0.001680 0.008127 -13519 1 0.000273 1560.000000 -0.003639 -0.000443 0.006605 -13520 1 0.000194 1560.000000 -0.001035 0.000875 0.006080 -13521 1 0.000202 1560.000000 -0.000170 -0.002192 0.009230 -13522 1 0.000224 1560.000000 0.002070 0.000092 0.000337 -13523 1 0.000274 1560.000000 0.000928 -0.001423 0.002990 -13524 1 0.000248 1560.000000 -0.002882 0.002044 0.002098 -13525 1 0.000253 1560.000000 -0.000411 0.003031 0.000840 -13526 1 0.000204 1560.000000 0.001923 0.001755 0.005223 -13527 1 0.000275 1560.000000 -0.003051 -0.002171 0.001210 -13528 1 0.000193 1560.000000 0.002277 -0.002362 0.002088 -13529 1 0.000281 1560.000000 -0.003817 0.000347 0.004057 -13530 1 0.000288 1560.000000 -0.002469 0.002542 0.000238 -13531 1 0.000205 1560.000000 -0.002269 0.003054 0.001096 -13532 1 0.000193 1560.000000 -0.002834 0.001618 0.005717 -13533 1 0.000241 1560.000000 -0.001210 0.002115 0.009105 -13534 1 0.000211 1560.000000 0.000011 0.003261 0.003347 -13535 1 0.000218 1560.000000 0.001654 0.001234 0.005722 -13536 1 0.000265 1560.000000 0.002215 -0.002312 0.002459 -13537 1 0.000246 1560.000000 -0.000920 0.003239 0.001131 -13538 1 0.000202 1560.000000 -0.002457 0.001994 0.005388 -13539 1 0.000217 1560.000000 0.001590 0.001554 0.004887 -13540 1 0.000195 1560.000000 0.002505 0.002611 0.001015 -13541 1 0.000194 1560.000000 -0.002541 0.001284 0.004707 -13542 1 0.000198 1560.000000 0.001705 0.000543 0.004003 -13543 1 0.000265 1560.000000 0.000077 -0.001132 0.002482 -13544 1 0.000207 1560.000000 -0.000709 0.002326 0.007881 -13545 1 0.000193 1560.000000 -0.001547 0.001761 0.005130 -13546 1 0.000269 1560.000000 -0.003668 -0.001003 0.004500 -13547 1 0.000240 1560.000000 -0.001131 0.003197 0.005080 -13548 1 0.000201 1560.000000 0.002617 -0.002663 0.004248 -13549 1 0.000273 1560.000000 0.002671 0.000589 0.003236 -13550 1 0.000259 1560.000000 -0.001917 0.000908 0.009169 -13551 1 0.000221 1560.000000 0.000824 0.001406 0.005660 -13552 1 0.000235 1560.000000 -0.000572 -0.001207 0.007871 -13553 1 0.000197 1560.000000 0.001156 -0.001175 0.002731 -13554 1 0.000260 1560.000000 0.002159 -0.001225 0.003028 -13555 1 0.000246 1560.000000 0.003620 -0.000428 0.006535 -13556 1 0.000226 1560.000000 -0.000319 -0.001706 0.007184 -13557 1 0.000214 1560.000000 -0.000104 0.003851 0.005294 -13558 1 0.000215 1560.000000 -0.001745 0.000616 0.007323 -13559 1 0.000246 1560.000000 0.002910 -0.001294 0.000501 -13560 1 0.000227 1560.000000 0.001332 -0.001574 0.002653 -13561 1 0.000264 1560.000000 -0.001438 -0.002460 0.002564 -13562 1 0.000198 1560.000000 -0.002533 -0.001345 0.004754 -13563 1 0.000221 1560.000000 -0.001893 0.002951 0.009542 -13564 1 0.000263 1560.000000 0.001515 -0.002215 0.004352 -13565 1 0.000193 1560.000000 0.003447 0.001483 0.007865 -13566 1 0.000262 1560.000000 0.002135 -0.002951 0.004460 -13567 1 0.000224 1560.000000 -0.001573 0.002607 0.005456 -13568 1 0.000235 1560.000000 0.000046 0.001165 0.005306 -13569 1 0.000262 1560.000000 -0.002731 0.001030 0.008157 -13570 1 0.000212 1560.000000 -0.002898 -0.002294 0.000483 -13571 1 0.000260 1560.000000 -0.002593 0.000965 0.007047 -13572 1 0.000215 1560.000000 -0.002362 -0.001077 0.006557 -13573 1 0.000247 1560.000000 0.001898 -0.001367 0.006607 -13574 1 0.000206 1560.000000 -0.000182 0.002947 0.004439 -13575 1 0.000199 1560.000000 0.002633 -0.000556 0.009034 -13576 1 0.000218 1560.000000 -0.000445 0.003263 0.003404 -13577 1 0.000218 1560.000000 -0.001585 0.003405 0.007493 -13578 1 0.000276 1560.000000 0.001061 0.001427 0.007480 -13579 1 0.000271 1560.000000 0.001015 0.003699 0.008582 -13580 1 0.000201 1560.000000 0.002109 0.002853 0.004647 -13581 1 0.000277 1560.000000 -0.001757 -0.003191 0.002660 -13582 1 0.000196 1560.000000 0.000695 0.003178 0.009474 -13583 1 0.000194 1560.000000 0.000913 -0.001773 0.006865 -13584 1 0.000283 1560.000000 -0.002453 0.000634 0.003753 -13585 1 0.000232 1560.000000 -0.002388 -0.003010 0.006634 -13586 1 0.000209 1560.000000 0.002254 0.001647 0.007896 -13587 1 0.000263 1560.000000 -0.000946 0.001664 0.008433 -13588 1 0.000227 1560.000000 -0.000048 -0.003551 0.009585 -13589 1 0.000220 1560.000000 -0.000377 0.002374 0.007320 -13590 1 0.000236 1560.000000 0.002352 0.000804 0.001132 -13591 1 0.000247 1560.000000 0.001743 0.003309 0.000804 -13592 1 0.000271 1560.000000 -0.001321 0.003208 0.007070 -13593 1 0.000272 1560.000000 -0.002720 -0.001891 0.008005 -13594 1 0.000201 1560.000000 -0.001381 0.000225 0.006850 -13595 1 0.000248 1560.000000 -0.003428 -0.001752 0.007704 -13596 1 0.000226 1560.000000 0.003576 0.000511 0.006817 -13597 1 0.000234 1560.000000 0.000424 0.002350 0.008262 -13598 1 0.000236 1560.000000 0.000160 0.001092 0.007408 -13599 1 0.000243 1560.000000 -0.001184 0.002530 0.000165 -13600 1 0.000285 1560.000000 0.002692 -0.002190 0.005395 -13601 1 0.000259 1560.000000 0.003582 0.001241 0.005486 -13602 1 0.000197 1560.000000 -0.001640 -0.001961 0.002422 -13603 1 0.000252 1560.000000 0.002372 0.001300 0.009775 -13604 1 0.000249 1560.000000 -0.000572 0.003262 0.006637 -13605 1 0.000256 1560.000000 0.003811 -0.000515 0.004705 -13606 1 0.000235 1560.000000 -0.001290 -0.001974 0.006801 -13607 1 0.000221 1560.000000 0.000636 -0.000966 0.000232 -13608 1 0.000211 1560.000000 0.000301 0.003310 0.004201 -13609 1 0.000226 1560.000000 -0.001990 -0.001766 0.008099 -13610 1 0.000205 1560.000000 0.003074 -0.000010 0.006573 -13611 1 0.000237 1560.000000 0.001431 -0.001056 0.003184 -13612 1 0.000240 1560.000000 -0.001892 0.002283 0.006101 -13613 1 0.000219 1560.000000 -0.000483 -0.002018 0.000973 -13614 1 0.000202 1560.000000 0.001686 -0.000640 0.009041 -13615 1 0.000283 1560.000000 0.001165 -0.002256 0.005709 -13616 1 0.000216 1560.000000 -0.002062 -0.003248 0.004302 -13617 1 0.000206 1560.000000 -0.000188 -0.000910 0.009688 -13618 1 0.000208 1560.000000 -0.001668 0.000169 0.008981 -13619 1 0.000277 1560.000000 0.002916 0.000036 0.009839 -13620 1 0.000197 1560.000000 -0.000143 -0.000890 0.001668 -13621 1 0.000202 1560.000000 -0.002090 0.001824 0.001434 -13622 1 0.000242 1560.000000 0.000423 0.001127 0.006499 -13623 1 0.000247 1560.000000 0.002171 -0.000806 0.001692 -13624 1 0.000210 1560.000000 -0.001276 0.000673 0.006641 -13625 1 0.000273 1560.000000 0.000511 -0.003346 0.006669 -13626 1 0.000232 1560.000000 0.001140 0.002727 0.005243 -13627 1 0.000200 1560.000000 -0.001933 -0.001873 0.000372 -13628 1 0.000201 1560.000000 0.000335 -0.003822 0.008458 -13629 1 0.000199 1560.000000 -0.001136 0.003602 0.007275 -13630 1 0.000223 1560.000000 -0.001211 -0.002577 0.000678 -13631 1 0.000237 1560.000000 0.000098 -0.003148 0.000574 -13632 1 0.000198 1560.000000 -0.001137 0.000487 0.008338 -13633 1 0.000200 1560.000000 -0.001005 0.001447 0.006034 -13634 1 0.000216 1560.000000 0.002712 0.001992 0.006002 -13635 1 0.000271 1560.000000 -0.001931 0.002480 0.005038 -13636 1 0.000210 1560.000000 0.001874 0.003264 0.007512 -13637 1 0.000272 1560.000000 0.000392 0.002588 0.008777 -13638 1 0.000218 1560.000000 0.002408 -0.002973 0.001601 -13639 1 0.000208 1560.000000 0.001994 0.002776 0.007839 -13640 1 0.000208 1560.000000 -0.001116 0.001308 0.001845 -13641 1 0.000252 1560.000000 0.002700 -0.002702 0.003237 -13642 1 0.000220 1560.000000 0.002335 0.002911 0.005573 -13643 1 0.000220 1560.000000 -0.002487 0.000878 0.006517 -13644 1 0.000250 1560.000000 0.000730 0.001806 0.009492 -13645 1 0.000213 1560.000000 -0.000177 -0.003805 0.002925 -13646 1 0.000200 1560.000000 0.002173 -0.002043 0.003237 -13647 1 0.000230 1560.000000 -0.001264 -0.003589 0.004685 -13648 1 0.000264 1560.000000 0.003240 0.001946 0.000526 -13649 1 0.000216 1560.000000 -0.000318 -0.003382 0.009494 -13650 1 0.000276 1560.000000 -0.001540 0.000214 0.000178 -13651 1 0.000239 1560.000000 -0.002604 -0.001947 0.006389 -13652 1 0.000241 1560.000000 0.000498 0.001982 0.003947 -13653 1 0.000271 1560.000000 -0.003651 0.000766 0.008824 -13654 1 0.000267 1560.000000 0.001226 0.003417 0.004945 -13655 1 0.000216 1560.000000 0.001679 0.002286 0.005115 -13656 1 0.000193 1560.000000 0.000487 0.002048 0.000828 -13657 1 0.000278 1560.000000 0.001862 0.000122 0.001135 -13658 1 0.000234 1560.000000 0.001390 -0.003541 0.007211 -13659 1 0.000194 1560.000000 0.002071 -0.002464 0.007112 -13660 1 0.000228 1560.000000 0.002398 0.002189 0.009325 -13661 1 0.000211 1560.000000 -0.001997 0.000941 0.007196 -13662 1 0.000231 1560.000000 -0.000125 -0.000429 0.000754 -13663 1 0.000264 1560.000000 0.002027 0.001554 0.006279 -13664 1 0.000233 1560.000000 0.003388 -0.000483 0.000898 -13665 1 0.000250 1560.000000 0.003581 0.001357 0.001474 -13666 1 0.000193 1560.000000 -0.000681 0.002576 0.006827 -13667 1 0.000228 1560.000000 -0.000673 -0.002876 0.006208 -13668 1 0.000243 1560.000000 -0.000656 -0.000362 0.007786 -13669 1 0.000200 1560.000000 0.001220 0.000606 0.001297 -13670 1 0.000201 1560.000000 -0.002663 -0.000758 0.004440 -13671 1 0.000270 1560.000000 -0.003066 -0.000989 0.009306 -13672 1 0.000206 1560.000000 -0.002071 0.000711 0.000275 -13673 1 0.000215 1560.000000 -0.003834 0.000174 0.006268 -13674 1 0.000212 1560.000000 -0.002403 0.002434 0.005259 -13675 1 0.000233 1560.000000 -0.002262 -0.001616 0.000587 -13676 1 0.000212 1560.000000 -0.000825 -0.003396 0.000915 -13677 1 0.000238 1560.000000 0.000712 -0.003129 0.007692 -13678 1 0.000205 1560.000000 -0.003618 0.000603 0.000189 -13679 1 0.000196 1560.000000 -0.001738 -0.000890 0.002822 -13680 1 0.000214 1560.000000 -0.000195 0.003083 0.006386 -13681 1 0.000274 1560.000000 -0.001048 0.002489 0.006219 -13682 1 0.000278 1560.000000 -0.000892 0.000288 0.003655 -13683 1 0.000198 1560.000000 0.002364 0.000096 0.000439 -13684 1 0.000259 1560.000000 -0.002246 -0.001004 0.000730 -13685 1 0.000216 1560.000000 -0.000611 0.003538 0.007955 -13686 1 0.000203 1560.000000 0.000980 0.000764 0.002008 -13687 1 0.000280 1560.000000 -0.001021 0.001506 0.002822 -13688 1 0.000193 1560.000000 0.002589 -0.002246 0.002749 -13689 1 0.000244 1560.000000 0.000466 0.001086 0.009567 -13690 1 0.000227 1560.000000 -0.001753 0.000957 0.004110 -13691 1 0.000210 1560.000000 -0.002984 0.001681 0.003578 -13692 1 0.000259 1560.000000 -0.000621 -0.003148 0.006266 -13693 1 0.000240 1560.000000 0.000009 -0.001640 0.000265 -13694 1 0.000247 1560.000000 -0.001277 0.000722 0.000758 -13695 1 0.000277 1560.000000 -0.002247 -0.002444 0.009700 -13696 1 0.000244 1560.000000 -0.001334 -0.003381 0.006302 -13697 1 0.000251 1560.000000 0.000376 -0.001610 0.001510 -13698 1 0.000234 1560.000000 0.001912 0.000437 0.003847 -13699 1 0.000196 1560.000000 0.000893 0.002372 0.003027 -13700 1 0.000276 1560.000000 -0.001074 -0.002704 0.007053 -13701 1 0.000226 1560.000000 0.000557 -0.003406 0.000124 -13702 1 0.000252 1560.000000 0.001321 -0.003254 0.005148 -13703 1 0.000202 1560.000000 -0.002457 0.001810 0.006767 -13704 1 0.000244 1560.000000 0.002903 -0.001009 0.000208 -13705 1 0.000205 1560.000000 0.002901 0.001866 0.002175 -13706 1 0.000260 1560.000000 -0.000977 0.000654 0.009400 -13707 1 0.000271 1560.000000 -0.001052 -0.001204 0.004073 -13708 1 0.000196 1560.000000 0.002192 0.001617 0.002839 -13709 1 0.000249 1560.000000 0.003216 -0.000903 0.003141 -13710 1 0.000219 1560.000000 0.002276 -0.002390 0.006366 -13711 1 0.000276 1560.000000 -0.002833 0.001182 0.007308 -13712 1 0.000239 1560.000000 0.003612 0.000009 0.005010 -13713 1 0.000225 1560.000000 0.000261 -0.003617 0.007398 -13714 1 0.000235 1560.000000 0.002605 -0.001855 0.009047 -13715 1 0.000230 1560.000000 -0.001766 -0.000496 0.002071 -13716 1 0.000194 1560.000000 -0.000880 0.001343 0.008140 -13717 1 0.000228 1560.000000 0.002426 0.000163 0.002699 -13718 1 0.000243 1560.000000 -0.001894 -0.002542 0.008927 -13719 1 0.000197 1560.000000 -0.001798 0.002791 0.005739 -13720 1 0.000209 1560.000000 0.000510 0.003765 0.004886 -13721 1 0.000205 1560.000000 -0.000490 0.000936 0.001608 -13722 1 0.000227 1560.000000 -0.001482 -0.001329 0.002047 -13723 1 0.000226 1560.000000 0.000564 -0.001098 0.002662 -13724 1 0.000209 1560.000000 0.002088 -0.003163 0.008987 -13725 1 0.000197 1560.000000 0.000912 -0.002504 0.009682 -13726 1 0.000232 1560.000000 -0.003144 -0.000544 0.003958 -13727 1 0.000215 1560.000000 0.001482 0.000674 0.004882 -13728 1 0.000234 1560.000000 -0.001885 -0.001745 0.003415 -13729 1 0.000282 1560.000000 0.003537 0.001175 0.008497 -13730 1 0.000194 1560.000000 0.001758 -0.003322 0.002332 -13731 1 0.000236 1560.000000 0.003603 -0.000755 0.006494 -13732 1 0.000210 1560.000000 -0.002561 0.002834 0.003544 -13733 1 0.000199 1560.000000 0.001536 -0.003351 0.004909 -13734 1 0.000256 1560.000000 0.000526 0.002566 0.001433 -13735 1 0.000208 1560.000000 0.001790 -0.000834 0.003799 -13736 1 0.000224 1560.000000 0.002797 0.002490 0.008743 -13737 1 0.000239 1560.000000 0.001065 0.003420 0.002920 -13738 1 0.000259 1560.000000 0.000040 -0.003311 0.001993 -13739 1 0.000249 1560.000000 0.001793 -0.002986 0.001961 -13740 1 0.000224 1560.000000 -0.003538 0.000920 0.002931 -13741 1 0.000230 1560.000000 0.003403 -0.000441 0.001501 -13742 1 0.000203 1560.000000 -0.000452 0.002059 0.008683 -13743 1 0.000245 1560.000000 -0.003771 -0.000779 0.007692 -13744 1 0.000223 1560.000000 0.003810 0.000027 0.004707 -13745 1 0.000246 1560.000000 0.002171 0.003127 0.007189 -13746 1 0.000251 1560.000000 0.003674 -0.001118 0.000432 -13747 1 0.000193 1560.000000 0.000820 -0.003202 0.007045 -13748 1 0.000273 1560.000000 0.000435 0.001752 0.004251 -13749 1 0.000277 1560.000000 0.003578 -0.001299 0.006130 -13750 1 0.000209 1560.000000 0.000913 0.001715 0.003672 -13751 1 0.000241 1560.000000 0.001875 -0.000519 0.001139 -13752 1 0.000234 1560.000000 -0.002268 0.000451 0.000151 -13753 1 0.000243 1560.000000 0.000103 0.003727 0.002585 -13754 1 0.000229 1560.000000 0.000011 0.002849 0.007989 -13755 1 0.000203 1560.000000 0.000728 -0.003383 0.009779 -13756 1 0.000193 1560.000000 0.002656 0.002430 0.009522 -13757 1 0.000244 1560.000000 -0.003062 -0.000180 0.001926 -13758 1 0.000198 1560.000000 -0.000439 -0.001458 0.006739 -13759 1 0.000286 1560.000000 0.001816 -0.001587 0.005174 -13760 1 0.000223 1560.000000 -0.003259 -0.001863 0.007017 -13761 1 0.000205 1560.000000 -0.002007 -0.000622 0.006856 -13762 1 0.000243 1560.000000 -0.000310 -0.002752 0.005745 -13763 1 0.000225 1560.000000 -0.002083 0.003182 0.007398 -13764 1 0.000286 1560.000000 -0.003330 -0.001661 0.007285 -13765 1 0.000202 1560.000000 0.001638 -0.001283 0.007828 -13766 1 0.000281 1560.000000 -0.001723 0.003378 0.006373 -13767 1 0.000219 1560.000000 0.002182 -0.002406 0.009503 -13768 1 0.000256 1560.000000 0.001849 0.002771 0.008455 -13769 1 0.000199 1560.000000 -0.002705 -0.000810 0.004191 -13770 1 0.000200 1560.000000 0.001899 -0.000739 0.000137 -13771 1 0.000220 1560.000000 0.002370 0.003021 0.008379 -13772 1 0.000208 1560.000000 0.002921 0.000621 0.008009 -13773 1 0.000201 1560.000000 -0.003020 -0.001048 0.003759 -13774 1 0.000247 1560.000000 0.001915 -0.002809 0.001823 -13775 1 0.000194 1560.000000 -0.002099 -0.000857 0.000921 -13776 1 0.000204 1560.000000 0.002741 -0.001417 0.002202 -13777 1 0.000203 1560.000000 0.001299 -0.002085 0.003740 -13778 1 0.000210 1560.000000 0.002163 0.001324 0.005530 -13779 1 0.000246 1560.000000 -0.003139 0.002088 0.001904 -13780 1 0.000243 1560.000000 -0.003266 -0.001807 0.005293 -13781 1 0.000202 1560.000000 -0.002812 -0.000066 0.008954 -13782 1 0.000213 1560.000000 -0.002467 -0.002952 0.001450 -13783 1 0.000210 1560.000000 0.000222 -0.000071 0.005314 -13784 1 0.000213 1560.000000 0.002828 -0.001909 0.000188 -13785 1 0.000205 1560.000000 0.003799 -0.000340 0.006958 -13786 1 0.000232 1560.000000 0.000595 -0.003338 0.000733 -13787 1 0.000197 1560.000000 -0.003052 -0.000074 0.006458 -13788 1 0.000212 1560.000000 0.002158 0.001659 0.003588 -13789 1 0.000195 1560.000000 -0.000400 0.002301 0.004549 -13790 1 0.000269 1560.000000 0.000733 0.001744 0.000397 -13791 1 0.000245 1560.000000 0.000630 0.003693 0.000184 -13792 1 0.000250 1560.000000 -0.000074 -0.000585 0.004060 -13793 1 0.000242 1560.000000 0.001085 0.002595 0.009815 -13794 1 0.000256 1560.000000 0.001624 0.002783 0.002862 -13795 1 0.000262 1560.000000 -0.000458 -0.003801 0.001030 -13796 1 0.000208 1560.000000 -0.001367 -0.001207 0.004225 -13797 1 0.000254 1560.000000 -0.002560 -0.002095 0.005271 -13798 1 0.000193 1560.000000 -0.000264 -0.003552 0.004172 -13799 1 0.000278 1560.000000 0.000369 -0.003727 0.007692 -13800 1 0.000238 1560.000000 0.002771 0.000344 0.006574 -13801 1 0.000230 1560.000000 -0.002268 -0.002479 0.004531 -13802 1 0.000219 1560.000000 0.000053 0.001428 0.001553 -13803 1 0.000281 1560.000000 -0.002253 0.002475 0.005469 -13804 1 0.000205 1560.000000 0.001244 0.000329 0.002716 -13805 1 0.000212 1560.000000 -0.002574 0.000696 0.009789 -13806 1 0.000200 1560.000000 0.000334 0.000866 0.009620 -13807 1 0.000205 1560.000000 0.002914 -0.002049 0.005601 -13808 1 0.000196 1560.000000 -0.001262 -0.000557 0.001730 -13809 1 0.000271 1560.000000 -0.001811 0.002257 0.001986 -13810 1 0.000288 1560.000000 0.000194 0.002595 0.002159 -13811 1 0.000214 1560.000000 -0.001106 -0.001413 0.002212 -13812 1 0.000262 1560.000000 -0.001017 -0.003637 0.000702 -13813 1 0.000233 1560.000000 0.002758 0.002670 0.008111 -13814 1 0.000198 1560.000000 0.001404 0.002430 0.006158 -13815 1 0.000244 1560.000000 0.001910 -0.001154 0.003865 -13816 1 0.000245 1560.000000 0.000895 -0.003578 0.008490 -13817 1 0.000257 1560.000000 0.000086 0.003220 0.009443 -13818 1 0.000197 1560.000000 0.001965 0.002399 0.006769 -13819 1 0.000251 1560.000000 -0.000677 -0.003279 0.002925 -13820 1 0.000272 1560.000000 -0.000383 -0.002346 0.000981 -13821 1 0.000263 1560.000000 -0.001961 -0.000851 0.001193 -13822 1 0.000211 1560.000000 -0.000518 -0.001529 0.006294 -13823 1 0.000260 1560.000000 -0.000474 -0.003753 0.003462 -13824 1 0.000241 1560.000000 -0.000310 -0.002770 0.004700 -13825 1 0.000205 1560.000000 0.002161 0.000998 0.001550 -13826 1 0.000235 1560.000000 -0.003638 -0.000207 0.009827 -13827 1 0.000230 1560.000000 0.002420 -0.000795 0.002370 -13828 1 0.000211 1560.000000 -0.000923 0.002662 0.003891 -13829 1 0.000199 1560.000000 0.001170 -0.000117 0.007744 -13830 1 0.000232 1560.000000 -0.000002 0.001478 0.002283 -13831 1 0.000234 1560.000000 -0.000693 0.000918 0.009530 -13832 1 0.000220 1560.000000 0.001447 -0.000799 0.002173 -13833 1 0.000226 1560.000000 0.000321 0.003771 0.006098 -13834 1 0.000207 1560.000000 -0.002576 -0.002586 0.003650 -13835 1 0.000241 1560.000000 0.002200 -0.001776 0.002641 -13836 1 0.000212 1560.000000 0.000048 0.003839 0.007947 -13837 1 0.000256 1560.000000 -0.002053 -0.001306 0.002803 -13838 1 0.000217 1560.000000 -0.003175 -0.001446 0.007587 -13839 1 0.000201 1560.000000 0.002637 0.000692 0.009261 -13840 1 0.000215 1560.000000 -0.000578 -0.000059 0.008681 -13841 1 0.000213 1560.000000 -0.001986 -0.001790 0.002164 -13842 1 0.000210 1560.000000 -0.003307 0.000141 0.007093 -13843 1 0.000195 1560.000000 0.003220 0.000029 0.002150 -13844 1 0.000254 1560.000000 -0.000477 0.002403 0.009166 -13845 1 0.000249 1560.000000 -0.001630 0.000510 0.002590 -13846 1 0.000226 1560.000000 0.003072 0.000131 0.009271 -13847 1 0.000203 1560.000000 -0.003663 0.000604 0.009394 -13848 1 0.000230 1560.000000 0.001957 -0.000027 0.007958 -13849 1 0.000205 1560.000000 -0.001132 0.003620 0.009010 -13850 1 0.000227 1560.000000 0.000861 -0.001221 0.002849 -13851 1 0.000248 1560.000000 -0.001032 0.003530 0.003184 -13852 1 0.000211 1560.000000 -0.002704 -0.000095 0.000215 -13853 1 0.000207 1560.000000 0.002120 0.001718 0.001704 -13854 1 0.000207 1560.000000 -0.000332 -0.000165 0.004891 -13855 1 0.000231 1560.000000 0.002061 0.001150 0.002259 -13856 1 0.000265 1560.000000 -0.001035 0.003660 0.007887 -13857 1 0.000199 1560.000000 -0.002440 0.001772 0.006042 -13858 1 0.000272 1560.000000 -0.002386 0.000124 0.009560 -13859 1 0.000219 1560.000000 0.001990 0.003098 0.003831 -13860 1 0.000222 1560.000000 -0.003620 -0.000676 0.003815 -13861 1 0.000241 1560.000000 0.001665 0.002229 0.006739 -13862 1 0.000202 1560.000000 0.002634 -0.000108 0.006067 -13863 1 0.000287 1560.000000 0.000106 0.003839 0.003150 -13864 1 0.000222 1560.000000 -0.001141 0.000077 0.001200 -13865 1 0.000240 1560.000000 0.001733 -0.002242 0.005704 -13866 1 0.000204 1560.000000 0.000857 0.001771 0.006754 -13867 1 0.000212 1560.000000 -0.003736 -0.000814 0.005035 -13868 1 0.000275 1560.000000 0.002235 0.000719 0.004749 -13869 1 0.000211 1560.000000 0.001313 -0.000093 0.004298 -13870 1 0.000245 1560.000000 0.000660 -0.001215 0.005604 -13871 1 0.000246 1560.000000 -0.000385 -0.003598 0.006250 -13872 1 0.000215 1560.000000 0.002394 0.000548 0.008451 -13873 1 0.000233 1560.000000 -0.002430 -0.000450 0.000951 -13874 1 0.000217 1560.000000 0.000679 -0.001354 0.005795 -13875 1 0.000264 1560.000000 -0.001289 0.003081 0.003588 -13876 1 0.000197 1560.000000 0.000266 -0.003579 0.008454 -13877 1 0.000265 1560.000000 -0.002035 0.003192 0.004410 -13878 1 0.000227 1560.000000 0.001580 0.001988 0.005719 -13879 1 0.000258 1560.000000 0.003203 -0.001395 0.004235 -13880 1 0.000254 1560.000000 0.000846 -0.003388 0.001954 -13881 1 0.000223 1560.000000 -0.001936 0.000148 0.002737 -13882 1 0.000276 1560.000000 -0.001621 -0.002296 0.008520 -13883 1 0.000203 1560.000000 -0.002432 -0.001141 0.009105 -13884 1 0.000198 1560.000000 -0.001892 -0.002140 0.004546 -13885 1 0.000254 1560.000000 0.001766 -0.000768 0.006192 -13886 1 0.000196 1560.000000 -0.000734 -0.003154 0.008786 -13887 1 0.000235 1560.000000 0.002618 -0.001152 0.004318 -13888 1 0.000264 1560.000000 -0.000577 -0.000923 0.003643 -13889 1 0.000275 1560.000000 0.002220 -0.002998 0.005972 -13890 1 0.000261 1560.000000 0.002783 -0.000424 0.005821 -13891 1 0.000284 1560.000000 -0.001816 -0.000920 0.007455 -13892 1 0.000269 1560.000000 0.003329 0.000363 0.008053 -13893 1 0.000209 1560.000000 -0.000746 0.001848 0.003108 -13894 1 0.000246 1560.000000 0.002980 -0.000196 0.007264 -13895 1 0.000203 1560.000000 0.002713 0.002127 0.000414 -13896 1 0.000241 1560.000000 0.000298 0.001381 0.009819 -13897 1 0.000206 1560.000000 -0.002163 0.000624 0.006012 -13898 1 0.000254 1560.000000 -0.003514 -0.001378 0.000470 -13899 1 0.000200 1560.000000 0.000770 0.002833 0.001779 -13900 1 0.000246 1560.000000 -0.001631 0.000489 0.003173 -13901 1 0.000230 1560.000000 0.001185 0.001043 0.004864 -13902 1 0.000274 1560.000000 0.001602 0.001078 0.001473 -13903 1 0.000233 1560.000000 0.003784 -0.000574 0.000352 -13904 1 0.000267 1560.000000 0.000875 -0.003043 0.004071 -13905 1 0.000205 1560.000000 -0.000302 -0.002676 0.007649 -13906 1 0.000215 1560.000000 -0.000143 -0.003788 0.009393 -13907 1 0.000237 1560.000000 0.001990 0.001176 0.009057 -13908 1 0.000224 1560.000000 -0.002874 -0.001577 0.003629 -13909 1 0.000198 1560.000000 -0.000405 -0.001956 0.006668 -13910 1 0.000261 1560.000000 0.000260 0.001910 0.005077 -13911 1 0.000287 1560.000000 0.003075 0.002261 0.002981 -13912 1 0.000205 1560.000000 0.003205 -0.000629 0.009384 -13913 1 0.000253 1560.000000 -0.003596 -0.001270 0.008874 -13914 1 0.000253 1560.000000 0.001880 0.002436 0.001106 -13915 1 0.000234 1560.000000 -0.001584 -0.003386 0.008991 -13916 1 0.000226 1560.000000 0.001862 0.003285 0.009615 -13917 1 0.000192 1560.000000 0.001424 -0.001173 0.006419 -13918 1 0.000255 1560.000000 -0.003552 -0.000965 0.001443 -13919 1 0.000248 1560.000000 -0.002307 0.000924 0.006073 -13920 1 0.000257 1560.000000 0.001485 0.003484 0.004841 -13921 1 0.000224 1560.000000 -0.001408 -0.001789 0.003431 -13922 1 0.000231 1560.000000 -0.002056 -0.000536 0.009286 -13923 1 0.000230 1560.000000 -0.001376 -0.000533 0.005544 -13924 1 0.000210 1560.000000 0.002956 0.001047 0.009408 -13925 1 0.000243 1560.000000 0.002510 0.000238 0.003655 -13926 1 0.000200 1560.000000 -0.000396 0.001487 0.001283 -13927 1 0.000288 1560.000000 0.003459 -0.000099 0.003479 -13928 1 0.000248 1560.000000 -0.001627 -0.002225 0.005951 -13929 1 0.000263 1560.000000 0.001962 0.002298 0.007809 -13930 1 0.000241 1560.000000 -0.002843 -0.000355 0.005521 -13931 1 0.000234 1560.000000 -0.001508 0.001592 0.006920 -13932 1 0.000233 1560.000000 -0.000237 -0.003820 0.004919 -13933 1 0.000202 1560.000000 0.001069 -0.000206 0.005436 -13934 1 0.000203 1560.000000 -0.002052 0.000215 0.006548 -13935 1 0.000219 1560.000000 0.002446 0.000152 0.000821 -13936 1 0.000236 1560.000000 -0.000115 -0.002934 0.006868 -13937 1 0.000254 1560.000000 -0.000511 -0.000059 0.006818 -13938 1 0.000224 1560.000000 -0.001058 0.001527 0.001765 -13939 1 0.000204 1560.000000 0.000120 -0.002581 0.009131 -13940 1 0.000238 1560.000000 -0.001984 -0.000378 0.000131 -13941 1 0.000195 1560.000000 -0.001971 -0.002911 0.000549 -13942 1 0.000267 1560.000000 -0.002114 0.000114 0.009039 -13943 1 0.000279 1560.000000 -0.001242 -0.002818 0.008260 -13944 1 0.000203 1560.000000 -0.002908 0.000463 0.004822 -13945 1 0.000214 1560.000000 -0.003264 -0.001540 0.001543 -13946 1 0.000198 1560.000000 -0.002898 0.002049 0.008674 -13947 1 0.000262 1560.000000 0.000833 -0.003507 0.004209 -13948 1 0.000208 1560.000000 0.000689 -0.003680 0.005489 -13949 1 0.000231 1560.000000 0.001949 0.001993 0.006831 -13950 1 0.000275 1560.000000 -0.000098 -0.002555 0.000161 -13951 1 0.000243 1560.000000 -0.000883 -0.002388 0.002288 -13952 1 0.000258 1560.000000 -0.000036 -0.000419 0.002142 -13953 1 0.000276 1560.000000 0.002512 0.002632 0.009705 -13954 1 0.000225 1560.000000 0.000373 -0.000486 0.001159 -13955 1 0.000213 1560.000000 0.001173 -0.002288 0.006064 -13956 1 0.000227 1560.000000 -0.000638 0.002800 0.000224 -13957 1 0.000231 1560.000000 -0.003458 -0.000874 0.008715 -13958 1 0.000223 1560.000000 0.001021 0.003574 0.008223 -13959 1 0.000239 1560.000000 -0.000974 0.001040 0.005192 -13960 1 0.000243 1560.000000 -0.001946 0.002538 0.006960 -13961 1 0.000196 1560.000000 -0.002098 -0.000811 0.006403 -13962 1 0.000213 1560.000000 0.003415 -0.000473 0.008153 -13963 1 0.000215 1560.000000 0.002281 -0.002316 0.006835 -13964 1 0.000205 1560.000000 -0.000648 0.003527 0.009582 -13965 1 0.000208 1560.000000 -0.001213 -0.001555 0.003058 -13966 1 0.000229 1560.000000 -0.002653 -0.001724 0.003809 -13967 1 0.000252 1560.000000 0.000565 0.002555 0.005522 -13968 1 0.000216 1560.000000 -0.002013 0.002773 0.000612 -13969 1 0.000217 1560.000000 -0.000254 0.003504 0.002123 -13970 1 0.000267 1560.000000 0.000937 0.003721 0.007811 -13971 1 0.000267 1560.000000 -0.000798 -0.001586 0.008216 -13972 1 0.000249 1560.000000 -0.002693 -0.001069 0.006801 -13973 1 0.000230 1560.000000 -0.000500 0.003057 0.005604 -13974 1 0.000262 1560.000000 -0.001491 0.002245 0.009604 -13975 1 0.000254 1560.000000 0.002170 0.001286 0.002794 -13976 1 0.000223 1560.000000 0.001383 0.002701 0.005200 -13977 1 0.000249 1560.000000 -0.001430 -0.000966 0.005730 -13978 1 0.000239 1560.000000 0.002291 -0.002566 0.001887 -13979 1 0.000193 1560.000000 -0.000287 0.000071 0.004602 -13980 1 0.000248 1560.000000 0.000485 -0.001057 0.002393 -13981 1 0.000246 1560.000000 -0.001287 0.001655 0.001562 -13982 1 0.000198 1560.000000 -0.001590 0.002753 0.009340 -13983 1 0.000259 1560.000000 -0.001581 0.001404 0.008020 -13984 1 0.000283 1560.000000 -0.001815 -0.002716 0.007157 -13985 1 0.000198 1560.000000 0.003429 0.000828 0.007447 -13986 1 0.000260 1560.000000 0.002149 0.001491 0.000244 -13987 1 0.000236 1560.000000 0.002290 -0.001846 0.002375 -13988 1 0.000215 1560.000000 -0.002270 0.001692 0.005943 -13989 1 0.000254 1560.000000 -0.001225 -0.002553 0.002954 -13990 1 0.000248 1560.000000 -0.001374 -0.003494 0.007044 -13991 1 0.000238 1560.000000 0.003006 -0.001062 0.001178 -13992 1 0.000251 1560.000000 0.000058 0.001479 0.008017 -13993 1 0.000200 1560.000000 -0.002792 0.000288 0.002794 -13994 1 0.000263 1560.000000 -0.003356 0.000746 0.002928 -13995 1 0.000271 1560.000000 -0.000690 -0.000805 0.006403 -13996 1 0.000202 1560.000000 0.000941 0.001074 0.003010 -13997 1 0.000203 1560.000000 0.001417 0.000698 0.001801 -13998 1 0.000214 1560.000000 0.002019 0.002900 0.006081 -13999 1 0.000239 1560.000000 -0.000804 0.003221 0.007852 -14000 1 0.000209 1560.000000 0.001272 -0.000686 0.002596 -14001 1 0.000198 1560.000000 -0.003017 -0.000036 0.003173 -14002 1 0.000283 1560.000000 0.003631 0.000895 0.004564 -14003 1 0.000197 1560.000000 -0.003034 -0.001559 0.004918 -14004 1 0.000213 1560.000000 -0.001584 0.002001 0.004512 -14005 1 0.000231 1560.000000 0.003419 0.001584 0.001805 -14006 1 0.000212 1560.000000 0.003152 0.000151 0.001731 -14007 1 0.000243 1560.000000 -0.000063 0.003617 0.007811 -14008 1 0.000231 1560.000000 -0.000794 -0.002066 0.007742 -14009 1 0.000199 1560.000000 0.003699 -0.000631 0.000811 -14010 1 0.000254 1560.000000 0.000313 0.000234 0.004611 -14011 1 0.000206 1560.000000 -0.003074 0.002216 0.005580 -14012 1 0.000243 1560.000000 0.001531 -0.000816 0.002961 -14013 1 0.000209 1560.000000 0.001355 0.002376 0.004505 -14014 1 0.000200 1560.000000 -0.003508 0.001524 0.003261 -14015 1 0.000201 1560.000000 -0.001015 -0.002641 0.008098 -14016 1 0.000218 1560.000000 -0.001090 -0.002607 0.003887 -14017 1 0.000223 1560.000000 0.001378 0.003101 0.006908 -14018 1 0.000258 1560.000000 -0.002697 0.002368 0.004114 -14019 1 0.000238 1560.000000 -0.002966 -0.001881 0.009145 -14020 1 0.000265 1560.000000 0.003497 0.001528 0.003783 -14021 1 0.000199 1560.000000 0.001190 -0.002760 0.007638 -14022 1 0.000251 1560.000000 0.002654 0.001868 0.009830 -14023 1 0.000196 1560.000000 -0.001911 -0.000554 0.004702 -14024 1 0.000276 1560.000000 0.001955 -0.003175 0.000259 -14025 1 0.000212 1560.000000 0.001932 0.000366 0.008569 -14026 1 0.000243 1560.000000 -0.003065 -0.002189 0.004970 -14027 1 0.000270 1560.000000 -0.001044 -0.001605 0.008032 -14028 1 0.000215 1560.000000 0.002815 0.001609 0.007462 -14029 1 0.000240 1560.000000 0.002317 -0.000866 0.005021 -14030 1 0.000195 1560.000000 -0.000872 -0.002727 0.005660 -14031 1 0.000195 1560.000000 -0.001588 -0.002992 0.001684 -14032 1 0.000207 1560.000000 0.003407 -0.000355 0.007381 -14033 1 0.000202 1560.000000 -0.000762 -0.002098 0.008846 -14034 1 0.000288 1560.000000 0.001632 -0.003465 0.001781 -14035 1 0.000193 1560.000000 0.001970 -0.002767 0.004175 -14036 1 0.000227 1560.000000 -0.002695 0.002031 0.002590 -14037 1 0.000211 1560.000000 0.002979 -0.000907 0.001586 -14038 1 0.000248 1560.000000 -0.002627 0.001235 0.008904 -14039 1 0.000214 1560.000000 -0.001391 -0.001880 0.008049 -14040 1 0.000224 1560.000000 -0.000051 -0.002078 0.009488 -14041 1 0.000203 1560.000000 -0.002743 0.000478 0.009440 -14042 1 0.000194 1560.000000 -0.000054 -0.001999 0.001224 -14043 1 0.000204 1560.000000 0.000695 -0.000965 0.007889 -14044 1 0.000196 1560.000000 -0.003251 -0.001583 0.000107 -14045 1 0.000201 1560.000000 -0.002544 -0.002727 0.007689 -14046 1 0.000232 1560.000000 -0.001647 0.002229 0.007622 -14047 1 0.000230 1560.000000 0.000378 -0.001377 0.004252 -14048 1 0.000205 1560.000000 -0.002015 0.000474 0.006852 -14049 1 0.000235 1560.000000 -0.000837 0.003063 0.006063 -14050 1 0.000246 1560.000000 0.002439 -0.001164 0.009277 -14051 1 0.000206 1560.000000 0.002149 -0.002919 0.009672 -14052 1 0.000220 1560.000000 -0.000953 -0.003368 0.006660 -14053 1 0.000240 1560.000000 -0.003530 -0.000473 0.005137 -14054 1 0.000209 1560.000000 -0.002570 0.000782 0.001439 -14055 1 0.000236 1560.000000 0.000968 -0.003186 0.000838 -14056 1 0.000216 1560.000000 -0.002255 -0.001800 0.003283 -14057 1 0.000237 1560.000000 0.001047 0.001388 0.004258 -14058 1 0.000271 1560.000000 0.002435 -0.002339 0.003226 -14059 1 0.000244 1560.000000 0.002276 0.001969 0.009807 -14060 1 0.000227 1560.000000 -0.000562 -0.000629 0.009136 -14061 1 0.000220 1560.000000 -0.002495 0.000737 0.008648 -14062 1 0.000211 1560.000000 0.003434 0.000738 0.002491 -14063 1 0.000276 1560.000000 0.002762 -0.000006 0.004585 -14064 1 0.000264 1560.000000 -0.003591 0.000155 0.001847 -14065 1 0.000233 1560.000000 -0.003492 0.000091 0.003431 -14066 1 0.000192 1560.000000 0.003249 -0.001732 0.009628 -14067 1 0.000241 1560.000000 -0.000180 0.002757 0.002556 -14068 1 0.000243 1560.000000 0.000105 -0.002820 0.003698 -14069 1 0.000208 1560.000000 0.001803 -0.001580 0.006215 -14070 1 0.000203 1560.000000 -0.001045 -0.000279 0.006080 -14071 1 0.000198 1560.000000 0.001059 0.000118 0.003512 -14072 1 0.000195 1560.000000 -0.000130 0.002110 0.003242 -14073 1 0.000220 1560.000000 -0.001389 0.000549 0.000449 -14074 1 0.000254 1560.000000 -0.000032 -0.003325 0.008145 -14075 1 0.000285 1560.000000 0.001199 -0.001336 0.008977 -14076 1 0.000216 1560.000000 0.002942 0.002357 0.005748 -14077 1 0.000216 1560.000000 -0.002743 0.000349 0.000819 -14078 1 0.000234 1560.000000 -0.003479 -0.000195 0.002094 -14079 1 0.000265 1560.000000 0.002342 0.002440 0.006179 -14080 1 0.000246 1560.000000 -0.001868 0.000172 0.006183 -14081 1 0.000217 1560.000000 0.000201 -0.002881 0.007417 -14082 1 0.000193 1560.000000 -0.001023 0.000249 0.006606 -14083 1 0.000224 1560.000000 -0.001451 -0.002616 0.007256 -14084 1 0.000229 1560.000000 0.003182 0.002125 0.009789 -14085 1 0.000255 1560.000000 -0.002672 -0.002406 0.002641 -14086 1 0.000232 1560.000000 0.001875 -0.001674 0.004154 -14087 1 0.000238 1560.000000 0.000720 0.002902 0.004314 -14088 1 0.000248 1560.000000 0.001272 -0.001336 0.000978 -14089 1 0.000247 1560.000000 -0.002757 0.002095 0.008289 -14090 1 0.000209 1560.000000 0.002315 -0.002000 0.004322 -14091 1 0.000236 1560.000000 0.002408 -0.000634 0.005545 -14092 1 0.000234 1560.000000 0.003007 -0.002372 0.007692 -14093 1 0.000210 1560.000000 -0.003391 0.001026 0.008904 -14094 1 0.000209 1560.000000 0.000884 -0.003716 0.004656 -14095 1 0.000247 1560.000000 -0.002338 -0.001280 0.002434 -14096 1 0.000196 1560.000000 0.000936 0.001305 0.005452 -14097 1 0.000269 1560.000000 0.001477 0.003324 0.007362 -14098 1 0.000249 1560.000000 0.003774 -0.000716 0.001240 -14099 1 0.000196 1560.000000 -0.001258 0.001291 0.007465 -14100 1 0.000216 1560.000000 0.001574 0.000726 0.002691 -14101 1 0.000205 1560.000000 0.002777 0.002629 0.003611 -14102 1 0.000226 1560.000000 0.000512 -0.002397 0.006304 -14103 1 0.000218 1560.000000 0.000784 0.003278 0.008963 -14104 1 0.000259 1560.000000 0.000340 -0.000612 0.004430 -14105 1 0.000205 1560.000000 0.001613 0.001864 0.003727 -14106 1 0.000195 1560.000000 -0.002579 -0.000805 0.008135 -14107 1 0.000223 1560.000000 -0.000183 0.003817 0.006195 -14108 1 0.000255 1560.000000 0.000669 -0.002656 0.003233 -14109 1 0.000201 1560.000000 -0.002067 -0.000567 0.008636 -14110 1 0.000277 1560.000000 0.002396 -0.002911 0.000363 -14111 1 0.000228 1560.000000 -0.003428 0.001275 0.007086 -14112 1 0.000230 1560.000000 -0.000060 0.001932 0.001067 -14113 1 0.000254 1560.000000 -0.001398 0.001281 0.006734 -14114 1 0.000196 1560.000000 0.002935 -0.001860 0.003761 -14115 1 0.000267 1560.000000 0.001730 0.003200 0.007785 -14116 1 0.000193 1560.000000 -0.002444 -0.001485 0.003637 -14117 1 0.000288 1560.000000 -0.002951 0.000141 0.006300 -14118 1 0.000204 1560.000000 0.001375 0.001970 0.003081 -14119 1 0.000265 1560.000000 -0.000198 0.002031 0.009830 -14120 1 0.000236 1560.000000 -0.002960 0.001306 0.001627 -14121 1 0.000246 1560.000000 0.003392 -0.000328 0.004522 -14122 1 0.000255 1560.000000 0.000299 -0.002039 0.005453 -14123 1 0.000193 1560.000000 0.002012 0.002592 0.007325 -14124 1 0.000202 1560.000000 -0.001104 -0.003364 0.004121 -14125 1 0.000274 1560.000000 -0.002681 0.001413 0.003087 -14126 1 0.000269 1560.000000 0.002392 0.002606 0.001423 -14127 1 0.000256 1560.000000 -0.002539 0.001259 0.008088 -14128 1 0.000252 1560.000000 -0.000437 0.002088 0.001970 -14129 1 0.000231 1560.000000 -0.003355 0.000015 0.008628 -14130 1 0.000224 1560.000000 0.000558 0.002424 0.001691 -14131 1 0.000201 1560.000000 0.002667 -0.002496 0.003731 -14132 1 0.000214 1560.000000 -0.000822 0.002244 0.006390 -14133 1 0.000270 1560.000000 0.002962 0.000301 0.009551 -14134 1 0.000201 1560.000000 -0.000867 -0.003665 0.009293 -14135 1 0.000218 1560.000000 -0.002042 -0.003084 0.005108 -14136 1 0.000237 1560.000000 -0.001803 -0.002702 0.000660 -14137 1 0.000267 1560.000000 -0.003090 -0.001955 0.005721 -14138 1 0.000231 1560.000000 0.000790 0.002621 0.003399 -14139 1 0.000202 1560.000000 -0.000570 -0.002568 0.008848 -14140 1 0.000217 1560.000000 -0.003121 0.001193 0.006434 -14141 1 0.000201 1560.000000 0.002301 -0.000770 0.004010 -14142 1 0.000274 1560.000000 0.001709 0.003146 0.006696 -14143 1 0.000279 1560.000000 -0.001065 -0.003513 0.000146 -14144 1 0.000264 1560.000000 -0.002011 -0.000777 0.009813 -14145 1 0.000203 1560.000000 0.001376 0.002272 0.009681 -14146 1 0.000219 1560.000000 0.001758 -0.002367 0.006388 -14147 1 0.000275 1560.000000 0.000535 -0.002063 0.007346 -14148 1 0.000219 1560.000000 -0.002472 -0.000325 0.007625 -14149 1 0.000236 1560.000000 0.003762 -0.000170 0.005062 -14150 1 0.000209 1560.000000 -0.001474 0.001865 0.004009 -14151 1 0.000232 1560.000000 -0.001976 -0.002387 0.006687 -14152 1 0.000233 1560.000000 0.002318 0.000932 0.006238 -14153 1 0.000241 1560.000000 -0.000983 0.001558 0.004734 -14154 1 0.000274 1560.000000 0.000918 0.001920 0.002121 -14155 1 0.000195 1560.000000 0.000176 -0.003063 0.004278 -14156 1 0.000263 1560.000000 -0.000430 -0.003607 0.007287 -14157 1 0.000226 1560.000000 -0.000566 0.000247 0.009793 -14158 1 0.000236 1560.000000 -0.001926 -0.002805 0.009770 -14159 1 0.000266 1560.000000 0.001911 -0.001200 0.009587 -14160 1 0.000288 1560.000000 -0.002325 -0.001363 0.009367 -14161 1 0.000253 1560.000000 -0.002407 -0.000772 0.004986 -14162 1 0.000193 1560.000000 -0.002323 -0.000971 0.006325 -14163 1 0.000227 1560.000000 -0.001151 -0.003128 0.002404 -14164 1 0.000277 1560.000000 0.001555 -0.002699 0.008302 -14165 1 0.000246 1560.000000 0.002869 0.000970 0.001211 -14166 1 0.000194 1560.000000 0.000423 0.000751 0.004491 -14167 1 0.000266 1560.000000 0.002751 0.002643 0.005271 -14168 1 0.000229 1560.000000 -0.001664 -0.002733 0.009125 -14169 1 0.000255 1560.000000 0.000631 0.000747 0.007848 -14170 1 0.000195 1560.000000 0.001346 -0.002396 0.002447 -14171 1 0.000270 1560.000000 0.002782 0.000310 0.000594 -14172 1 0.000266 1560.000000 -0.000126 0.001649 0.005125 -14173 1 0.000236 1560.000000 0.000117 0.001940 0.001817 -14174 1 0.000216 1560.000000 0.000046 0.002043 0.009516 -14175 1 0.000200 1560.000000 -0.003375 0.001791 0.009046 -14176 1 0.000203 1560.000000 -0.001493 0.000551 0.005794 -14177 1 0.000235 1560.000000 -0.000468 -0.002309 0.005158 -14178 1 0.000227 1560.000000 -0.001200 -0.002427 0.008346 -14179 1 0.000195 1560.000000 -0.000822 -0.001842 0.001838 -14180 1 0.000253 1560.000000 0.002508 -0.001134 0.005546 -14181 1 0.000252 1560.000000 -0.000241 0.001749 0.007237 -14182 1 0.000214 1560.000000 -0.002352 0.001181 0.001090 -14183 1 0.000244 1560.000000 0.002187 -0.000348 0.009211 -14184 1 0.000231 1560.000000 0.000199 -0.002246 0.003174 -14185 1 0.000253 1560.000000 0.003605 0.001221 0.007798 -14186 1 0.000221 1560.000000 -0.002881 -0.001190 0.009042 -14187 1 0.000193 1560.000000 0.001232 0.002850 0.000147 -14188 1 0.000193 1560.000000 -0.000620 0.000953 0.002746 -14189 1 0.000249 1560.000000 0.000363 -0.000674 0.002408 -14190 1 0.000261 1560.000000 -0.001749 -0.000375 0.003338 -14191 1 0.000241 1560.000000 0.000831 0.000445 0.006404 -14192 1 0.000216 1560.000000 -0.000659 0.000530 0.003958 -14193 1 0.000232 1560.000000 -0.000792 -0.003599 0.003992 -14194 1 0.000231 1560.000000 -0.000723 0.001926 0.008432 -14195 1 0.000205 1560.000000 0.000363 0.002982 0.008978 -14196 1 0.000223 1560.000000 -0.000081 0.001806 0.000622 -14197 1 0.000205 1560.000000 0.003397 0.001402 0.007595 -14198 1 0.000231 1560.000000 0.001184 0.003386 0.000196 -14199 1 0.000207 1560.000000 0.001567 -0.000661 0.005998 -14200 1 0.000276 1560.000000 0.003213 0.001098 0.008296 -14201 1 0.000197 1560.000000 -0.000690 0.001971 0.007491 -14202 1 0.000201 1560.000000 0.003211 -0.001532 0.001618 -14203 1 0.000212 1560.000000 0.001394 -0.001276 0.008135 -14204 1 0.000262 1560.000000 0.001307 -0.003563 0.001345 -14205 1 0.000245 1560.000000 -0.001603 0.003234 0.007672 -14206 1 0.000270 1560.000000 0.002813 0.001198 0.003046 -14207 1 0.000280 1560.000000 0.001282 0.000872 0.009298 -14208 1 0.000199 1560.000000 -0.000208 -0.000418 0.003784 -14209 1 0.000203 1560.000000 -0.001124 -0.000346 0.006753 -14210 1 0.000216 1560.000000 -0.000997 0.001989 0.005767 -14211 1 0.000219 1560.000000 0.001275 0.001730 0.003118 -14212 1 0.000263 1560.000000 -0.002519 0.001500 0.007546 -14213 1 0.000276 1560.000000 0.002403 0.002699 0.007715 -14214 1 0.000276 1560.000000 -0.001970 -0.000788 0.002678 -14215 1 0.000278 1560.000000 -0.003118 0.000761 0.009667 -14216 1 0.000226 1560.000000 0.002003 -0.003132 0.001740 -14217 1 0.000231 1560.000000 -0.001628 0.003405 0.002012 -14218 1 0.000226 1560.000000 -0.000966 -0.001534 0.003123 -14219 1 0.000205 1560.000000 -0.000304 -0.000103 0.009223 -14220 1 0.000288 1560.000000 0.001167 0.003586 0.002024 -14221 1 0.000204 1560.000000 0.001303 0.000529 0.009662 -14222 1 0.000279 1560.000000 -0.001880 -0.001855 0.001514 -14223 1 0.000256 1560.000000 0.000353 0.003804 0.006341 -14224 1 0.000268 1560.000000 -0.000043 0.002249 0.005739 -14225 1 0.000229 1560.000000 0.003756 0.000784 0.000981 -14226 1 0.000286 1560.000000 -0.001574 0.002721 0.008561 -14227 1 0.000252 1560.000000 0.003023 0.001741 0.003909 -14228 1 0.000202 1560.000000 -0.001525 0.003511 0.006120 -14229 1 0.000211 1560.000000 0.003377 -0.001823 0.000152 -14230 1 0.000195 1560.000000 -0.001120 0.000329 0.001764 -14231 1 0.000238 1560.000000 -0.001477 -0.000614 0.007714 -14232 1 0.000251 1560.000000 -0.002133 -0.003142 0.008224 -14233 1 0.000243 1560.000000 0.000189 0.000578 0.009045 -14234 1 0.000205 1560.000000 0.000397 0.000113 0.007071 -14235 1 0.000287 1560.000000 -0.001963 0.001275 0.004028 -14236 1 0.000267 1560.000000 -0.000577 -0.003120 0.009437 -14237 1 0.000219 1560.000000 -0.000940 0.000474 0.005530 -14238 1 0.000283 1560.000000 0.001146 0.002157 0.008234 -14239 1 0.000219 1560.000000 -0.000923 -0.000922 0.002466 -14240 1 0.000207 1560.000000 0.001106 -0.000886 0.007302 -14241 1 0.000218 1560.000000 -0.002851 -0.001325 0.005976 -14242 1 0.000203 1560.000000 -0.003182 0.000314 0.004223 -14243 1 0.000211 1560.000000 0.001512 0.002055 0.009647 -14244 1 0.000239 1560.000000 0.002037 -0.001704 0.003249 -14245 1 0.000254 1560.000000 0.003201 -0.000858 0.008708 -14246 1 0.000240 1560.000000 -0.000323 -0.000174 0.000461 -14247 1 0.000263 1560.000000 0.002142 -0.001854 0.001497 -14248 1 0.000204 1560.000000 0.000885 0.000134 0.005223 -14249 1 0.000206 1560.000000 0.001775 0.002808 0.000366 -14250 1 0.000220 1560.000000 -0.000915 -0.002428 0.003205 -14251 1 0.000287 1560.000000 -0.001831 -0.002186 0.007613 -14252 1 0.000227 1560.000000 -0.002380 -0.002063 0.007467 -14253 1 0.000257 1560.000000 0.000428 0.002704 0.004058 -14254 1 0.000228 1560.000000 -0.000913 0.002988 0.003248 -14255 1 0.000206 1560.000000 0.000699 0.001850 0.006054 -14256 1 0.000254 1560.000000 0.003591 0.000958 0.004948 -14257 1 0.000268 1560.000000 0.003207 -0.001515 0.009450 -14258 1 0.000240 1560.000000 0.002281 -0.001218 0.002229 -14259 1 0.000232 1560.000000 0.001578 0.000665 0.007843 -14260 1 0.000223 1560.000000 0.003558 0.000164 0.005506 -14261 1 0.000254 1560.000000 -0.002852 -0.001064 0.007514 -14262 1 0.000201 1560.000000 -0.001055 0.003385 0.002357 -14263 1 0.000197 1560.000000 0.001962 -0.001271 0.009347 -14264 1 0.000205 1560.000000 -0.000900 -0.002881 0.003777 -14265 1 0.000207 1560.000000 0.000870 0.000648 0.002798 -14266 1 0.000222 1560.000000 0.003777 -0.000245 0.001264 -14267 1 0.000236 1560.000000 0.003257 0.001216 0.009469 -14268 1 0.000246 1560.000000 0.000536 -0.000014 0.002397 -14269 1 0.000208 1560.000000 -0.002280 -0.002770 0.005262 -14270 1 0.000228 1560.000000 -0.001378 0.000773 0.001503 -14271 1 0.000254 1560.000000 0.000547 0.001656 0.007049 -14272 1 0.000229 1560.000000 0.000834 -0.002496 0.002076 -14273 1 0.000201 1560.000000 0.000292 0.001344 0.007851 -14274 1 0.000200 1560.000000 -0.001991 -0.002196 0.005358 -14275 1 0.000250 1560.000000 -0.003077 0.001556 0.002134 -14276 1 0.000242 1560.000000 0.003281 -0.001984 0.006318 -14277 1 0.000248 1560.000000 -0.003112 0.000296 0.008687 -14278 1 0.000225 1560.000000 0.000124 -0.003516 0.000925 -14279 1 0.000195 1560.000000 -0.002830 0.001833 0.003457 -14280 1 0.000210 1560.000000 0.000406 0.000117 0.003045 -14281 1 0.000202 1560.000000 0.001270 0.000168 0.003272 -14282 1 0.000224 1560.000000 0.001498 -0.000642 0.000188 -14283 1 0.000228 1560.000000 -0.001112 0.000912 0.004971 -14284 1 0.000273 1560.000000 0.002208 -0.000756 0.002195 -14285 1 0.000287 1560.000000 0.003326 0.001893 0.003132 -14286 1 0.000270 1560.000000 -0.002108 0.003094 0.001950 -14287 1 0.000197 1560.000000 0.001190 -0.002519 0.007729 -14288 1 0.000211 1560.000000 -0.002341 -0.003024 0.005602 -14289 1 0.000250 1560.000000 -0.003221 0.001399 0.008024 -14290 1 0.000267 1560.000000 0.000963 0.003582 0.006433 -14291 1 0.000217 1560.000000 0.002226 -0.001793 0.003986 -14292 1 0.000226 1560.000000 0.001129 -0.003169 0.003508 -14293 1 0.000286 1560.000000 0.003798 0.000054 0.005513 -14294 1 0.000225 1560.000000 0.001339 -0.000673 0.002001 -14295 1 0.000227 1560.000000 0.001260 -0.002727 0.000858 -14296 1 0.000199 1560.000000 0.000325 -0.000830 0.005344 -14297 1 0.000247 1560.000000 0.002239 0.002187 0.001656 -14298 1 0.000286 1560.000000 0.003558 0.000508 0.008357 -14299 1 0.000259 1560.000000 -0.000977 0.002533 0.005669 -14300 1 0.000198 1560.000000 -0.002354 -0.000763 0.000728 -14301 1 0.000237 1560.000000 0.001541 0.003504 0.006982 -14302 1 0.000205 1560.000000 0.002110 -0.000256 0.001859 -14303 1 0.000236 1560.000000 -0.003376 0.001740 0.008720 -14304 1 0.000256 1560.000000 -0.003304 0.001022 0.006787 -14305 1 0.000222 1560.000000 -0.001295 -0.003520 0.008926 -14306 1 0.000234 1560.000000 0.003492 0.000644 0.001702 -14307 1 0.000207 1560.000000 -0.001626 0.000980 0.005387 -14308 1 0.000217 1560.000000 -0.001309 -0.002986 0.002572 -14309 1 0.000218 1560.000000 -0.001258 -0.003065 0.002823 -14310 1 0.000230 1560.000000 -0.002048 0.000216 0.004203 -14311 1 0.000221 1560.000000 -0.002190 -0.001268 0.007138 -14312 1 0.000231 1560.000000 -0.002674 0.000488 0.000213 -14313 1 0.000205 1560.000000 -0.000713 -0.002935 0.007760 -14314 1 0.000248 1560.000000 -0.000925 -0.001915 0.000619 -14315 1 0.000222 1560.000000 0.003148 -0.001103 0.002535 -14316 1 0.000226 1560.000000 -0.001998 0.001861 0.000776 -14317 1 0.000260 1560.000000 0.001059 -0.003499 0.002555 -14318 1 0.000195 1560.000000 0.000668 0.001348 0.006764 -14319 1 0.000280 1560.000000 -0.000895 -0.002108 0.007989 -14320 1 0.000284 1560.000000 0.002231 -0.002096 0.004846 -14321 1 0.000221 1560.000000 0.000642 -0.003608 0.002959 -14322 1 0.000210 1560.000000 0.001825 -0.001657 0.007554 -14323 1 0.000281 1560.000000 -0.001547 0.002838 0.006323 -14324 1 0.000228 1560.000000 -0.000719 -0.000054 0.006695 -14325 1 0.000248 1560.000000 -0.001420 -0.002633 0.006194 -14326 1 0.000201 1560.000000 -0.000896 -0.001530 0.003797 -14327 1 0.000256 1560.000000 -0.000647 0.003788 0.002779 -14328 1 0.000236 1560.000000 -0.000544 0.002971 0.003772 -14329 1 0.000224 1560.000000 -0.001219 0.002434 0.007488 -14330 1 0.000226 1560.000000 0.002298 0.002138 0.004784 -14331 1 0.000266 1560.000000 -0.002905 0.001867 0.002319 -14332 1 0.000284 1560.000000 0.003471 0.000636 0.003353 -14333 1 0.000269 1560.000000 -0.002346 -0.000105 0.000671 -14334 1 0.000235 1560.000000 0.002075 -0.000897 0.007812 -14335 1 0.000201 1560.000000 -0.003542 0.001068 0.009475 -14336 1 0.000269 1560.000000 0.002059 -0.002254 0.005679 -14337 1 0.000203 1560.000000 -0.001300 -0.002871 0.001993 -14338 1 0.000211 1560.000000 -0.000855 0.002209 0.000361 -14339 1 0.000226 1560.000000 0.003259 0.001417 0.000284 -14340 1 0.000213 1560.000000 -0.002319 -0.002878 0.008426 -14341 1 0.000250 1560.000000 0.003563 0.000651 0.007067 -14342 1 0.000206 1560.000000 -0.002849 0.001207 0.006555 -14343 1 0.000235 1560.000000 -0.002355 0.001540 0.002685 -14344 1 0.000196 1560.000000 0.000226 -0.000115 0.007078 -14345 1 0.000232 1560.000000 -0.001199 -0.003362 0.008242 -14346 1 0.000245 1560.000000 -0.000833 0.002011 0.007795 -14347 1 0.000233 1560.000000 0.000453 0.003808 0.008902 -14348 1 0.000202 1560.000000 0.001951 -0.000999 0.002031 -14349 1 0.000198 1560.000000 0.000070 -0.000036 0.000365 -14350 1 0.000217 1560.000000 0.000812 -0.000648 0.005234 -14351 1 0.000205 1560.000000 0.002392 -0.002952 0.009142 -14352 1 0.000212 1560.000000 0.002654 0.001949 0.002672 -14353 1 0.000210 1560.000000 0.000470 -0.000689 0.006007 -14354 1 0.000256 1560.000000 -0.001964 -0.002073 0.009118 -14355 1 0.000231 1560.000000 0.000939 -0.003621 0.007719 -14356 1 0.000288 1560.000000 -0.001014 0.001896 0.006221 -14357 1 0.000255 1560.000000 0.000489 -0.000778 0.004675 -14358 1 0.000206 1560.000000 0.001899 0.001033 0.003886 -14359 1 0.000223 1560.000000 -0.001781 -0.002319 0.000316 -14360 1 0.000216 1560.000000 0.001165 0.000665 0.003284 -14361 1 0.000218 1560.000000 -0.000402 -0.003007 0.006842 -14362 1 0.000197 1560.000000 -0.002021 -0.001020 0.001535 -14363 1 0.000211 1560.000000 -0.003120 0.001139 0.008941 -14364 1 0.000197 1560.000000 0.001195 -0.002649 0.002811 -14365 1 0.000253 1560.000000 0.002068 0.002216 0.001262 -14366 1 0.000196 1560.000000 0.000114 0.001717 0.009766 -14367 1 0.000221 1560.000000 -0.003051 -0.000723 0.000966 -14368 1 0.000212 1560.000000 0.001423 0.002454 0.006414 -14369 1 0.000199 1560.000000 0.002448 -0.002268 0.008850 -14370 1 0.000253 1560.000000 0.001484 0.003248 0.009773 -14371 1 0.000207 1560.000000 0.000188 0.000086 0.006555 -14372 1 0.000213 1560.000000 0.003104 0.001732 0.002324 -14373 1 0.000225 1560.000000 -0.001848 -0.000535 0.009098 -14374 1 0.000218 1560.000000 0.000873 0.003167 0.006948 -14375 1 0.000210 1560.000000 0.003619 0.000030 0.006663 -14376 1 0.000246 1560.000000 -0.001665 0.001664 0.007945 -14377 1 0.000233 1560.000000 -0.001476 0.002352 0.002600 -14378 1 0.000248 1560.000000 -0.003057 0.001501 0.004533 -14379 1 0.000245 1560.000000 0.000970 -0.000944 0.008511 -14380 1 0.000222 1560.000000 0.001701 -0.000113 0.000645 -14381 1 0.000193 1560.000000 -0.002479 -0.001103 0.002006 -14382 1 0.000227 1560.000000 0.001348 -0.003557 0.007569 -14383 1 0.000241 1560.000000 0.002749 0.001042 0.000701 -14384 1 0.000195 1560.000000 -0.001064 -0.001326 0.005687 -14385 1 0.000196 1560.000000 -0.002404 0.002248 0.009312 -14386 1 0.000205 1560.000000 -0.002778 -0.000507 0.003699 -14387 1 0.000283 1560.000000 0.001517 -0.002627 0.006901 -14388 1 0.000252 1560.000000 -0.002479 0.001217 0.006240 -14389 1 0.000227 1560.000000 0.000930 -0.002808 0.005215 -14390 1 0.000285 1560.000000 0.003087 -0.001201 0.009235 -14391 1 0.000226 1560.000000 -0.002148 0.000727 0.001913 -14392 1 0.000256 1560.000000 0.000475 -0.003461 0.008794 -14393 1 0.000222 1560.000000 0.002152 -0.000847 0.000450 -14394 1 0.000239 1560.000000 -0.000174 0.001565 0.003329 -14395 1 0.000213 1560.000000 0.000177 -0.001664 0.008993 -14396 1 0.000203 1560.000000 -0.000567 -0.002047 0.002406 -14397 1 0.000249 1560.000000 -0.001996 0.001155 0.007005 -14398 1 0.000225 1560.000000 -0.001430 -0.002318 0.009734 -14399 1 0.000256 1560.000000 -0.001244 0.002851 0.008476 -14400 1 0.000257 1560.000000 0.000042 0.000989 0.008461 -14401 1 0.000262 1560.000000 0.002299 0.002083 0.003016 -14402 1 0.000219 1560.000000 -0.001697 -0.000589 0.000822 -14403 1 0.000266 1560.000000 -0.001056 -0.001655 0.009482 -14404 1 0.000199 1560.000000 0.001041 -0.000140 0.004344 -14405 1 0.000269 1560.000000 -0.002926 0.000549 0.000556 -14406 1 0.000193 1560.000000 0.002025 0.001598 0.000424 -14407 1 0.000243 1560.000000 -0.001946 0.001037 0.002090 -14408 1 0.000246 1560.000000 0.001314 0.001474 0.009480 -14409 1 0.000222 1560.000000 -0.000181 0.002575 0.001884 -14410 1 0.000276 1560.000000 -0.002752 0.001910 0.009173 -14411 1 0.000276 1560.000000 0.000897 0.002597 0.005402 -14412 1 0.000249 1560.000000 0.001314 -0.001534 0.002973 -14413 1 0.000224 1560.000000 -0.001698 -0.001289 0.000957 -14414 1 0.000217 1560.000000 0.001019 0.001579 0.006139 -14415 1 0.000207 1560.000000 0.000237 -0.001635 0.002086 -14416 1 0.000204 1560.000000 0.001948 0.001704 0.007429 -14417 1 0.000235 1560.000000 -0.001277 0.001100 0.001266 -14418 1 0.000238 1560.000000 -0.001483 -0.003440 0.008292 -14419 1 0.000209 1560.000000 0.001495 -0.002236 0.001399 -14420 1 0.000238 1560.000000 0.000377 0.001941 0.007484 -14421 1 0.000255 1560.000000 -0.000718 -0.002143 0.006994 -14422 1 0.000247 1560.000000 0.000815 0.003445 0.003443 -14423 1 0.000249 1560.000000 0.003196 -0.001075 0.009835 -14424 1 0.000229 1560.000000 0.001951 0.000929 0.007472 -14425 1 0.000231 1560.000000 0.000561 -0.002758 0.001807 -14426 1 0.000239 1560.000000 0.002931 -0.000810 0.001848 -14427 1 0.000196 1560.000000 -0.000440 -0.003255 0.004814 -14428 1 0.000287 1560.000000 0.003782 -0.000724 0.005080 -14429 1 0.000193 1560.000000 -0.001898 0.003210 0.007146 -14430 1 0.000244 1560.000000 -0.000809 0.003375 0.002014 -14431 1 0.000233 1560.000000 0.002035 -0.000112 0.007046 -14432 1 0.000218 1560.000000 -0.003365 0.001741 0.006787 -14433 1 0.000198 1560.000000 -0.002160 -0.001911 0.000220 -14434 1 0.000270 1560.000000 -0.002253 0.002602 0.009569 -14435 1 0.000240 1560.000000 -0.003775 -0.000596 0.003312 -14436 1 0.000197 1560.000000 0.003225 0.000252 0.008551 -14437 1 0.000193 1560.000000 -0.000776 -0.002166 0.002386 -14438 1 0.000253 1560.000000 0.002334 -0.003052 0.007243 -14439 1 0.000243 1560.000000 -0.001980 0.001408 0.000155 -14440 1 0.000200 1560.000000 0.000200 -0.000178 0.001177 -14441 1 0.000207 1560.000000 0.000166 -0.003339 0.006522 -14442 1 0.000248 1560.000000 0.001599 0.002744 0.005084 -14443 1 0.000233 1560.000000 0.002198 -0.002002 0.001169 -14444 1 0.000242 1560.000000 -0.002655 -0.001582 0.005483 -14445 1 0.000212 1560.000000 -0.001276 -0.003396 0.007760 -14446 1 0.000232 1560.000000 -0.003533 -0.001171 0.004795 -14447 1 0.000221 1560.000000 0.001319 0.001012 0.002167 -14448 1 0.000264 1560.000000 0.000753 0.000659 0.005380 -14449 1 0.000198 1560.000000 0.000179 0.000248 0.009129 -14450 1 0.000210 1560.000000 0.003454 0.000916 0.003830 -14451 1 0.000261 1560.000000 -0.002951 0.000791 0.005372 -14452 1 0.000223 1560.000000 -0.002785 -0.001679 0.002147 -14453 1 0.000265 1560.000000 0.001137 -0.002061 0.001448 -14454 1 0.000221 1560.000000 0.002371 0.002641 0.006520 -14455 1 0.000224 1560.000000 -0.002844 -0.001808 0.005835 -14456 1 0.000254 1560.000000 0.000046 0.001656 0.002104 -14457 1 0.000276 1560.000000 -0.001072 0.002716 0.009824 -14458 1 0.000266 1560.000000 -0.002459 -0.002845 0.003482 -14459 1 0.000277 1560.000000 -0.002683 -0.001908 0.008917 -14460 1 0.000214 1560.000000 0.001934 0.001300 0.008612 -14461 1 0.000206 1560.000000 0.001010 0.001170 0.003224 -14462 1 0.000257 1560.000000 0.002004 0.002603 0.006447 -14463 1 0.000233 1560.000000 -0.000741 -0.002388 0.005631 -14464 1 0.000204 1560.000000 0.001536 -0.000072 0.003210 -14465 1 0.000210 1560.000000 -0.002238 0.003058 0.001408 -14466 1 0.000207 1560.000000 0.002020 0.000057 0.000594 -14467 1 0.000275 1560.000000 0.002828 0.000210 0.003084 -14468 1 0.000232 1560.000000 0.000340 -0.001829 0.000776 -14469 1 0.000246 1560.000000 0.003468 0.001600 0.004097 -14470 1 0.000196 1560.000000 -0.001038 -0.001088 0.005806 -14471 1 0.000241 1560.000000 -0.002432 -0.001844 0.001536 -14472 1 0.000218 1560.000000 0.000514 0.001707 0.006759 -14473 1 0.000230 1560.000000 -0.001440 -0.001962 0.007150 -14474 1 0.000258 1560.000000 -0.002215 -0.000405 0.008168 -14475 1 0.000263 1560.000000 0.000841 -0.003549 0.000945 -14476 1 0.000241 1560.000000 -0.000729 -0.002855 0.005033 -14477 1 0.000284 1560.000000 0.001441 -0.003560 0.002963 -14478 1 0.000249 1560.000000 -0.001124 -0.002911 0.005396 -14479 1 0.000242 1560.000000 0.001439 0.001920 0.007646 -14480 1 0.000246 1560.000000 0.002021 0.000274 0.001670 -14481 1 0.000263 1560.000000 0.001679 0.002960 0.002618 -14482 1 0.000197 1560.000000 0.000717 0.000546 0.000738 -14483 1 0.000227 1560.000000 -0.001258 0.003181 0.004287 -14484 1 0.000272 1560.000000 0.001674 0.002111 0.009837 -14485 1 0.000210 1560.000000 0.001460 -0.001408 0.007953 -14486 1 0.000235 1560.000000 -0.001085 0.000807 0.003100 -14487 1 0.000248 1560.000000 0.002793 -0.001015 0.003571 -14488 1 0.000245 1560.000000 -0.003137 -0.000501 0.004681 -14489 1 0.000228 1560.000000 0.000118 -0.002906 0.009740 -14490 1 0.000211 1560.000000 -0.001091 -0.000597 0.002374 -14491 1 0.000226 1560.000000 0.001825 -0.002573 0.006745 -14492 1 0.000240 1560.000000 -0.002466 0.002090 0.001767 -14493 1 0.000205 1560.000000 0.000437 -0.002653 0.005528 -14494 1 0.000224 1560.000000 0.003018 0.000131 0.003250 -14495 1 0.000210 1560.000000 -0.002275 0.000552 0.009238 -14496 1 0.000211 1560.000000 -0.001566 -0.000549 0.009084 -14497 1 0.000208 1560.000000 0.001252 0.000414 0.000879 -14498 1 0.000244 1560.000000 0.002423 0.000345 0.004389 -14499 1 0.000217 1560.000000 0.000911 0.001219 0.001740 -14500 1 0.000197 1560.000000 -0.002016 -0.001244 0.003731 -14501 1 0.000277 1560.000000 0.003287 -0.000376 0.000157 -14502 1 0.000211 1560.000000 0.000843 0.002108 0.009629 -14503 1 0.000257 1560.000000 0.001208 -0.002308 0.005402 -14504 1 0.000213 1560.000000 -0.002705 -0.001342 0.003801 -14505 1 0.000240 1560.000000 0.002736 -0.001141 0.004973 -14506 1 0.000232 1560.000000 0.000753 -0.003498 0.005239 -14507 1 0.000213 1560.000000 0.002456 0.001812 0.001855 -14508 1 0.000265 1560.000000 -0.000023 0.003024 0.008206 -14509 1 0.000200 1560.000000 -0.002304 0.002341 0.008431 -14510 1 0.000255 1560.000000 0.001706 0.000520 0.005922 -14511 1 0.000199 1560.000000 -0.000968 -0.003640 0.008319 -14512 1 0.000269 1560.000000 0.002489 0.002834 0.007086 -14513 1 0.000193 1560.000000 0.000063 0.002618 0.000371 -14514 1 0.000258 1560.000000 0.003380 0.001781 0.003934 -14515 1 0.000208 1560.000000 0.001063 -0.000113 0.006576 -14516 1 0.000258 1560.000000 -0.000707 0.000194 0.000147 -14517 1 0.000231 1560.000000 -0.000631 -0.002169 0.001891 -14518 1 0.000203 1560.000000 -0.003217 -0.001286 0.003365 -14519 1 0.000234 1560.000000 -0.001778 0.000955 0.003775 -14520 1 0.000203 1560.000000 0.001620 0.001150 0.000167 -14521 1 0.000215 1560.000000 0.000224 0.001973 0.005615 -14522 1 0.000267 1560.000000 -0.001615 0.001960 0.006209 -14523 1 0.000216 1560.000000 -0.000904 -0.002922 0.009355 -14524 1 0.000273 1560.000000 0.001232 -0.003485 0.006263 -14525 1 0.000277 1560.000000 0.003817 -0.000267 0.002531 -14526 1 0.000253 1560.000000 -0.001264 -0.000910 0.006418 -14527 1 0.000243 1560.000000 0.001246 0.000699 0.004221 -14528 1 0.000264 1560.000000 0.002385 0.002403 0.009194 -14529 1 0.000231 1560.000000 -0.000718 0.003641 0.006167 -14530 1 0.000193 1560.000000 -0.001118 0.000198 0.009547 -14531 1 0.000279 1560.000000 0.003213 -0.001562 0.002921 -14532 1 0.000203 1560.000000 0.000848 0.001012 0.004534 -14533 1 0.000212 1560.000000 -0.000430 0.001521 0.009022 -14534 1 0.000194 1560.000000 0.000862 -0.000359 0.008751 -14535 1 0.000248 1560.000000 -0.001238 0.002708 0.001445 -14536 1 0.000246 1560.000000 -0.003164 -0.000377 0.008012 -14537 1 0.000258 1560.000000 0.003760 0.000132 0.008378 -14538 1 0.000217 1560.000000 0.001985 0.002016 0.009386 -14539 1 0.000285 1560.000000 0.003616 -0.001047 0.001605 -14540 1 0.000275 1560.000000 0.000738 0.000312 0.009354 -14541 1 0.000245 1560.000000 0.003127 -0.001574 0.008362 -14542 1 0.000241 1560.000000 -0.003320 0.000740 0.004631 -14543 1 0.000214 1560.000000 0.003526 -0.000341 0.004718 -14544 1 0.000243 1560.000000 -0.003253 -0.000637 0.007796 -14545 1 0.000194 1560.000000 -0.003841 0.000305 0.007363 -14546 1 0.000218 1560.000000 0.003180 -0.001059 0.009432 -14547 1 0.000273 1560.000000 0.002340 -0.002303 0.001536 -14548 1 0.000193 1560.000000 0.001187 -0.000203 0.008036 -14549 1 0.000276 1560.000000 -0.002028 -0.002908 0.005622 -14550 1 0.000198 1560.000000 -0.001403 0.002667 0.006646 -14551 1 0.000212 1560.000000 0.000051 -0.001201 0.007081 -14552 1 0.000221 1560.000000 0.001730 -0.001902 0.000456 -14553 1 0.000257 1560.000000 0.003768 -0.000490 0.008541 -14554 1 0.000218 1560.000000 -0.003113 -0.001929 0.008574 -14555 1 0.000218 1560.000000 -0.000065 -0.002611 0.009002 -14556 1 0.000230 1560.000000 0.002561 0.002292 0.008527 -14557 1 0.000196 1560.000000 0.000835 -0.000395 0.006008 -14558 1 0.000238 1560.000000 0.000268 -0.003236 0.005174 -14559 1 0.000252 1560.000000 0.001799 0.003395 0.008501 -14560 1 0.000194 1560.000000 0.002143 0.002224 0.004917 -14561 1 0.000279 1560.000000 -0.001833 0.002089 0.004249 -14562 1 0.000288 1560.000000 0.003835 -0.000045 0.003832 -14563 1 0.000275 1560.000000 0.000996 -0.003296 0.008313 -14564 1 0.000234 1560.000000 -0.002422 0.000083 0.004148 -14565 1 0.000201 1560.000000 0.002130 -0.003214 0.001441 -14566 1 0.000196 1560.000000 0.002194 -0.001529 0.002086 -14567 1 0.000199 1560.000000 0.000737 -0.001956 0.003510 -14568 1 0.000245 1560.000000 0.002263 0.001935 0.008818 -14569 1 0.000205 1560.000000 -0.002499 0.000587 0.000689 -14570 1 0.000219 1560.000000 -0.002584 0.002094 0.007931 -14571 1 0.000203 1560.000000 -0.001644 0.000868 0.000724 -14572 1 0.000201 1560.000000 -0.002452 -0.001312 0.005414 -14573 1 0.000272 1560.000000 -0.002552 0.001511 0.005546 -14574 1 0.000246 1560.000000 -0.003383 0.000835 0.005657 -14575 1 0.000217 1560.000000 -0.001411 0.003076 0.000215 -14576 1 0.000227 1560.000000 -0.002790 0.000708 0.004990 -14577 1 0.000197 1560.000000 0.003303 0.001106 0.006900 -14578 1 0.000226 1560.000000 -0.000724 -0.002411 0.004771 -14579 1 0.000287 1560.000000 -0.002142 -0.002957 0.000225 -14580 1 0.000241 1560.000000 -0.003230 -0.001849 0.004368 -14581 1 0.000247 1560.000000 0.003591 0.001061 0.001359 -14582 1 0.000261 1560.000000 -0.001208 -0.000650 0.004592 -14583 1 0.000274 1560.000000 -0.000654 0.003021 0.000554 -14584 1 0.000220 1560.000000 -0.002590 -0.001564 0.005720 -14585 1 0.000252 1560.000000 -0.000816 -0.002827 0.000428 -14586 1 0.000233 1560.000000 0.001979 -0.001623 0.008796 -14587 1 0.000261 1560.000000 -0.000358 0.001206 0.003066 -14588 1 0.000218 1560.000000 -0.000551 -0.002409 0.005802 -14589 1 0.000230 1560.000000 0.001298 -0.002900 0.001669 -14590 1 0.000192 1560.000000 -0.000794 0.000878 0.004475 -14591 1 0.000224 1560.000000 -0.002231 0.003028 0.004645 -14592 1 0.000259 1560.000000 -0.000146 0.000612 0.005010 -14593 1 0.000253 1560.000000 -0.001264 0.002710 0.006222 -14594 1 0.000272 1560.000000 0.001097 0.003647 0.002629 -14595 1 0.000287 1560.000000 0.001182 0.001961 0.002755 -14596 1 0.000253 1560.000000 -0.000394 -0.001358 0.000774 -14597 1 0.000259 1560.000000 0.002434 0.001279 0.005063 -14598 1 0.000219 1560.000000 0.002149 -0.001309 0.002712 -14599 1 0.000226 1560.000000 -0.002073 -0.002893 0.004354 -14600 1 0.000262 1560.000000 -0.002875 0.002393 0.005516 -14601 1 0.000229 1560.000000 0.001916 -0.002372 0.008815 -14602 1 0.000238 1560.000000 -0.001505 -0.002691 0.001160 -14603 1 0.000206 1560.000000 0.002081 0.002484 0.000213 -14604 1 0.000261 1560.000000 0.001061 0.003347 0.007903 -14605 1 0.000249 1560.000000 0.000767 -0.000720 0.003800 -14606 1 0.000255 1560.000000 -0.002734 -0.002598 0.000524 -14607 1 0.000224 1560.000000 0.001018 -0.001901 0.008858 -14608 1 0.000280 1560.000000 -0.002705 -0.001455 0.006219 -14609 1 0.000228 1560.000000 -0.000873 0.001862 0.000523 -14610 1 0.000197 1560.000000 0.000154 0.000892 0.006204 -14611 1 0.000233 1560.000000 -0.001602 -0.001099 0.007614 -14612 1 0.000204 1560.000000 -0.001199 -0.000348 0.000408 -14613 1 0.000262 1560.000000 -0.000455 0.001262 0.008368 -14614 1 0.000209 1560.000000 0.001967 0.002823 0.002779 -14615 1 0.000215 1560.000000 -0.000561 0.000096 0.007719 -14616 1 0.000210 1560.000000 -0.002695 0.000498 0.009801 -14617 1 0.000220 1560.000000 0.003357 0.000932 0.000144 -14618 1 0.000215 1560.000000 -0.003641 -0.001164 0.006768 -14619 1 0.000197 1560.000000 0.000718 0.003111 0.000780 -14620 1 0.000234 1560.000000 0.000126 0.003562 0.001962 -14621 1 0.000244 1560.000000 -0.002113 -0.003221 0.005385 -14622 1 0.000242 1560.000000 -0.002514 0.002295 0.002080 -14623 1 0.000237 1560.000000 -0.000705 0.003577 0.002161 -14624 1 0.000194 1560.000000 0.000644 0.002784 0.003963 -14625 1 0.000271 1560.000000 -0.003337 -0.000723 0.003904 -14626 1 0.000217 1560.000000 -0.000049 -0.002192 0.007977 -14627 1 0.000199 1560.000000 0.002918 0.002413 0.005509 -14628 1 0.000275 1560.000000 0.002178 0.001654 0.005076 -14629 1 0.000200 1560.000000 -0.001312 0.002051 0.008277 -14630 1 0.000202 1560.000000 -0.000705 0.002112 0.007983 -14631 1 0.000258 1560.000000 -0.001634 -0.002639 0.002351 -14632 1 0.000194 1560.000000 -0.000161 0.002918 0.001208 -14633 1 0.000254 1560.000000 0.003093 -0.001392 0.005022 -14634 1 0.000223 1560.000000 0.000457 0.002520 0.002736 -14635 1 0.000200 1560.000000 0.003060 -0.001400 0.000693 -14636 1 0.000206 1560.000000 -0.000349 -0.001532 0.003756 -14637 1 0.000202 1560.000000 -0.002908 -0.001290 0.006294 -14638 1 0.000268 1560.000000 -0.001373 0.002652 0.002421 -14639 1 0.000264 1560.000000 0.002504 -0.001678 0.008684 -14640 1 0.000277 1560.000000 -0.002261 -0.000424 0.006793 -14641 1 0.000195 1560.000000 -0.003711 0.000618 0.003066 -14642 1 0.000243 1560.000000 -0.000867 -0.001924 0.008374 -14643 1 0.000203 1560.000000 0.000972 0.003506 0.000401 -14644 1 0.000247 1560.000000 0.000622 -0.002732 0.008172 -14645 1 0.000213 1560.000000 0.002641 0.002020 0.005784 -14646 1 0.000209 1560.000000 -0.000471 0.002233 0.003104 -14647 1 0.000237 1560.000000 -0.000662 -0.002356 0.008807 -14648 1 0.000227 1560.000000 -0.001976 -0.002113 0.008867 -14649 1 0.000246 1560.000000 -0.000294 -0.001426 0.007770 -14650 1 0.000213 1560.000000 0.002504 0.000359 0.008764 -14651 1 0.000217 1560.000000 0.001502 0.000242 0.001277 -14652 1 0.000223 1560.000000 0.001786 -0.002345 0.003753 -14653 1 0.000250 1560.000000 -0.002831 0.001281 0.005975 -14654 1 0.000272 1560.000000 -0.001220 -0.003398 0.009792 -14655 1 0.000200 1560.000000 -0.000317 0.001800 0.009542 -14656 1 0.000226 1560.000000 0.000858 0.000235 0.005916 -14657 1 0.000194 1560.000000 0.001799 -0.001311 0.004696 -14658 1 0.000231 1560.000000 -0.001073 -0.003376 0.002716 -14659 1 0.000238 1560.000000 -0.001198 -0.000720 0.001295 -14660 1 0.000269 1560.000000 -0.000985 0.002627 0.008934 -14661 1 0.000230 1560.000000 -0.000056 -0.002727 0.005263 -14662 1 0.000258 1560.000000 -0.003247 -0.000143 0.005300 -14663 1 0.000231 1560.000000 0.001970 -0.001149 0.000816 -14664 1 0.000193 1560.000000 0.003377 0.000547 0.006018 -14665 1 0.000285 1560.000000 -0.001750 0.003324 0.009803 -14666 1 0.000267 1560.000000 -0.002221 -0.002665 0.003318 -14667 1 0.000253 1560.000000 0.001297 -0.003006 0.006910 -14668 1 0.000237 1560.000000 -0.002533 0.001760 0.007120 -14669 1 0.000260 1560.000000 -0.002566 0.002655 0.007867 -14670 1 0.000249 1560.000000 0.002972 -0.001251 0.006297 -14671 1 0.000214 1560.000000 -0.000682 0.000253 0.003398 -14672 1 0.000226 1560.000000 -0.003511 0.001573 0.006688 -14673 1 0.000244 1560.000000 -0.002287 0.001216 0.004887 -14674 1 0.000213 1560.000000 -0.003711 -0.000976 0.008139 -14675 1 0.000210 1560.000000 0.000558 0.002979 0.004798 -14676 1 0.000249 1560.000000 -0.001879 0.000616 0.008647 -14677 1 0.000240 1560.000000 -0.001156 0.000581 0.004933 -14678 1 0.000284 1560.000000 -0.002560 -0.002798 0.006238 -14679 1 0.000287 1560.000000 0.001242 0.001412 0.001595 -14680 1 0.000264 1560.000000 -0.002468 0.001948 0.004716 -14681 1 0.000281 1560.000000 -0.000017 -0.001032 0.007970 -14682 1 0.000279 1560.000000 0.001630 0.002378 0.008738 -14683 1 0.000220 1560.000000 0.000916 0.003709 0.001504 -14684 1 0.000248 1560.000000 0.002083 0.001754 0.001357 -14685 1 0.000277 1560.000000 0.002867 -0.002124 0.000736 -14686 1 0.000253 1560.000000 0.000268 -0.000732 0.000340 -14687 1 0.000198 1560.000000 -0.000490 -0.003110 0.005576 -14688 1 0.000277 1560.000000 0.001209 0.002537 0.006626 -14689 1 0.000220 1560.000000 -0.000317 0.003479 0.007674 -14690 1 0.000276 1560.000000 -0.001847 0.002271 0.003120 -14691 1 0.000265 1560.000000 0.000216 0.003828 0.005830 -14692 1 0.000232 1560.000000 0.000023 -0.003444 0.008678 -14693 1 0.000218 1560.000000 0.000990 0.000398 0.003344 -14694 1 0.000246 1560.000000 -0.000185 -0.003520 0.002813 -14695 1 0.000222 1560.000000 -0.000670 -0.001449 0.001799 -14696 1 0.000271 1560.000000 0.001202 0.003260 0.008408 -14697 1 0.000232 1560.000000 -0.001792 -0.002400 0.001881 -14698 1 0.000258 1560.000000 0.003253 -0.002012 0.000293 -14699 1 0.000210 1560.000000 -0.000019 0.003078 0.007472 -14700 1 0.000213 1560.000000 0.002680 0.000862 0.001459 -14701 1 0.000203 1560.000000 0.000278 0.000268 0.003973 -14702 1 0.000227 1560.000000 0.003298 -0.001854 0.003774 -14703 1 0.000263 1560.000000 0.000311 0.003794 0.002738 -14704 1 0.000206 1560.000000 0.001707 -0.003111 0.000426 -14705 1 0.000214 1560.000000 -0.003485 -0.001549 0.003626 -14706 1 0.000250 1560.000000 -0.001635 -0.003403 0.004998 -14707 1 0.000196 1560.000000 0.003405 0.000728 0.009366 -14708 1 0.000265 1560.000000 0.000527 0.002639 0.002239 -14709 1 0.000268 1560.000000 0.000214 0.001758 0.004491 -14710 1 0.000270 1560.000000 -0.003064 0.000814 0.005935 -14711 1 0.000227 1560.000000 0.000901 -0.003163 0.002593 -14712 1 0.000251 1560.000000 -0.002122 0.000091 0.008699 -14713 1 0.000288 1560.000000 -0.003544 0.001066 0.000995 -14714 1 0.000252 1560.000000 -0.003679 -0.000210 0.002649 -14715 1 0.000220 1560.000000 0.001640 -0.003063 0.004662 -14716 1 0.000251 1560.000000 0.001382 -0.000400 0.004229 -14717 1 0.000243 1560.000000 -0.000749 -0.003216 0.004303 -14718 1 0.000282 1560.000000 0.000163 -0.003126 0.003440 -14719 1 0.000259 1560.000000 0.003611 -0.000184 0.001681 -14720 1 0.000254 1560.000000 0.002210 -0.000688 0.004458 -14721 1 0.000206 1560.000000 0.001352 -0.002630 0.006342 -14722 1 0.000215 1560.000000 -0.003108 -0.001310 0.001488 -14723 1 0.000245 1560.000000 0.000620 -0.001825 0.003027 -14724 1 0.000220 1560.000000 -0.000677 0.001453 0.001848 -14725 1 0.000224 1560.000000 0.000736 -0.002247 0.001562 -14726 1 0.000231 1560.000000 0.001482 -0.002898 0.009709 -14727 1 0.000281 1560.000000 0.001338 -0.000755 0.009234 -14728 1 0.000256 1560.000000 0.003462 0.001151 0.009337 -14729 1 0.000231 1560.000000 -0.000261 0.003239 0.007520 -14730 1 0.000219 1560.000000 -0.001972 -0.002259 0.000730 -14731 1 0.000260 1560.000000 0.003318 -0.001041 0.005526 -14732 1 0.000212 1560.000000 -0.000163 -0.000907 0.008503 -14733 1 0.000205 1560.000000 0.001437 0.001284 0.008182 -14734 1 0.000280 1560.000000 -0.000188 -0.003108 0.005978 -14735 1 0.000194 1560.000000 0.001881 0.000195 0.003225 -14736 1 0.000257 1560.000000 0.003208 -0.000276 0.004337 -14737 1 0.000202 1560.000000 -0.002958 0.001375 0.005711 -14738 1 0.000240 1560.000000 -0.001956 0.003200 0.001471 -14739 1 0.000225 1560.000000 -0.001871 0.002798 0.009347 -14740 1 0.000216 1560.000000 0.000105 0.002148 0.008108 -14741 1 0.000206 1560.000000 0.003659 -0.000240 0.007082 -14742 1 0.000209 1560.000000 -0.000414 0.001919 0.003167 -14743 1 0.000279 1560.000000 0.002450 0.001372 0.009503 -14744 1 0.000222 1560.000000 -0.000537 0.002678 0.002845 -14745 1 0.000228 1560.000000 0.002169 0.003104 0.000735 -14746 1 0.000226 1560.000000 -0.002214 0.000565 0.007025 -14747 1 0.000252 1560.000000 0.002268 -0.001326 0.005573 -14748 1 0.000214 1560.000000 0.001348 0.001137 0.005486 -14749 1 0.000243 1560.000000 0.000309 0.002140 0.003993 -14750 1 0.000256 1560.000000 -0.003253 -0.001748 0.009787 -14751 1 0.000222 1560.000000 -0.000983 -0.003724 0.007894 -14752 1 0.000235 1560.000000 0.000990 0.001302 0.000163 -14753 1 0.000227 1560.000000 -0.002310 -0.003084 0.001155 -14754 1 0.000250 1560.000000 -0.000696 0.001157 0.005661 -14755 1 0.000242 1560.000000 -0.002181 0.001600 0.002015 -14756 1 0.000225 1560.000000 0.003068 -0.000849 0.007879 -14757 1 0.000278 1560.000000 -0.002927 0.000859 0.002173 -14758 1 0.000244 1560.000000 -0.000486 0.002085 0.005874 -14759 1 0.000222 1560.000000 0.000480 -0.001491 0.008420 -14760 1 0.000239 1560.000000 -0.001094 0.003232 0.001706 -14761 1 0.000238 1560.000000 -0.003552 0.001192 0.003413 -14762 1 0.000215 1560.000000 0.002348 0.000146 0.007627 -14763 1 0.000240 1560.000000 0.001399 -0.000204 0.000653 -14764 1 0.000198 1560.000000 -0.002266 -0.001630 0.001631 -14765 1 0.000250 1560.000000 0.002602 -0.000236 0.003509 -14766 1 0.000251 1560.000000 0.001004 0.003338 0.006711 -14767 1 0.000274 1560.000000 -0.000162 0.003233 0.003016 -14768 1 0.000251 1560.000000 -0.001043 -0.000478 0.001259 -14769 1 0.000251 1560.000000 -0.002658 0.002217 0.001383 -14770 1 0.000223 1560.000000 0.000995 0.002219 0.002130 -14771 1 0.000243 1560.000000 0.002925 0.002276 0.003234 -14772 1 0.000231 1560.000000 -0.003623 -0.001198 0.002004 -14773 1 0.000237 1560.000000 -0.001425 -0.000788 0.004347 -14774 1 0.000287 1560.000000 0.003439 -0.000085 0.003148 -14775 1 0.000213 1560.000000 -0.000036 0.000272 0.003723 -14776 1 0.000221 1560.000000 0.001407 0.001412 0.003720 -14777 1 0.000198 1560.000000 0.002533 0.001940 0.002898 -14778 1 0.000224 1560.000000 0.001732 0.000481 0.007124 -14779 1 0.000193 1560.000000 -0.002093 0.002932 0.002520 -14780 1 0.000203 1560.000000 0.001835 0.002310 0.000188 -14781 1 0.000254 1560.000000 0.000079 -0.000981 0.009262 -14782 1 0.000204 1560.000000 -0.002639 0.001723 0.004712 -14783 1 0.000220 1560.000000 0.002820 0.002170 0.006705 -14784 1 0.000262 1560.000000 -0.001980 -0.001151 0.004041 -14785 1 0.000212 1560.000000 -0.002502 -0.000082 0.005685 -14786 1 0.000270 1560.000000 -0.002811 -0.000795 0.008224 -14787 1 0.000278 1560.000000 0.001389 0.003510 0.005930 -14788 1 0.000218 1560.000000 -0.000684 -0.001044 0.008858 -14789 1 0.000227 1560.000000 0.002075 -0.001133 0.008860 -14790 1 0.000227 1560.000000 -0.000582 -0.003749 0.009718 -14791 1 0.000208 1560.000000 0.002314 0.001938 0.006666 -14792 1 0.000193 1560.000000 0.000251 -0.002161 0.003450 -14793 1 0.000226 1560.000000 -0.001264 -0.002310 0.003781 -14794 1 0.000192 1560.000000 0.001000 -0.003540 0.003627 -14795 1 0.000199 1560.000000 0.000423 0.000594 0.001669 -14796 1 0.000224 1560.000000 0.002574 -0.001663 0.003910 -14797 1 0.000227 1560.000000 -0.001647 0.003255 0.002557 -14798 1 0.000198 1560.000000 -0.000936 -0.003055 0.003170 -14799 1 0.000245 1560.000000 0.000429 0.001410 0.005979 -14800 1 0.000197 1560.000000 -0.002146 0.001096 0.006721 -14801 1 0.000194 1560.000000 0.000784 0.002368 0.000358 -14802 1 0.000221 1560.000000 -0.001425 -0.002543 0.008190 -14803 1 0.000201 1560.000000 0.001837 0.002138 0.007613 -14804 1 0.000224 1560.000000 0.001213 -0.000148 0.009517 -14805 1 0.000259 1560.000000 0.000656 0.003116 0.006176 -14806 1 0.000228 1560.000000 -0.002109 0.001589 0.009082 -14807 1 0.000220 1560.000000 -0.001616 -0.000954 0.006997 -14808 1 0.000223 1560.000000 0.001345 0.001740 0.003361 -14809 1 0.000218 1560.000000 0.003035 -0.002115 0.002471 -14810 1 0.000195 1560.000000 -0.000863 -0.002658 0.004820 -14811 1 0.000246 1560.000000 -0.000091 0.003622 0.003160 -14812 1 0.000261 1560.000000 -0.001032 -0.000971 0.007191 -14813 1 0.000246 1560.000000 0.001626 0.002293 0.009527 -14814 1 0.000206 1560.000000 0.003304 0.001336 0.008377 -14815 1 0.000240 1560.000000 -0.003006 -0.002382 0.003962 -14816 1 0.000232 1560.000000 -0.000894 0.003170 0.003029 -14817 1 0.000211 1560.000000 -0.001656 -0.002754 0.005352 -14818 1 0.000217 1560.000000 0.000082 -0.003076 0.001543 -14819 1 0.000267 1560.000000 -0.003401 -0.001758 0.004836 -14820 1 0.000202 1560.000000 0.002011 0.002997 0.008462 -14821 1 0.000228 1560.000000 0.000768 -0.002318 0.006853 -14822 1 0.000260 1560.000000 -0.002849 0.002246 0.005024 -14823 1 0.000212 1560.000000 0.003231 0.000596 0.007922 -14824 1 0.000202 1560.000000 -0.001074 0.001440 0.006558 -14825 1 0.000196 1560.000000 -0.001181 0.003427 0.004459 -14826 1 0.000208 1560.000000 0.003266 0.001064 0.003234 -14827 1 0.000247 1560.000000 0.002965 -0.000131 0.004250 -14828 1 0.000221 1560.000000 0.001847 0.000330 0.006061 -14829 1 0.000270 1560.000000 0.000147 0.001996 0.003391 -14830 1 0.000199 1560.000000 0.000176 0.001713 0.003452 -14831 1 0.000227 1560.000000 0.001530 0.000952 0.005481 -14832 1 0.000211 1560.000000 0.002258 0.002490 0.004906 -14833 1 0.000199 1560.000000 -0.000011 -0.001558 0.008478 -14834 1 0.000206 1560.000000 0.000910 -0.003269 0.001731 -14835 1 0.000254 1560.000000 0.001014 -0.001952 0.002998 -14836 1 0.000250 1560.000000 -0.001224 -0.001569 0.006416 -14837 1 0.000212 1560.000000 -0.000579 0.001427 0.002677 -14838 1 0.000256 1560.000000 -0.001238 0.002298 0.006297 -14839 1 0.000226 1560.000000 -0.000736 0.000925 0.001529 -14840 1 0.000206 1560.000000 0.001342 0.001539 0.005603 -14841 1 0.000196 1560.000000 -0.000874 0.003336 0.002559 -14842 1 0.000283 1560.000000 -0.000523 0.001163 0.004040 -14843 1 0.000230 1560.000000 -0.001504 -0.002141 0.004499 -14844 1 0.000241 1560.000000 0.001785 -0.000815 0.001544 -14845 1 0.000200 1560.000000 -0.002049 -0.002786 0.008509 -14846 1 0.000219 1560.000000 -0.002095 -0.000423 0.004769 -14847 1 0.000240 1560.000000 0.003004 -0.000481 0.000497 -14848 1 0.000233 1560.000000 0.001204 -0.001682 0.002120 -14849 1 0.000193 1560.000000 0.002995 -0.002325 0.009121 -14850 1 0.000200 1560.000000 0.000385 0.000821 0.008431 -14851 1 0.000249 1560.000000 0.002657 0.000544 0.000695 -14852 1 0.000194 1560.000000 -0.002488 -0.002813 0.002162 -14853 1 0.000210 1560.000000 -0.001466 0.000471 0.008079 -14854 1 0.000198 1560.000000 0.000971 0.000405 0.006058 -14855 1 0.000193 1560.000000 -0.002873 0.001727 0.005907 -14856 1 0.000256 1560.000000 -0.002191 0.001768 0.000502 -14857 1 0.000258 1560.000000 -0.000238 0.000319 0.007244 -14858 1 0.000215 1560.000000 0.002704 0.000276 0.006857 -14859 1 0.000258 1560.000000 0.001618 -0.003217 0.000659 -14860 1 0.000225 1560.000000 -0.001713 0.000422 0.007870 -14861 1 0.000202 1560.000000 0.002788 0.001005 0.002504 -14862 1 0.000196 1560.000000 0.000647 0.002463 0.001257 -14863 1 0.000226 1560.000000 -0.002150 0.001270 0.003802 -14864 1 0.000226 1560.000000 0.000123 -0.002961 0.005698 -14865 1 0.000223 1560.000000 0.002636 -0.002216 0.007727 -14866 1 0.000218 1560.000000 -0.000103 0.001094 0.009778 -14867 1 0.000206 1560.000000 -0.001455 0.000630 0.002913 -14868 1 0.000224 1560.000000 0.001300 -0.002395 0.006801 -14869 1 0.000264 1560.000000 -0.003168 0.000048 0.004135 -14870 1 0.000231 1560.000000 -0.001708 0.000403 0.006321 -14871 1 0.000238 1560.000000 -0.000764 0.001617 0.008154 -14872 1 0.000208 1560.000000 -0.001125 0.003536 0.006976 -14873 1 0.000225 1560.000000 0.001622 0.000210 0.000717 -14874 1 0.000259 1560.000000 -0.003359 0.001002 0.004797 -14875 1 0.000245 1560.000000 0.002136 0.000279 0.003007 -14876 1 0.000202 1560.000000 -0.001245 0.001671 0.002840 -14877 1 0.000196 1560.000000 0.000690 -0.000663 0.006697 -14878 1 0.000237 1560.000000 -0.000982 0.000462 0.003966 -14879 1 0.000262 1560.000000 0.002327 0.002845 0.009344 -14880 1 0.000215 1560.000000 0.002431 -0.000130 0.007012 -14881 1 0.000205 1560.000000 -0.001478 -0.001669 0.007170 -14882 1 0.000253 1560.000000 -0.001519 0.003017 0.008107 -14883 1 0.000279 1560.000000 0.001847 0.000657 0.009637 -14884 1 0.000208 1560.000000 0.000508 -0.001241 0.007627 -14885 1 0.000222 1560.000000 -0.002894 -0.001165 0.001663 -14886 1 0.000245 1560.000000 -0.002896 0.001535 0.009519 -14887 1 0.000198 1560.000000 -0.002118 0.000940 0.005220 -14888 1 0.000258 1560.000000 0.000262 0.002144 0.009007 -14889 1 0.000275 1560.000000 -0.002344 0.002028 0.001456 -14890 1 0.000210 1560.000000 -0.001968 -0.001537 0.009080 -14891 1 0.000212 1560.000000 -0.001736 0.000986 0.001800 -14892 1 0.000195 1560.000000 0.000101 -0.003222 0.001076 -14893 1 0.000221 1560.000000 -0.003381 0.000735 0.005032 -14894 1 0.000258 1560.000000 0.003576 0.001230 0.006467 -14895 1 0.000195 1560.000000 -0.003155 0.001184 0.007945 -14896 1 0.000208 1560.000000 -0.000294 0.001892 0.002124 -14897 1 0.000226 1560.000000 0.002448 -0.002959 0.000969 -14898 1 0.000253 1560.000000 0.000846 -0.002714 0.003807 -14899 1 0.000209 1560.000000 -0.000319 -0.002066 0.009393 -14900 1 0.000193 1560.000000 -0.003103 0.000634 0.003402 -14901 1 0.000218 1560.000000 0.003573 0.001197 0.006144 -14902 1 0.000204 1560.000000 -0.002133 -0.001706 0.007938 -14903 1 0.000216 1560.000000 -0.002814 0.002345 0.002531 -14904 1 0.000218 1560.000000 -0.001783 -0.000441 0.003684 -14905 1 0.000281 1560.000000 -0.001462 0.003160 0.009812 -14906 1 0.000211 1560.000000 -0.000990 -0.003082 0.001083 -14907 1 0.000252 1560.000000 0.001482 0.003157 0.002753 -14908 1 0.000219 1560.000000 0.000639 0.001047 0.004798 -14909 1 0.000218 1560.000000 -0.001418 -0.002644 0.004956 -14910 1 0.000254 1560.000000 0.002473 0.002393 0.007226 -14911 1 0.000241 1560.000000 -0.000458 0.003809 0.006641 -14912 1 0.000209 1560.000000 0.002929 0.002484 0.000151 -14913 1 0.000267 1560.000000 -0.001581 -0.001667 0.005767 -14914 1 0.000219 1560.000000 -0.001038 -0.001189 0.000603 -14915 1 0.000267 1560.000000 0.000779 0.002643 0.007826 -14916 1 0.000222 1560.000000 0.000667 0.001456 0.001864 -14917 1 0.000195 1560.000000 0.002452 -0.002847 0.006530 -14918 1 0.000226 1560.000000 -0.001225 -0.000391 0.004779 -14919 1 0.000278 1560.000000 0.003700 0.000610 0.007581 -14920 1 0.000195 1560.000000 -0.001846 0.002075 0.000614 -14921 1 0.000245 1560.000000 0.001723 0.000812 0.005523 -14922 1 0.000280 1560.000000 -0.003505 -0.000220 0.007973 -14923 1 0.000262 1560.000000 0.001429 0.002228 0.000138 -14924 1 0.000207 1560.000000 0.001068 0.003081 0.008886 -14925 1 0.000249 1560.000000 -0.000057 0.000910 0.002007 -14926 1 0.000193 1560.000000 -0.002341 0.001279 0.001316 -14927 1 0.000208 1560.000000 0.002621 -0.001713 0.002705 -14928 1 0.000200 1560.000000 0.001327 0.000610 0.008433 -14929 1 0.000280 1560.000000 0.003475 0.001555 0.008655 -14930 1 0.000201 1560.000000 0.003338 -0.001767 0.007013 -14931 1 0.000250 1560.000000 -0.000464 -0.002167 0.007449 -14932 1 0.000210 1560.000000 -0.001490 0.002041 0.003118 -14933 1 0.000217 1560.000000 0.000135 0.002487 0.004159 -14934 1 0.000193 1560.000000 0.001537 -0.001059 0.006638 -14935 1 0.000206 1560.000000 0.000591 0.000418 0.000996 -14936 1 0.000208 1560.000000 0.000515 -0.000432 0.008482 -14937 1 0.000233 1560.000000 -0.002652 -0.000693 0.001850 -14938 1 0.000254 1560.000000 0.002941 0.001120 0.004597 -14939 1 0.000201 1560.000000 -0.001322 -0.000431 0.008047 -14940 1 0.000255 1560.000000 0.000250 -0.003420 0.001269 -14941 1 0.000266 1560.000000 -0.000261 -0.003077 0.001459 -14942 1 0.000218 1560.000000 0.000168 -0.000108 0.007874 -14943 1 0.000262 1560.000000 0.003030 0.001707 0.009112 -14944 1 0.000264 1560.000000 0.000347 -0.003742 0.006629 -14945 1 0.000218 1560.000000 0.000481 0.001019 0.009809 -14946 1 0.000231 1560.000000 0.003181 0.001781 0.000804 -14947 1 0.000197 1560.000000 -0.002395 0.001428 0.009554 -14948 1 0.000240 1560.000000 -0.003134 -0.001988 0.008132 -14949 1 0.000278 1560.000000 -0.000810 0.002593 0.004131 -14950 1 0.000272 1560.000000 -0.003145 0.001758 0.001331 -14951 1 0.000248 1560.000000 -0.002517 -0.001753 0.008577 -14952 1 0.000257 1560.000000 -0.003050 -0.002264 0.004271 -14953 1 0.000282 1560.000000 -0.002610 -0.002216 0.006144 -14954 1 0.000221 1560.000000 -0.002106 -0.000622 0.004152 -14955 1 0.000255 1560.000000 -0.003070 -0.001058 0.003181 -14956 1 0.000210 1560.000000 0.000221 -0.001158 0.001937 -14957 1 0.000195 1560.000000 0.000825 0.003124 0.002764 -14958 1 0.000247 1560.000000 -0.002901 0.001757 0.000749 -14959 1 0.000281 1560.000000 0.001662 0.002664 0.008927 -14960 1 0.000262 1560.000000 0.000026 0.003679 0.007105 -14961 1 0.000207 1560.000000 -0.002138 0.002823 0.009524 -14962 1 0.000206 1560.000000 -0.002338 0.000164 0.008227 -14963 1 0.000245 1560.000000 0.000557 -0.003186 0.008827 -14964 1 0.000211 1560.000000 0.000171 0.002165 0.006364 -14965 1 0.000228 1560.000000 0.002898 0.001575 0.000932 -14966 1 0.000201 1560.000000 -0.000145 -0.003790 0.002171 -14967 1 0.000208 1560.000000 0.003154 -0.001701 0.007672 -14968 1 0.000282 1560.000000 0.003239 0.001424 0.007332 -14969 1 0.000213 1560.000000 -0.003168 -0.002037 0.004228 -14970 1 0.000262 1560.000000 0.000549 0.003536 0.003612 -14971 1 0.000215 1560.000000 -0.002760 -0.002405 0.009238 -14972 1 0.000192 1560.000000 -0.002550 0.002758 0.005466 -14973 1 0.000198 1560.000000 -0.000888 0.000894 0.009101 -14974 1 0.000283 1560.000000 0.001090 0.002973 0.001480 -14975 1 0.000201 1560.000000 0.002365 -0.002100 0.005544 -14976 1 0.000205 1560.000000 -0.000731 -0.001494 0.002672 -14977 1 0.000240 1560.000000 0.001133 -0.001229 0.003062 -14978 1 0.000266 1560.000000 -0.003221 0.001690 0.000769 -14979 1 0.000197 1560.000000 -0.000751 0.002916 0.006268 -14980 1 0.000288 1560.000000 0.000322 -0.003690 0.004171 -14981 1 0.000223 1560.000000 0.000242 0.002411 0.004364 -14982 1 0.000194 1560.000000 -0.001593 -0.003059 0.008577 -14983 1 0.000207 1560.000000 -0.001387 0.000001 0.004569 -14984 1 0.000259 1560.000000 0.001935 -0.000657 0.007965 -14985 1 0.000245 1560.000000 0.002057 0.001239 0.007760 -14986 1 0.000236 1560.000000 0.002386 -0.002848 0.003462 -14987 1 0.000201 1560.000000 -0.000239 0.001634 0.002157 -14988 1 0.000232 1560.000000 0.002372 0.001454 0.003865 -14989 1 0.000226 1560.000000 0.000815 -0.001922 0.008747 -14990 1 0.000277 1560.000000 -0.002684 0.001168 0.001005 -14991 1 0.000208 1560.000000 0.002929 -0.000299 0.008137 -14992 1 0.000279 1560.000000 -0.000975 0.002234 0.001382 -14993 1 0.000245 1560.000000 -0.000812 0.001416 0.008352 -14994 1 0.000211 1560.000000 -0.000110 0.001252 0.006842 -14995 1 0.000192 1560.000000 0.001116 -0.003599 0.002328 -14996 1 0.000207 1560.000000 -0.000585 -0.000933 0.001797 -14997 1 0.000221 1560.000000 -0.001026 0.001369 0.005377 -14998 1 0.000269 1560.000000 0.001073 0.003145 0.003979 -14999 1 0.000218 1560.000000 0.001647 0.000613 0.004335 -15000 1 0.000202 1560.000000 0.002589 0.001966 0.001600 -15001 1 0.000215 1560.000000 0.000156 0.003820 0.001839 -15002 1 0.000253 1560.000000 -0.002854 -0.002069 0.007618 -15003 1 0.000224 1560.000000 0.002147 0.001495 0.005829 -15004 1 0.000229 1560.000000 0.003412 0.001391 0.002992 -15005 1 0.000224 1560.000000 0.001255 -0.002987 0.002144 -15006 1 0.000238 1560.000000 0.002192 -0.000478 0.009636 -15007 1 0.000204 1560.000000 0.000926 0.001546 0.009112 -15008 1 0.000277 1560.000000 -0.001051 0.002286 0.004441 -15009 1 0.000207 1560.000000 0.002478 -0.000231 0.003831 -15010 1 0.000281 1560.000000 0.000502 -0.001401 0.002675 -15011 1 0.000195 1560.000000 -0.000836 0.000162 0.009010 -15012 1 0.000250 1560.000000 -0.002101 -0.001852 0.007378 -15013 1 0.000202 1560.000000 -0.002308 -0.001939 0.008069 -15014 1 0.000208 1560.000000 -0.001685 -0.002394 0.003345 -15015 1 0.000224 1560.000000 0.001433 -0.002908 0.008035 -15016 1 0.000197 1560.000000 -0.003204 0.001457 0.008986 -15017 1 0.000202 1560.000000 -0.000588 -0.000409 0.009233 -15018 1 0.000245 1560.000000 -0.003681 -0.000436 0.008885 -15019 1 0.000261 1560.000000 -0.001621 -0.001940 0.006374 -15020 1 0.000233 1560.000000 0.001639 -0.002003 0.005306 -15021 1 0.000242 1560.000000 -0.001377 -0.000406 0.007794 -15022 1 0.000282 1560.000000 0.001223 -0.003312 0.007557 -15023 1 0.000226 1560.000000 -0.002067 0.002955 0.006756 -15024 1 0.000285 1560.000000 0.003180 0.000926 0.009823 -15025 1 0.000193 1560.000000 0.000256 -0.003280 0.001641 -15026 1 0.000260 1560.000000 -0.002577 -0.002852 0.006760 -15027 1 0.000245 1560.000000 0.002724 0.002009 0.008790 -15028 1 0.000248 1560.000000 0.000707 -0.001422 0.002345 -15029 1 0.000267 1560.000000 -0.000007 0.003737 0.006038 -15030 1 0.000225 1560.000000 0.001597 -0.002557 0.004649 -15031 1 0.000230 1560.000000 -0.003078 -0.000605 0.005700 -15032 1 0.000213 1560.000000 -0.003657 0.001158 0.000164 -15033 1 0.000274 1560.000000 0.000966 0.002297 0.009237 -15034 1 0.000218 1560.000000 -0.001016 -0.001553 0.000964 -15035 1 0.000202 1560.000000 -0.000514 -0.000084 0.002774 -15036 1 0.000246 1560.000000 -0.001698 0.001308 0.006691 -15037 1 0.000265 1560.000000 0.000030 0.003018 0.005916 -15038 1 0.000205 1560.000000 0.000827 -0.003238 0.006367 -15039 1 0.000229 1560.000000 -0.002083 -0.000660 0.007487 -15040 1 0.000252 1560.000000 0.001655 -0.003378 0.003571 -15041 1 0.000245 1560.000000 0.000665 0.003713 0.000470 -15042 1 0.000279 1560.000000 0.000448 -0.003765 0.009792 -15043 1 0.000192 1560.000000 -0.000476 -0.002064 0.000143 -15044 1 0.000213 1560.000000 -0.000547 -0.003518 0.006027 -15045 1 0.000212 1560.000000 0.000593 0.000833 0.004625 -15046 1 0.000223 1560.000000 0.002019 -0.001867 0.005336 -15047 1 0.000229 1560.000000 -0.001769 0.002606 0.007700 -15048 1 0.000216 1560.000000 -0.003115 -0.000788 0.002839 -15049 1 0.000225 1560.000000 -0.002006 -0.000184 0.008070 -15050 1 0.000212 1560.000000 -0.002691 0.001156 0.002347 -15051 1 0.000203 1560.000000 -0.002591 -0.002124 0.009155 -15052 1 0.000208 1560.000000 0.001889 -0.001603 0.004463 -15053 1 0.000222 1560.000000 -0.000861 -0.001859 0.009482 -15054 1 0.000194 1560.000000 -0.000774 0.001360 0.003547 -15055 1 0.000229 1560.000000 -0.000923 -0.000772 0.004680 -15056 1 0.000270 1560.000000 -0.002696 0.002244 0.005835 -15057 1 0.000228 1560.000000 0.001972 0.002552 0.006141 -15058 1 0.000237 1560.000000 0.003303 0.001846 0.005675 -15059 1 0.000240 1560.000000 -0.003830 0.000267 0.001742 -15060 1 0.000277 1560.000000 0.002073 0.001266 0.000842 -15061 1 0.000230 1560.000000 -0.002603 -0.002824 0.007372 -15062 1 0.000208 1560.000000 0.001530 -0.000165 0.002666 -15063 1 0.000196 1560.000000 -0.002290 -0.001245 0.007999 -15064 1 0.000264 1560.000000 0.003361 0.000189 0.003009 -15065 1 0.000212 1560.000000 0.001418 0.002713 0.009393 -15066 1 0.000234 1560.000000 -0.000128 -0.003852 0.003165 -15067 1 0.000240 1560.000000 0.002742 0.001414 0.000199 -15068 1 0.000192 1560.000000 -0.001185 0.000101 0.004980 -15069 1 0.000195 1560.000000 0.001502 -0.002786 0.002865 -15070 1 0.000277 1560.000000 -0.002409 0.002550 0.002170 -15071 1 0.000269 1560.000000 0.002757 0.002620 0.009004 -15072 1 0.000211 1560.000000 -0.000972 -0.002246 0.005909 -15073 1 0.000229 1560.000000 -0.001603 -0.003373 0.001297 -15074 1 0.000268 1560.000000 -0.000357 0.002735 0.008402 -15075 1 0.000283 1560.000000 -0.002002 -0.002743 0.006797 -15076 1 0.000215 1560.000000 -0.000555 -0.003040 0.009741 -15077 1 0.000245 1560.000000 -0.000763 -0.003100 0.007260 -15078 1 0.000288 1560.000000 -0.001847 0.001607 0.004264 -15079 1 0.000204 1560.000000 0.002930 -0.002292 0.004263 -15080 1 0.000203 1560.000000 -0.000926 -0.001205 0.005441 -15081 1 0.000247 1560.000000 -0.002496 -0.002096 0.002091 -15082 1 0.000267 1560.000000 -0.001890 0.001279 0.001038 -15083 1 0.000209 1560.000000 0.002598 0.001233 0.003334 -15084 1 0.000209 1560.000000 -0.003773 0.000291 0.003214 -15085 1 0.000209 1560.000000 -0.000691 0.002394 0.001405 -15086 1 0.000235 1560.000000 -0.003768 -0.000696 0.008235 -15087 1 0.000224 1560.000000 0.003154 -0.002037 0.009715 -15088 1 0.000223 1560.000000 0.002050 0.000355 0.002555 -15089 1 0.000218 1560.000000 -0.000035 0.000118 0.006525 -15090 1 0.000261 1560.000000 0.000275 -0.000995 0.008464 -15091 1 0.000229 1560.000000 0.001230 0.001958 0.006436 -15092 1 0.000200 1560.000000 -0.000675 -0.000310 0.008072 -15093 1 0.000221 1560.000000 -0.000304 0.000763 0.004308 -15094 1 0.000281 1560.000000 -0.000876 -0.001641 0.009687 -15095 1 0.000222 1560.000000 -0.000196 -0.002243 0.005488 -15096 1 0.000243 1560.000000 0.001312 -0.000738 0.006298 -15097 1 0.000203 1560.000000 -0.002769 0.001721 0.003668 -15098 1 0.000277 1560.000000 -0.001623 -0.001355 0.005922 -15099 1 0.000207 1560.000000 0.001224 0.001565 0.000563 -15100 1 0.000261 1560.000000 0.001529 0.000152 0.006304 -15101 1 0.000251 1560.000000 -0.000896 0.002931 0.008675 -15102 1 0.000194 1560.000000 0.002686 0.001701 0.009631 -15103 1 0.000197 1560.000000 -0.000769 -0.002133 0.007378 -15104 1 0.000194 1560.000000 -0.002306 -0.002916 0.004438 -15105 1 0.000197 1560.000000 0.001733 -0.003181 0.001024 -15106 1 0.000276 1560.000000 -0.003368 0.001138 0.009176 -15107 1 0.000219 1560.000000 0.002934 0.001027 0.006059 -15108 1 0.000248 1560.000000 0.000602 -0.002418 0.004146 -15109 1 0.000203 1560.000000 0.001646 -0.001518 0.004574 -15110 1 0.000205 1560.000000 0.000656 0.001270 0.003851 -15111 1 0.000279 1560.000000 -0.001927 -0.001612 0.007207 -15112 1 0.000198 1560.000000 -0.001606 -0.003231 0.003592 -15113 1 0.000235 1560.000000 -0.003558 -0.000154 0.006663 -15114 1 0.000275 1560.000000 0.003071 -0.000693 0.003222 -15115 1 0.000267 1560.000000 -0.003843 0.000253 0.001042 -15116 1 0.000204 1560.000000 0.002202 0.000046 0.008584 -15117 1 0.000268 1560.000000 0.000839 0.002775 0.005678 -15118 1 0.000213 1560.000000 -0.002119 -0.002344 0.006330 -15119 1 0.000219 1560.000000 -0.003209 -0.001307 0.008504 -15120 1 0.000196 1560.000000 0.002794 -0.002588 0.005488 -15121 1 0.000197 1560.000000 0.002432 -0.000350 0.001848 -15122 1 0.000238 1560.000000 -0.002587 0.001490 0.000181 -15123 1 0.000246 1560.000000 -0.003152 0.000120 0.004517 -15124 1 0.000280 1560.000000 0.002956 0.000181 0.008136 -15125 1 0.000279 1560.000000 -0.001785 0.002533 0.001508 -15126 1 0.000242 1560.000000 -0.002732 0.001237 0.002629 -15127 1 0.000247 1560.000000 0.003844 0.000220 0.002298 -15128 1 0.000245 1560.000000 0.001574 -0.002272 0.001713 -15129 1 0.000194 1560.000000 0.000681 -0.000212 0.005200 -15130 1 0.000194 1560.000000 -0.001450 0.001643 0.007471 -15131 1 0.000206 1560.000000 -0.000037 -0.000693 0.005105 -15132 1 0.000199 1560.000000 0.002457 0.001420 0.008690 -15133 1 0.000279 1560.000000 0.003158 -0.002171 0.008262 -15134 1 0.000201 1560.000000 0.001350 0.000025 0.003650 -15135 1 0.000239 1560.000000 -0.001364 -0.003545 0.008020 -15136 1 0.000240 1560.000000 -0.002997 0.000786 0.001928 -15137 1 0.000226 1560.000000 0.000147 0.002242 0.000341 -15138 1 0.000228 1560.000000 0.001264 0.002909 0.004577 -15139 1 0.000264 1560.000000 -0.001088 -0.001360 0.005169 -15140 1 0.000220 1560.000000 -0.000333 0.001860 0.000541 -15141 1 0.000257 1560.000000 -0.003042 -0.000957 0.001643 -15142 1 0.000279 1560.000000 0.002030 0.000003 0.003225 -15143 1 0.000254 1560.000000 -0.001475 0.002604 0.004842 -15144 1 0.000225 1560.000000 -0.002817 -0.001952 0.003902 -15145 1 0.000216 1560.000000 0.002565 -0.001964 0.009379 -15146 1 0.000243 1560.000000 -0.001874 -0.000017 0.009589 -15147 1 0.000215 1560.000000 -0.003077 0.001751 0.002452 -15148 1 0.000204 1560.000000 0.001508 -0.001542 0.003414 -15149 1 0.000225 1560.000000 0.002195 0.000758 0.006864 -15150 1 0.000231 1560.000000 -0.003560 -0.001283 0.000720 -15151 1 0.000216 1560.000000 -0.000065 -0.002625 0.008728 -15152 1 0.000250 1560.000000 0.001282 0.001321 0.003923 -15153 1 0.000203 1560.000000 0.002100 -0.002223 0.003922 -15154 1 0.000212 1560.000000 0.002728 0.000025 0.008897 -15155 1 0.000267 1560.000000 0.003700 -0.000169 0.003276 -15156 1 0.000220 1560.000000 0.001423 0.001348 0.006290 -15157 1 0.000235 1560.000000 -0.001812 -0.003079 0.002263 -15158 1 0.000239 1560.000000 0.002374 -0.001192 0.002658 -15159 1 0.000253 1560.000000 0.002436 0.002891 0.009781 -15160 1 0.000195 1560.000000 -0.000829 0.003178 0.007471 -15161 1 0.000248 1560.000000 -0.000334 0.003722 0.002778 -15162 1 0.000196 1560.000000 -0.000443 0.002808 0.007740 -15163 1 0.000226 1560.000000 0.002747 -0.001718 0.001521 -15164 1 0.000222 1560.000000 0.000223 -0.000971 0.006412 -15165 1 0.000222 1560.000000 0.003012 -0.000948 0.008420 -15166 1 0.000218 1560.000000 0.000350 0.000934 0.004896 -15167 1 0.000219 1560.000000 0.003305 0.001492 0.001028 -15168 1 0.000257 1560.000000 0.003804 0.000533 0.008529 -15169 1 0.000288 1560.000000 0.001681 0.001984 0.002075 -15170 1 0.000227 1560.000000 0.001679 0.000482 0.003205 -15171 1 0.000272 1560.000000 -0.001350 0.001198 0.002917 -15172 1 0.000247 1560.000000 0.002912 0.000142 0.001545 -15173 1 0.000208 1560.000000 0.001216 0.000692 0.007490 -15174 1 0.000227 1560.000000 0.002383 -0.000792 0.007584 -15175 1 0.000259 1560.000000 0.003032 0.001377 0.001426 -15176 1 0.000255 1560.000000 -0.003033 0.000745 0.000216 -15177 1 0.000272 1560.000000 0.002448 -0.002414 0.003832 -15178 1 0.000280 1560.000000 0.000548 -0.001882 0.008158 -15179 1 0.000248 1560.000000 0.002617 -0.000183 0.001629 -15180 1 0.000287 1560.000000 -0.001675 0.001502 0.001141 -15181 1 0.000277 1560.000000 0.000228 0.002912 0.002644 -15182 1 0.000199 1560.000000 0.000766 0.001092 0.007232 -15183 1 0.000247 1560.000000 0.002052 0.000308 0.003552 -15184 1 0.000200 1560.000000 -0.003277 0.001959 0.009591 -15185 1 0.000276 1560.000000 0.003445 0.000739 0.007721 -15186 1 0.000234 1560.000000 -0.002497 0.001433 0.006898 -15187 1 0.000242 1560.000000 -0.000042 -0.003295 0.009538 -15188 1 0.000274 1560.000000 -0.001227 -0.002252 0.002323 -15189 1 0.000207 1560.000000 0.002600 -0.000201 0.000838 -15190 1 0.000216 1560.000000 -0.001727 0.001782 0.005297 -15191 1 0.000214 1560.000000 -0.003178 0.001873 0.009227 -15192 1 0.000241 1560.000000 0.000703 0.000840 0.000375 -15193 1 0.000209 1560.000000 0.001681 -0.000241 0.003633 -15194 1 0.000202 1560.000000 0.002310 0.003066 0.000949 -15195 1 0.000263 1560.000000 -0.002650 -0.000386 0.002836 -15196 1 0.000233 1560.000000 0.002034 -0.002689 0.009034 -15197 1 0.000202 1560.000000 0.001109 -0.001631 0.002922 -15198 1 0.000218 1560.000000 -0.001052 0.001015 0.005530 -15199 1 0.000205 1560.000000 -0.002332 -0.000379 0.005303 -15200 1 0.000242 1560.000000 0.002901 -0.001327 0.002707 -15201 1 0.000250 1560.000000 0.000196 0.002051 0.002022 -15202 1 0.000271 1560.000000 0.002266 -0.002402 0.000963 -15203 1 0.000265 1560.000000 0.000901 -0.003420 0.007488 -15204 1 0.000255 1560.000000 -0.003114 -0.000673 0.002511 -15205 1 0.000255 1560.000000 0.001451 0.001898 0.003563 -15206 1 0.000207 1560.000000 0.002677 -0.002350 0.007445 -15207 1 0.000233 1560.000000 -0.002440 0.000643 0.004060 -15208 1 0.000272 1560.000000 -0.000683 -0.002030 0.000325 -15209 1 0.000214 1560.000000 0.002997 -0.002222 0.009444 -15210 1 0.000193 1560.000000 -0.001428 -0.001761 0.000440 -15211 1 0.000217 1560.000000 0.002463 -0.000779 0.000407 -15212 1 0.000263 1560.000000 -0.000814 -0.002524 0.006740 -15213 1 0.000197 1560.000000 -0.001076 0.002507 0.002753 -15214 1 0.000220 1560.000000 0.002330 -0.000102 0.005552 -15215 1 0.000232 1560.000000 0.001069 -0.002190 0.003729 -15216 1 0.000203 1560.000000 -0.003012 -0.001526 0.006696 -15217 1 0.000230 1560.000000 0.001611 -0.001268 0.009173 -15218 1 0.000266 1560.000000 0.002084 -0.003235 0.007379 -15219 1 0.000246 1560.000000 -0.000637 -0.000434 0.000141 -15220 1 0.000199 1560.000000 0.001284 0.002078 0.001509 -15221 1 0.000222 1560.000000 -0.000537 -0.001626 0.009753 -15222 1 0.000201 1560.000000 -0.003343 -0.000943 0.007885 -15223 1 0.000217 1560.000000 -0.001380 0.001813 0.006847 -15224 1 0.000262 1560.000000 -0.000364 -0.003432 0.003277 -15225 1 0.000278 1560.000000 0.001722 0.002188 0.000520 -15226 1 0.000202 1560.000000 -0.000301 0.000057 0.002417 -15227 1 0.000286 1560.000000 0.002624 0.002802 0.001561 -15228 1 0.000229 1560.000000 0.002020 -0.002587 0.003764 -15229 1 0.000212 1560.000000 -0.000249 -0.002373 0.007741 -15230 1 0.000245 1560.000000 0.003677 -0.000985 0.000821 -15231 1 0.000280 1560.000000 -0.001726 0.000637 0.000264 -15232 1 0.000254 1560.000000 0.002359 -0.000194 0.004743 -15233 1 0.000252 1560.000000 0.001345 -0.002709 0.003333 -15234 1 0.000257 1560.000000 0.002667 -0.002169 0.003761 -15235 1 0.000229 1560.000000 0.000052 -0.001400 0.000864 -15236 1 0.000283 1560.000000 0.002987 0.002391 0.003939 -15237 1 0.000277 1560.000000 -0.001622 0.000804 0.004833 -15238 1 0.000206 1560.000000 0.000806 -0.003308 0.005865 -15239 1 0.000268 1560.000000 -0.000762 -0.003250 0.005267 -15240 1 0.000198 1560.000000 -0.002254 0.003060 0.006077 -15241 1 0.000229 1560.000000 0.002551 0.002012 0.004574 -15242 1 0.000207 1560.000000 0.002524 0.001588 0.001898 -15243 1 0.000248 1560.000000 -0.001474 -0.002521 0.006511 -15244 1 0.000215 1560.000000 0.003477 0.001545 0.005884 -15245 1 0.000228 1560.000000 -0.002252 -0.000639 0.002205 -15246 1 0.000207 1560.000000 0.000733 -0.001138 0.006050 -15247 1 0.000259 1560.000000 0.000007 -0.001947 0.008939 -15248 1 0.000225 1560.000000 0.001100 -0.001152 0.000711 -15249 1 0.000264 1560.000000 0.001457 -0.001586 0.005306 -15250 1 0.000253 1560.000000 0.001169 0.000265 0.004099 -15251 1 0.000200 1560.000000 0.003656 0.001085 0.003123 -15252 1 0.000197 1560.000000 -0.001688 -0.001612 0.008142 -15253 1 0.000194 1560.000000 -0.002606 -0.001288 0.001148 -15254 1 0.000204 1560.000000 -0.002997 -0.001126 0.005482 -15255 1 0.000228 1560.000000 -0.001748 -0.002471 0.004481 -15256 1 0.000217 1560.000000 -0.001763 -0.002334 0.009587 -15257 1 0.000262 1560.000000 -0.000941 0.003251 0.004725 -15258 1 0.000204 1560.000000 -0.001242 -0.000981 0.001800 -15259 1 0.000224 1560.000000 -0.001724 0.001299 0.001651 -15260 1 0.000265 1560.000000 -0.003223 -0.000656 0.003547 -15261 1 0.000197 1560.000000 0.000383 0.000721 0.005764 -15262 1 0.000281 1560.000000 0.003049 0.001583 0.005491 -15263 1 0.000238 1560.000000 0.000971 -0.000082 0.006200 -15264 1 0.000204 1560.000000 0.002513 0.002352 0.001676 -15265 1 0.000281 1560.000000 -0.001259 -0.002324 0.002753 -15266 1 0.000209 1560.000000 -0.001662 -0.000207 0.005556 -15267 1 0.000233 1560.000000 0.001817 -0.001853 0.003032 -15268 1 0.000250 1560.000000 -0.001812 -0.001254 0.006082 -15269 1 0.000227 1560.000000 0.003383 -0.000224 0.007097 -15270 1 0.000271 1560.000000 0.000449 0.001960 0.005260 -15271 1 0.000281 1560.000000 -0.000383 -0.003706 0.006554 -15272 1 0.000255 1560.000000 -0.003332 0.001362 0.004694 -15273 1 0.000198 1560.000000 -0.001210 -0.002142 0.007366 -15274 1 0.000246 1560.000000 0.003391 -0.001679 0.001303 -15275 1 0.000217 1560.000000 0.002033 -0.001431 0.005707 -15276 1 0.000268 1560.000000 0.000544 -0.002904 0.000751 -15277 1 0.000193 1560.000000 -0.002578 -0.001618 0.007552 -15278 1 0.000220 1560.000000 0.003367 -0.000800 0.007090 -15279 1 0.000280 1560.000000 -0.001520 0.002726 0.000646 -15280 1 0.000248 1560.000000 -0.000903 0.003024 0.001339 -15281 1 0.000193 1560.000000 0.003272 0.000273 0.009494 -15282 1 0.000205 1560.000000 0.003095 0.001782 0.000390 -15283 1 0.000228 1560.000000 -0.002631 -0.001283 0.002549 -15284 1 0.000243 1560.000000 0.002365 -0.000555 0.002304 -15285 1 0.000212 1560.000000 0.001687 0.002396 0.005667 -15286 1 0.000232 1560.000000 -0.001464 0.002188 0.004558 -15287 1 0.000230 1560.000000 -0.003305 -0.001878 0.004089 -15288 1 0.000282 1560.000000 -0.002635 -0.000980 0.003079 -15289 1 0.000200 1560.000000 0.001855 -0.002841 0.000518 -15290 1 0.000205 1560.000000 0.002418 -0.002612 0.000859 -15291 1 0.000209 1560.000000 0.001620 -0.003385 0.009080 -15292 1 0.000270 1560.000000 -0.002627 0.002768 0.000958 -15293 1 0.000224 1560.000000 0.000636 -0.000273 0.005964 -15294 1 0.000210 1560.000000 0.001328 0.002496 0.001581 -15295 1 0.000245 1560.000000 0.001992 -0.002870 0.006445 -15296 1 0.000214 1560.000000 0.001023 0.002926 0.002616 -15297 1 0.000248 1560.000000 -0.002666 -0.001883 0.002546 -15298 1 0.000218 1560.000000 0.003014 0.001106 0.004270 -15299 1 0.000199 1560.000000 -0.002635 0.001888 0.001604 -15300 1 0.000207 1560.000000 0.000831 -0.002485 0.004263 -15301 1 0.000220 1560.000000 -0.002661 -0.000834 0.006729 -15302 1 0.000200 1560.000000 -0.000127 -0.003247 0.006233 -15303 1 0.000222 1560.000000 -0.000981 -0.000340 0.004614 -15304 1 0.000215 1560.000000 0.001336 0.000607 0.007899 -15305 1 0.000209 1560.000000 0.001747 -0.002212 0.002000 -15306 1 0.000233 1560.000000 -0.001687 0.003416 0.002769 -15307 1 0.000204 1560.000000 -0.002032 0.000796 0.002634 -15308 1 0.000247 1560.000000 0.000941 0.001906 0.005676 -15309 1 0.000239 1560.000000 0.002821 -0.000238 0.004423 -15310 1 0.000205 1560.000000 -0.001152 0.001900 0.003035 -15311 1 0.000231 1560.000000 -0.001926 -0.002967 0.009588 -15312 1 0.000272 1560.000000 0.001672 -0.000723 0.004088 -15313 1 0.000224 1560.000000 0.002111 0.002286 0.008963 -15314 1 0.000231 1560.000000 0.001323 -0.003544 0.009428 -15315 1 0.000222 1560.000000 -0.001725 -0.000770 0.001093 -15316 1 0.000219 1560.000000 0.001497 -0.002134 0.003928 -15317 1 0.000252 1560.000000 0.002681 -0.002549 0.007032 -15318 1 0.000214 1560.000000 0.003330 -0.000391 0.007665 -15319 1 0.000208 1560.000000 -0.000623 0.000830 0.004609 -15320 1 0.000273 1560.000000 0.002269 0.002507 0.009501 -15321 1 0.000207 1560.000000 0.003743 0.000782 0.000231 -15322 1 0.000203 1560.000000 -0.002767 -0.002674 0.005495 -15323 1 0.000261 1560.000000 0.002882 -0.002477 0.005810 -15324 1 0.000201 1560.000000 0.001521 0.002022 0.000980 -15325 1 0.000209 1560.000000 -0.000362 -0.003652 0.003972 -15326 1 0.000245 1560.000000 -0.002998 -0.000740 0.004382 -15327 1 0.000213 1560.000000 -0.000896 -0.001433 0.007027 -15328 1 0.000274 1560.000000 0.003799 0.000519 0.003146 -15329 1 0.000227 1560.000000 0.001644 0.003180 0.004407 -15330 1 0.000215 1560.000000 0.000468 -0.002312 0.007217 -15331 1 0.000210 1560.000000 -0.002606 -0.002416 0.005497 -15332 1 0.000220 1560.000000 0.001003 0.001312 0.001444 -15333 1 0.000199 1560.000000 0.000235 0.002728 0.006404 -15334 1 0.000287 1560.000000 -0.000647 -0.003463 0.004908 -15335 1 0.000254 1560.000000 0.000614 0.001903 0.007833 -15336 1 0.000205 1560.000000 0.002190 -0.000430 0.005427 -15337 1 0.000192 1560.000000 -0.001852 0.001461 0.002114 -15338 1 0.000225 1560.000000 -0.000547 -0.000986 0.000333 -15339 1 0.000258 1560.000000 0.001850 0.001483 0.002153 -15340 1 0.000211 1560.000000 -0.003274 -0.000050 0.002409 -15341 1 0.000202 1560.000000 -0.001452 0.001546 0.009751 -15342 1 0.000239 1560.000000 -0.003384 -0.001481 0.005454 -15343 1 0.000205 1560.000000 0.000214 0.000915 0.003827 -15344 1 0.000224 1560.000000 -0.000914 0.003649 0.003472 -15345 1 0.000285 1560.000000 -0.000565 -0.001860 0.001324 -15346 1 0.000281 1560.000000 0.000503 0.000951 0.002045 -15347 1 0.000257 1560.000000 -0.001710 0.002370 0.005607 -15348 1 0.000256 1560.000000 0.003386 -0.000309 0.009543 -15349 1 0.000214 1560.000000 0.001530 -0.000573 0.008417 -15350 1 0.000219 1560.000000 0.001033 0.001144 0.006041 -15351 1 0.000247 1560.000000 -0.002440 0.002500 0.009094 -15352 1 0.000199 1560.000000 -0.002738 0.000213 0.003474 -15353 1 0.000210 1560.000000 0.003343 0.001326 0.006820 -15354 1 0.000250 1560.000000 -0.000623 -0.001435 0.008399 -15355 1 0.000198 1560.000000 -0.003351 0.001174 0.009499 -15356 1 0.000210 1560.000000 -0.000403 -0.003060 0.009112 -15357 1 0.000223 1560.000000 0.003498 -0.001287 0.008099 -15358 1 0.000260 1560.000000 -0.000356 0.003135 0.005157 -15359 1 0.000238 1560.000000 -0.001375 0.003533 0.007101 -15360 1 0.000268 1560.000000 -0.002723 0.001315 0.004908 -15361 1 0.000256 1560.000000 0.001243 -0.002288 0.007917 -15362 1 0.000244 1560.000000 0.002034 0.002200 0.008038 -15363 1 0.000237 1560.000000 0.000271 0.003435 0.003942 -15364 1 0.000210 1560.000000 -0.001537 0.000797 0.008790 -15365 1 0.000194 1560.000000 0.001354 0.003117 0.004042 -15366 1 0.000248 1560.000000 0.002117 -0.000853 0.000777 -15367 1 0.000207 1560.000000 0.003399 -0.000540 0.007844 -15368 1 0.000246 1560.000000 -0.002358 0.001098 0.007530 -15369 1 0.000230 1560.000000 0.002873 0.000822 0.000442 -15370 1 0.000201 1560.000000 -0.001979 0.002959 0.004752 -15371 1 0.000223 1560.000000 -0.003434 0.000200 0.005783 -15372 1 0.000225 1560.000000 -0.000750 -0.002455 0.002549 -15373 1 0.000204 1560.000000 0.002452 -0.001115 0.004050 -15374 1 0.000238 1560.000000 -0.000855 -0.001032 0.009084 -15375 1 0.000265 1560.000000 -0.000837 0.001190 0.006745 -15376 1 0.000211 1560.000000 0.001856 0.001285 0.003011 -15377 1 0.000246 1560.000000 -0.001674 -0.003027 0.006009 -15378 1 0.000252 1560.000000 -0.002690 -0.002214 0.000251 -15379 1 0.000224 1560.000000 0.001896 0.000501 0.004154 -15380 1 0.000234 1560.000000 0.000690 -0.001338 0.004286 -15381 1 0.000269 1560.000000 0.003507 -0.000329 0.008740 -15382 1 0.000225 1560.000000 -0.002016 0.000313 0.003487 -15383 1 0.000200 1560.000000 0.000832 0.002647 0.004373 -15384 1 0.000274 1560.000000 -0.000756 -0.001408 0.000151 -15385 1 0.000240 1560.000000 -0.001560 0.002933 0.001689 -15386 1 0.000197 1560.000000 -0.000985 -0.003200 0.000889 -15387 1 0.000225 1560.000000 -0.000804 -0.000122 0.003832 -15388 1 0.000196 1560.000000 0.000090 0.001790 0.008655 -15389 1 0.000245 1560.000000 -0.001866 -0.001599 0.004540 -15390 1 0.000262 1560.000000 0.000575 -0.000655 0.005738 -15391 1 0.000235 1560.000000 -0.002435 -0.001122 0.004611 -15392 1 0.000256 1560.000000 0.002713 -0.000597 0.007918 -15393 1 0.000217 1560.000000 0.002807 0.001933 0.005184 -15394 1 0.000192 1560.000000 -0.003066 -0.001317 0.005160 -15395 1 0.000200 1560.000000 -0.001159 0.001102 0.003463 -15396 1 0.000211 1560.000000 0.000302 -0.001819 0.002263 -15397 1 0.000207 1560.000000 -0.002209 -0.000701 0.000445 -15398 1 0.000286 1560.000000 0.002202 -0.000033 0.008071 -15399 1 0.000244 1560.000000 -0.001683 -0.000292 0.008674 -15400 1 0.000194 1560.000000 -0.002492 0.001327 0.005753 -15401 1 0.000267 1560.000000 -0.001294 0.002560 0.006469 -15402 1 0.000221 1560.000000 -0.003130 0.002116 0.000250 -15403 1 0.000212 1560.000000 0.000495 0.002053 0.002873 -15404 1 0.000268 1560.000000 0.000965 0.002210 0.006313 -15405 1 0.000260 1560.000000 0.002658 0.002256 0.002889 -15406 1 0.000217 1560.000000 -0.001134 -0.000408 0.008179 -15407 1 0.000222 1560.000000 0.002909 0.001938 0.008613 -15408 1 0.000215 1560.000000 -0.001673 0.001281 0.003563 -15409 1 0.000221 1560.000000 -0.000446 -0.001582 0.000160 -15410 1 0.000200 1560.000000 0.000485 0.001111 0.009245 -15411 1 0.000216 1560.000000 0.003176 -0.001563 0.001009 -15412 1 0.000197 1560.000000 0.001194 0.002852 0.003242 -15413 1 0.000231 1560.000000 -0.003255 -0.001690 0.008538 -15414 1 0.000225 1560.000000 0.001872 0.002474 0.001348 -15415 1 0.000248 1560.000000 0.003404 0.000058 0.002408 -15416 1 0.000206 1560.000000 0.002116 0.001824 0.004084 -15417 1 0.000210 1560.000000 0.003668 -0.000912 0.009603 -15418 1 0.000215 1560.000000 -0.003466 -0.000442 0.001177 -15419 1 0.000217 1560.000000 -0.001698 0.001810 0.000163 -15420 1 0.000213 1560.000000 -0.002045 0.003053 0.008175 -15421 1 0.000277 1560.000000 -0.002814 -0.001371 0.002260 -15422 1 0.000196 1560.000000 0.003409 0.000815 0.009120 -15423 1 0.000203 1560.000000 -0.002660 -0.000810 0.002427 -15424 1 0.000252 1560.000000 0.003619 0.001054 0.005712 -15425 1 0.000197 1560.000000 0.001511 -0.002395 0.003298 -15426 1 0.000266 1560.000000 0.003318 -0.001013 0.003635 -15427 1 0.000288 1560.000000 0.002554 0.002414 0.006933 -15428 1 0.000223 1560.000000 0.002651 -0.001151 0.002761 -15429 1 0.000225 1560.000000 0.003078 -0.000466 0.008592 -15430 1 0.000223 1560.000000 0.001331 0.001962 0.004864 -15431 1 0.000230 1560.000000 -0.000165 0.000652 0.000534 -15432 1 0.000245 1560.000000 -0.000013 0.002174 0.000750 -15433 1 0.000223 1560.000000 0.001748 -0.002809 0.004927 -15434 1 0.000267 1560.000000 0.001840 -0.002214 0.004410 -15435 1 0.000218 1560.000000 -0.002362 0.001643 0.009415 -15436 1 0.000208 1560.000000 -0.001120 0.002688 0.004097 -15437 1 0.000243 1560.000000 -0.001391 0.001801 0.007911 -15438 1 0.000278 1560.000000 0.002885 -0.000584 0.008316 -15439 1 0.000229 1560.000000 0.000260 -0.003349 0.005792 -15440 1 0.000212 1560.000000 0.000433 0.003401 0.002756 -15441 1 0.000218 1560.000000 -0.002397 -0.001468 0.001997 -15442 1 0.000268 1560.000000 -0.000912 -0.001611 0.002829 -15443 1 0.000239 1560.000000 0.001318 -0.000022 0.001739 -15444 1 0.000214 1560.000000 0.001599 0.000724 0.000895 -15445 1 0.000235 1560.000000 0.003073 -0.000346 0.006979 -15446 1 0.000259 1560.000000 0.003407 -0.001777 0.002934 -15447 1 0.000239 1560.000000 -0.002358 0.001099 0.004382 -15448 1 0.000229 1560.000000 -0.002698 0.001700 0.000895 -15449 1 0.000257 1560.000000 -0.000825 0.003755 0.005631 -15450 1 0.000281 1560.000000 -0.002684 -0.002043 0.006691 -15451 1 0.000228 1560.000000 -0.000722 -0.002243 0.006262 -15452 1 0.000209 1560.000000 0.002824 -0.001199 0.004211 -15453 1 0.000208 1560.000000 0.002125 0.001269 0.000112 -15454 1 0.000201 1560.000000 -0.000071 0.002315 0.002915 -15455 1 0.000254 1560.000000 -0.003088 0.000006 0.007172 -15456 1 0.000208 1560.000000 0.002307 0.001217 0.007280 -15457 1 0.000200 1560.000000 -0.001267 0.002400 0.003165 -15458 1 0.000241 1560.000000 -0.000413 0.002392 0.005261 -15459 1 0.000200 1560.000000 -0.000375 0.003452 0.000124 -15460 1 0.000222 1560.000000 0.001067 0.002453 0.002180 -15461 1 0.000202 1560.000000 0.000563 -0.002966 0.005411 -15462 1 0.000199 1560.000000 -0.001305 -0.001878 0.003132 -15463 1 0.000229 1560.000000 0.001707 0.001188 0.003999 -15464 1 0.000276 1560.000000 0.000270 -0.002048 0.004619 -15465 1 0.000250 1560.000000 0.000290 0.002374 0.009824 -15466 1 0.000219 1560.000000 0.000267 -0.003336 0.009747 -15467 1 0.000209 1560.000000 0.001621 0.002820 0.004204 -15468 1 0.000275 1560.000000 -0.000122 -0.003509 0.000195 -15469 1 0.000212 1560.000000 -0.001572 -0.003276 0.006466 -15470 1 0.000206 1560.000000 -0.002096 0.000866 0.000119 -15471 1 0.000225 1560.000000 -0.001254 0.001193 0.009069 -15472 1 0.000267 1560.000000 -0.000825 0.002484 0.008246 -15473 1 0.000286 1560.000000 0.003385 0.000956 0.008596 -15474 1 0.000195 1560.000000 -0.003490 -0.001449 0.003146 -15475 1 0.000195 1560.000000 -0.002029 -0.001201 0.000651 -15476 1 0.000213 1560.000000 0.001098 -0.001220 0.000318 -15477 1 0.000257 1560.000000 0.000075 0.001264 0.002614 -15478 1 0.000255 1560.000000 -0.000626 -0.001195 0.003245 -15479 1 0.000261 1560.000000 0.002630 -0.001571 0.007729 -15480 1 0.000193 1560.000000 0.002970 -0.000365 0.004081 -15481 1 0.000211 1560.000000 0.000099 0.003320 0.003541 -15482 1 0.000239 1560.000000 -0.002336 -0.001838 0.005397 -15483 1 0.000236 1560.000000 -0.003021 0.002307 0.008688 -15484 1 0.000246 1560.000000 0.001160 -0.002838 0.008719 -15485 1 0.000211 1560.000000 0.001799 -0.001936 0.007421 -15486 1 0.000195 1560.000000 -0.000190 -0.000457 0.004490 -15487 1 0.000199 1560.000000 -0.003152 -0.001349 0.009745 -15488 1 0.000222 1560.000000 0.001270 0.003093 0.004763 -15489 1 0.000240 1560.000000 0.000528 -0.002606 0.001346 -15490 1 0.000286 1560.000000 0.001971 0.001423 0.003435 -15491 1 0.000272 1560.000000 -0.001316 -0.001680 0.003640 -15492 1 0.000245 1560.000000 -0.003176 0.000211 0.006082 -15493 1 0.000200 1560.000000 0.002413 -0.000293 0.002238 -15494 1 0.000241 1560.000000 -0.001167 0.002315 0.007826 -15495 1 0.000225 1560.000000 -0.003370 -0.000914 0.004758 -15496 1 0.000258 1560.000000 -0.002283 -0.002461 0.007294 -15497 1 0.000230 1560.000000 -0.000014 -0.003158 0.002190 -15498 1 0.000252 1560.000000 -0.001586 -0.003482 0.005367 -15499 1 0.000235 1560.000000 0.001062 -0.000452 0.003141 -15500 1 0.000213 1560.000000 -0.000428 0.000032 0.005627 -15501 1 0.000259 1560.000000 -0.001976 0.000895 0.006663 -15502 1 0.000235 1560.000000 0.001187 0.000198 0.002119 -15503 1 0.000256 1560.000000 -0.000380 0.001766 0.006661 -15504 1 0.000243 1560.000000 -0.002414 -0.001526 0.002807 -15505 1 0.000288 1560.000000 0.001012 -0.003658 0.006224 -15506 1 0.000231 1560.000000 -0.003008 0.002109 0.008490 -15507 1 0.000261 1560.000000 0.001167 0.000267 0.008326 -15508 1 0.000220 1560.000000 0.001151 0.000590 0.005826 -15509 1 0.000281 1560.000000 -0.001614 -0.002579 0.009814 -15510 1 0.000198 1560.000000 0.001175 0.001735 0.006055 -15511 1 0.000196 1560.000000 0.002287 0.000578 0.006987 -15512 1 0.000197 1560.000000 0.000836 -0.000337 0.001295 -15513 1 0.000201 1560.000000 -0.000463 0.003271 0.004736 -15514 1 0.000265 1560.000000 -0.003195 -0.001860 0.003244 -15515 1 0.000248 1560.000000 -0.000363 0.002829 0.001341 -15516 1 0.000211 1560.000000 0.002489 0.000892 0.003579 -15517 1 0.000197 1560.000000 -0.000871 -0.003109 0.008434 -15518 1 0.000261 1560.000000 0.000472 -0.003061 0.006652 -15519 1 0.000284 1560.000000 0.003463 0.000120 0.004439 -15520 1 0.000209 1560.000000 -0.000176 -0.002994 0.007668 -15521 1 0.000269 1560.000000 -0.001655 0.001137 0.009254 -15522 1 0.000211 1560.000000 0.000431 0.000611 0.005284 -15523 1 0.000234 1560.000000 -0.000149 0.003852 0.002990 -15524 1 0.000216 1560.000000 0.000743 0.000618 0.008656 -15525 1 0.000266 1560.000000 -0.000996 -0.002445 0.004771 -15526 1 0.000236 1560.000000 -0.000781 -0.003739 0.007773 -15527 1 0.000195 1560.000000 -0.000453 0.003799 0.001471 -15528 1 0.000208 1560.000000 0.000863 -0.002908 0.009759 -15529 1 0.000198 1560.000000 -0.000648 -0.001795 0.007363 -15530 1 0.000244 1560.000000 -0.001261 0.002847 0.007692 -15531 1 0.000257 1560.000000 0.002522 -0.001567 0.008422 -15532 1 0.000268 1560.000000 -0.003590 0.001359 0.004980 -15533 1 0.000205 1560.000000 0.003283 -0.000111 0.008822 -15534 1 0.000220 1560.000000 -0.003643 -0.000398 0.001352 -15535 1 0.000202 1560.000000 0.001769 0.000187 0.004112 -15536 1 0.000198 1560.000000 -0.000315 -0.000409 0.007231 -15537 1 0.000194 1560.000000 0.000960 -0.002633 0.002291 -15538 1 0.000202 1560.000000 0.002225 0.000545 0.002939 -15539 1 0.000193 1560.000000 -0.000973 -0.001164 0.006263 -15540 1 0.000203 1560.000000 0.002223 0.001238 0.008581 -15541 1 0.000219 1560.000000 0.001353 -0.001470 0.006725 -15542 1 0.000248 1560.000000 -0.000963 0.000604 0.008712 -15543 1 0.000242 1560.000000 0.002161 0.003151 0.001466 -15544 1 0.000273 1560.000000 0.000223 0.002971 0.005411 -15545 1 0.000233 1560.000000 -0.002173 -0.001951 0.004588 -15546 1 0.000252 1560.000000 -0.003514 0.001545 0.000325 -15547 1 0.000245 1560.000000 0.003488 -0.000012 0.007080 -15548 1 0.000216 1560.000000 0.000824 -0.001582 0.008423 -15549 1 0.000202 1560.000000 -0.001403 -0.002237 0.005086 -15550 1 0.000255 1560.000000 0.003047 0.002314 0.006559 -15551 1 0.000215 1560.000000 -0.001510 0.000082 0.006932 -15552 1 0.000195 1560.000000 0.002541 -0.002817 0.002690 -15553 1 0.000222 1560.000000 -0.001641 -0.000910 0.002261 -15554 1 0.000244 1560.000000 -0.002219 -0.002110 0.003139 -15555 1 0.000209 1560.000000 -0.000566 -0.001278 0.002592 -15556 1 0.000199 1560.000000 -0.000666 -0.002686 0.005924 -15557 1 0.000244 1560.000000 -0.000506 0.003778 0.005903 -15558 1 0.000193 1560.000000 -0.001353 -0.001107 0.002960 -15559 1 0.000281 1560.000000 0.001405 -0.000147 0.001286 -15560 1 0.000250 1560.000000 0.000006 -0.002322 0.001166 -15561 1 0.000204 1560.000000 -0.000108 0.001210 0.004548 -15562 1 0.000247 1560.000000 -0.001292 -0.001307 0.003383 -15563 1 0.000218 1560.000000 0.003147 -0.000589 0.000864 -15564 1 0.000263 1560.000000 0.001496 -0.003507 0.000821 -15565 1 0.000254 1560.000000 0.003087 -0.002060 0.004537 -15566 1 0.000228 1560.000000 -0.001631 -0.001851 0.001231 -15567 1 0.000279 1560.000000 -0.000923 -0.002332 0.003445 -15568 1 0.000275 1560.000000 -0.002941 0.001997 0.004153 -15569 1 0.000213 1560.000000 -0.001568 0.001715 0.001747 -15570 1 0.000262 1560.000000 -0.001200 0.002458 0.003716 -15571 1 0.000228 1560.000000 0.000321 0.003239 0.005968 -15572 1 0.000194 1560.000000 0.000031 0.003327 0.002046 -15573 1 0.000204 1560.000000 0.002553 0.001497 0.009218 -15574 1 0.000200 1560.000000 0.002012 -0.002987 0.004905 -15575 1 0.000265 1560.000000 0.002048 -0.001765 0.001225 -15576 1 0.000241 1560.000000 -0.002284 0.002538 0.008151 -15577 1 0.000217 1560.000000 0.003775 -0.000455 0.008262 -15578 1 0.000278 1560.000000 -0.003370 0.000529 0.002299 -15579 1 0.000213 1560.000000 -0.000017 -0.001500 0.006680 -15580 1 0.000227 1560.000000 -0.001118 -0.003301 0.003800 -15581 1 0.000205 1560.000000 0.002721 -0.002630 0.002323 -15582 1 0.000210 1560.000000 -0.000657 -0.003587 0.002922 -15583 1 0.000205 1560.000000 -0.001320 -0.001287 0.002261 -15584 1 0.000262 1560.000000 0.001544 -0.000533 0.009239 -15585 1 0.000203 1560.000000 -0.001189 -0.000026 0.003529 -15586 1 0.000201 1560.000000 0.000764 -0.001544 0.001015 -15587 1 0.000216 1560.000000 0.000507 0.002109 0.007773 -15588 1 0.000220 1560.000000 -0.002047 -0.000378 0.003012 -15589 1 0.000226 1560.000000 0.000338 -0.001026 0.005775 -15590 1 0.000206 1560.000000 -0.002640 0.001868 0.005269 -15591 1 0.000203 1560.000000 -0.002422 0.001896 0.003284 -15592 1 0.000239 1560.000000 0.001455 -0.000877 0.006447 -15593 1 0.000238 1560.000000 -0.001730 0.002683 0.007157 -15594 1 0.000249 1560.000000 -0.000874 -0.001713 0.003407 -15595 1 0.000219 1560.000000 0.001603 0.001232 0.004528 -15596 1 0.000196 1560.000000 -0.002996 0.002320 0.002385 -15597 1 0.000235 1560.000000 0.000281 0.001984 0.007788 -15598 1 0.000212 1560.000000 0.000933 -0.000228 0.001531 -15599 1 0.000269 1560.000000 -0.003796 0.000072 0.003817 -15600 1 0.000204 1560.000000 -0.003774 -0.000769 0.000925 -15601 1 0.000204 1560.000000 -0.003070 -0.002289 0.008652 -15602 1 0.000208 1560.000000 -0.000795 0.001352 0.000978 -15603 1 0.000198 1560.000000 -0.000353 -0.000532 0.004913 -15604 1 0.000229 1560.000000 0.001647 0.000589 0.007409 -15605 1 0.000261 1560.000000 0.000671 0.001289 0.008668 -15606 1 0.000255 1560.000000 -0.001270 -0.001458 0.002457 -15607 1 0.000236 1560.000000 -0.003348 -0.001175 0.003586 -15608 1 0.000273 1560.000000 -0.002503 -0.002743 0.001919 -15609 1 0.000228 1560.000000 0.000442 0.002793 0.003681 -15610 1 0.000266 1560.000000 0.003426 0.000477 0.008833 -15611 1 0.000197 1560.000000 -0.000092 0.000787 0.008523 -15612 1 0.000254 1560.000000 -0.001104 -0.000992 0.009837 -15613 1 0.000208 1560.000000 -0.001306 -0.000355 0.001737 -15614 1 0.000256 1560.000000 -0.002321 0.001459 0.009049 -15615 1 0.000208 1560.000000 0.001632 0.002246 0.003925 -15616 1 0.000208 1560.000000 0.002092 -0.000061 0.005627 -15617 1 0.000195 1560.000000 -0.000346 0.000074 0.005413 -15618 1 0.000195 1560.000000 -0.001366 -0.003538 0.007382 -15619 1 0.000204 1560.000000 0.000328 0.002197 0.000840 -15620 1 0.000249 1560.000000 -0.001643 0.002977 0.000162 -15621 1 0.000219 1560.000000 0.000412 -0.002644 0.003254 -15622 1 0.000195 1560.000000 -0.000942 -0.001442 0.004376 -15623 1 0.000198 1560.000000 -0.000782 0.003473 0.005608 -15624 1 0.000263 1560.000000 0.002004 0.002981 0.006791 -15625 1 0.000206 1560.000000 0.000656 0.000340 0.002188 -15626 1 0.000203 1560.000000 -0.000556 -0.002413 0.004366 -15627 1 0.000270 1560.000000 -0.002215 -0.000330 0.001086 -15628 1 0.000241 1560.000000 0.001729 -0.001487 0.005457 -15629 1 0.000209 1560.000000 0.003061 -0.001866 0.007146 -15630 1 0.000192 1560.000000 -0.002955 -0.000276 0.003708 -15631 1 0.000225 1560.000000 -0.002529 0.000022 0.009273 -15632 1 0.000274 1560.000000 -0.001994 0.003275 0.008658 -15633 1 0.000238 1560.000000 0.000367 0.002493 0.006470 -15634 1 0.000285 1560.000000 -0.003635 0.000698 0.000768 -15635 1 0.000267 1560.000000 -0.003785 -0.000231 0.003723 -15636 1 0.000227 1560.000000 -0.000262 -0.001078 0.002337 -15637 1 0.000194 1560.000000 0.002258 0.001162 0.005936 -15638 1 0.000204 1560.000000 -0.002313 -0.000729 0.001361 -15639 1 0.000208 1560.000000 0.002700 0.000255 0.005884 -15640 1 0.000225 1560.000000 0.002736 0.000668 0.009821 -15641 1 0.000234 1560.000000 0.000212 -0.003329 0.003254 -15642 1 0.000197 1560.000000 -0.000409 -0.001683 0.000734 -15643 1 0.000194 1560.000000 0.001141 0.000237 0.007105 -15644 1 0.000220 1560.000000 0.000296 0.002210 0.008015 -15645 1 0.000231 1560.000000 0.001572 -0.001847 0.000881 -15646 1 0.000229 1560.000000 -0.003523 0.001532 0.004594 -15647 1 0.000260 1560.000000 0.000934 0.003737 0.006889 -15648 1 0.000247 1560.000000 0.000318 0.001047 0.000509 -15649 1 0.000200 1560.000000 0.001410 0.000927 0.008825 -15650 1 0.000202 1560.000000 0.000409 -0.003818 0.003048 -15651 1 0.000214 1560.000000 0.000660 0.001707 0.008744 -15652 1 0.000230 1560.000000 -0.002419 -0.001621 0.007003 -15653 1 0.000266 1560.000000 0.003146 -0.000941 0.002849 -15654 1 0.000285 1560.000000 0.000355 -0.003068 0.006336 -15655 1 0.000242 1560.000000 0.003155 0.000458 0.008720 -15656 1 0.000253 1560.000000 0.003181 -0.000377 0.005715 -15657 1 0.000198 1560.000000 0.000445 0.001475 0.004213 -15658 1 0.000258 1560.000000 0.002337 0.002370 0.008077 -15659 1 0.000210 1560.000000 -0.000259 -0.002924 0.003401 -15660 1 0.000221 1560.000000 -0.000494 -0.002936 0.004657 -15661 1 0.000274 1560.000000 -0.000986 -0.000131 0.007533 -15662 1 0.000248 1560.000000 -0.001341 -0.000901 0.003771 -15663 1 0.000223 1560.000000 0.002264 0.000602 0.009426 -15664 1 0.000267 1560.000000 -0.001525 0.002467 0.002024 -15665 1 0.000223 1560.000000 0.002385 -0.001100 0.003761 -15666 1 0.000203 1560.000000 -0.000514 0.001748 0.001346 -15667 1 0.000227 1560.000000 -0.001602 -0.001564 0.006917 -15668 1 0.000201 1560.000000 0.000951 0.002650 0.000751 -15669 1 0.000206 1560.000000 0.001217 0.002286 0.006194 -15670 1 0.000233 1560.000000 -0.002211 0.002464 0.000608 -15671 1 0.000196 1560.000000 -0.003425 0.001472 0.001375 -15672 1 0.000248 1560.000000 -0.000952 0.003136 0.008267 -15673 1 0.000193 1560.000000 -0.000313 -0.002984 0.007520 -15674 1 0.000214 1560.000000 0.000383 -0.001669 0.002669 -15675 1 0.000221 1560.000000 -0.000858 0.000463 0.006046 -15676 1 0.000241 1560.000000 0.002219 -0.002234 0.002719 -15677 1 0.000220 1560.000000 0.001277 0.001013 0.009615 -15678 1 0.000288 1560.000000 -0.003417 -0.001742 0.002167 -15679 1 0.000244 1560.000000 -0.001354 -0.002853 0.002817 -15680 1 0.000286 1560.000000 0.003753 -0.000722 0.001922 -15681 1 0.000257 1560.000000 0.002064 -0.001436 0.001257 -15682 1 0.000206 1560.000000 -0.003054 -0.001638 0.008394 -15683 1 0.000264 1560.000000 0.001007 0.002055 0.007830 -15684 1 0.000215 1560.000000 -0.000092 0.003073 0.000604 -15685 1 0.000193 1560.000000 -0.003017 0.000615 0.002608 -15686 1 0.000250 1560.000000 -0.000421 -0.000936 0.004473 -15687 1 0.000195 1560.000000 -0.000585 -0.000117 0.005635 -15688 1 0.000199 1560.000000 0.000712 0.000677 0.003320 -15689 1 0.000210 1560.000000 0.000287 -0.001282 0.009073 -15690 1 0.000217 1560.000000 -0.001678 -0.003465 0.001798 -15691 1 0.000252 1560.000000 -0.001239 -0.003641 0.009146 -15692 1 0.000286 1560.000000 0.003327 -0.001842 0.007949 -15693 1 0.000207 1560.000000 0.001297 0.002877 0.005079 -15694 1 0.000212 1560.000000 -0.001096 -0.002501 0.005314 -15695 1 0.000218 1560.000000 0.003256 -0.000587 0.001863 -15696 1 0.000231 1560.000000 0.000120 0.001642 0.006355 -15697 1 0.000274 1560.000000 -0.000430 -0.002524 0.003501 -15698 1 0.000257 1560.000000 -0.000720 0.000363 0.001573 -15699 1 0.000287 1560.000000 -0.002663 -0.001690 0.006424 -15700 1 0.000270 1560.000000 -0.001249 0.002796 0.000731 -15701 1 0.000274 1560.000000 -0.001123 0.000398 0.000689 -15702 1 0.000195 1560.000000 0.003227 -0.001300 0.005511 -15703 1 0.000255 1560.000000 -0.000660 0.003626 0.008559 -15704 1 0.000249 1560.000000 -0.002120 0.000675 0.005332 -15705 1 0.000199 1560.000000 -0.001734 -0.003306 0.008030 -15706 1 0.000288 1560.000000 0.002937 -0.001531 0.007083 -15707 1 0.000248 1560.000000 -0.001770 0.002127 0.001048 -15708 1 0.000229 1560.000000 -0.001587 0.000560 0.003848 -15709 1 0.000263 1560.000000 0.000966 -0.003579 0.009571 -15710 1 0.000225 1560.000000 0.000724 0.000131 0.004572 -15711 1 0.000221 1560.000000 -0.001103 -0.003245 0.000375 -15712 1 0.000246 1560.000000 0.002646 -0.002190 0.003352 -15713 1 0.000230 1560.000000 0.003301 -0.000618 0.003936 -15714 1 0.000285 1560.000000 -0.003300 0.000886 0.003402 -15715 1 0.000211 1560.000000 0.001695 -0.003216 0.005544 -15716 1 0.000281 1560.000000 0.003123 0.001486 0.009241 -15717 1 0.000244 1560.000000 -0.001138 -0.000365 0.009427 -15718 1 0.000200 1560.000000 -0.000178 -0.001163 0.001503 -15719 1 0.000206 1560.000000 -0.001556 -0.001286 0.004275 -15720 1 0.000220 1560.000000 0.002229 -0.002833 0.000143 -15721 1 0.000208 1560.000000 0.002701 0.002465 0.007279 -15722 1 0.000209 1560.000000 -0.002886 0.002147 0.009059 -15723 1 0.000199 1560.000000 -0.000123 0.001912 0.009444 -15724 1 0.000266 1560.000000 -0.002799 0.001697 0.008112 -15725 1 0.000196 1560.000000 0.000420 0.001451 0.006748 -15726 1 0.000215 1560.000000 0.000038 0.002499 0.005304 -15727 1 0.000228 1560.000000 -0.000472 -0.000325 0.000656 -15728 1 0.000211 1560.000000 -0.001726 -0.001974 0.000497 -15729 1 0.000287 1560.000000 -0.000669 0.002727 0.001438 -15730 1 0.000278 1560.000000 0.002246 0.001265 0.001802 -15731 1 0.000193 1560.000000 -0.000503 0.000273 0.005982 -15732 1 0.000196 1560.000000 -0.001700 -0.000921 0.003352 -15733 1 0.000195 1560.000000 -0.002328 -0.000538 0.002518 -15734 1 0.000235 1560.000000 -0.001760 -0.001453 0.001629 -15735 1 0.000271 1560.000000 0.001434 0.000635 0.008779 -15736 1 0.000224 1560.000000 0.002426 -0.001446 0.002715 -15737 1 0.000194 1560.000000 -0.000457 0.001582 0.002089 -15738 1 0.000283 1560.000000 -0.003484 0.001624 0.001893 -15739 1 0.000255 1560.000000 0.000593 0.002744 0.004900 -15740 1 0.000207 1560.000000 -0.001659 0.000789 0.004442 -15741 1 0.000227 1560.000000 0.002377 0.002199 0.004160 -15742 1 0.000277 1560.000000 0.002327 0.000163 0.009731 -15743 1 0.000194 1560.000000 -0.001069 0.002527 0.000826 -15744 1 0.000220 1560.000000 -0.000412 -0.003732 0.001276 -15745 1 0.000200 1560.000000 0.001062 0.002073 0.004266 -15746 1 0.000219 1560.000000 0.000502 0.000316 0.008782 -15747 1 0.000247 1560.000000 -0.001909 -0.002997 0.006230 -15748 1 0.000219 1560.000000 -0.002757 0.001819 0.006637 -15749 1 0.000213 1560.000000 -0.001876 -0.001376 0.008064 -15750 1 0.000233 1560.000000 0.002994 0.001971 0.003800 -15751 1 0.000273 1560.000000 0.001419 0.002982 0.005292 -15752 1 0.000210 1560.000000 0.000871 -0.001462 0.008949 -15753 1 0.000253 1560.000000 -0.003384 -0.001100 0.006030 -15754 1 0.000210 1560.000000 0.002533 0.000455 0.004146 -15755 1 0.000261 1560.000000 0.002373 -0.001851 0.006253 -15756 1 0.000192 1560.000000 0.003268 0.000494 0.005136 -15757 1 0.000207 1560.000000 0.002111 -0.001501 0.007503 -15758 1 0.000270 1560.000000 -0.002569 -0.001826 0.006841 -15759 1 0.000233 1560.000000 0.002857 0.001900 0.006892 -15760 1 0.000245 1560.000000 0.002659 -0.001814 0.008452 -15761 1 0.000211 1560.000000 -0.002123 -0.000911 0.003434 -15762 1 0.000213 1560.000000 -0.000002 -0.001728 0.004089 -15763 1 0.000259 1560.000000 -0.001075 0.003617 0.000152 -15764 1 0.000210 1560.000000 -0.001162 0.000603 0.001962 -15765 1 0.000288 1560.000000 0.001569 0.001669 0.007508 -15766 1 0.000216 1560.000000 -0.001420 -0.002999 0.006890 -15767 1 0.000258 1560.000000 0.002244 0.001182 0.000339 -15768 1 0.000199 1560.000000 0.001876 -0.002826 0.009610 -15769 1 0.000195 1560.000000 -0.001848 0.001070 0.000643 -15770 1 0.000204 1560.000000 0.000108 -0.000649 0.005436 -15771 1 0.000268 1560.000000 0.000734 0.000982 0.003733 -15772 1 0.000231 1560.000000 -0.000307 0.003470 0.001368 -15773 1 0.000248 1560.000000 -0.000434 -0.000724 0.009802 -15774 1 0.000223 1560.000000 -0.002413 -0.000903 0.003358 -15775 1 0.000198 1560.000000 -0.001886 -0.002564 0.001221 -15776 1 0.000231 1560.000000 0.002710 0.001308 0.005126 -15777 1 0.000248 1560.000000 0.001189 0.002437 0.004079 -15778 1 0.000230 1560.000000 -0.001208 -0.001201 0.009734 -15779 1 0.000251 1560.000000 -0.001331 0.000113 0.003024 -15780 1 0.000201 1560.000000 0.003014 -0.000872 0.002312 -15781 1 0.000227 1560.000000 0.000887 0.000448 0.002338 -15782 1 0.000283 1560.000000 0.001938 0.003060 0.002554 -15783 1 0.000217 1560.000000 -0.000756 0.002306 0.004722 -15784 1 0.000259 1560.000000 -0.003386 0.000256 0.006707 -15785 1 0.000272 1560.000000 -0.002042 0.001702 0.009378 -15786 1 0.000213 1560.000000 0.001014 0.001096 0.003759 -15787 1 0.000247 1560.000000 -0.002667 0.000270 0.006872 -15788 1 0.000288 1560.000000 -0.002062 0.002957 0.009840 -15789 1 0.000198 1560.000000 -0.001785 0.000288 0.003077 -15790 1 0.000239 1560.000000 0.002092 0.001616 0.008080 -15791 1 0.000239 1560.000000 0.003037 -0.000614 0.006935 -15792 1 0.000251 1560.000000 -0.003204 0.001304 0.003947 -15793 1 0.000215 1560.000000 0.001727 -0.003327 0.008287 -15794 1 0.000274 1560.000000 0.003023 -0.002284 0.007440 -15795 1 0.000212 1560.000000 -0.002038 0.002135 0.009249 -15796 1 0.000248 1560.000000 -0.002146 0.000101 0.006065 -15797 1 0.000261 1560.000000 0.002208 0.002839 0.007148 -15798 1 0.000210 1560.000000 -0.001586 -0.000433 0.002958 -15799 1 0.000204 1560.000000 0.001137 0.001311 0.000689 -15800 1 0.000196 1560.000000 0.003067 0.000817 0.005268 -15801 1 0.000271 1560.000000 -0.000923 -0.002127 0.000990 -15802 1 0.000270 1560.000000 -0.003251 -0.001952 0.009099 -15803 1 0.000272 1560.000000 -0.001954 -0.002987 0.007442 -15804 1 0.000196 1560.000000 -0.002413 -0.000975 0.000485 -15805 1 0.000228 1560.000000 0.000689 0.002885 0.001340 -15806 1 0.000199 1560.000000 -0.001788 0.002686 0.005523 -15807 1 0.000204 1560.000000 0.003773 -0.000236 0.008124 -15808 1 0.000251 1560.000000 -0.000488 0.002514 0.008511 -15809 1 0.000208 1560.000000 0.000789 0.002044 0.006999 -15810 1 0.000209 1560.000000 -0.000361 -0.000911 0.002631 -15811 1 0.000232 1560.000000 -0.000145 0.000740 0.009501 -15812 1 0.000223 1560.000000 0.003389 0.001252 0.003458 -15813 1 0.000219 1560.000000 0.001284 -0.001570 0.007100 -15814 1 0.000242 1560.000000 -0.002828 -0.001849 0.002898 -15815 1 0.000201 1560.000000 -0.001187 0.000835 0.001941 -15816 1 0.000268 1560.000000 -0.002371 -0.001399 0.004588 -15817 1 0.000253 1560.000000 -0.001874 0.001831 0.001227 -15818 1 0.000223 1560.000000 -0.001431 -0.003391 0.001997 -15819 1 0.000203 1560.000000 -0.003558 0.001181 0.004145 -15820 1 0.000224 1560.000000 -0.000705 -0.001572 0.003119 -15821 1 0.000280 1560.000000 -0.001351 0.001841 0.007605 -15822 1 0.000213 1560.000000 -0.001183 0.003492 0.004951 -15823 1 0.000273 1560.000000 -0.001852 -0.002123 0.004840 -15824 1 0.000232 1560.000000 0.001617 0.003489 0.001937 -15825 1 0.000224 1560.000000 -0.001325 0.001176 0.000537 -15826 1 0.000203 1560.000000 0.001306 0.001285 0.002010 -15827 1 0.000224 1560.000000 -0.000215 -0.002347 0.000731 -15828 1 0.000251 1560.000000 0.002188 0.003100 0.006371 -15829 1 0.000198 1560.000000 0.001991 -0.002615 0.001495 -15830 1 0.000272 1560.000000 0.002333 -0.001776 0.009806 -15831 1 0.000235 1560.000000 0.000575 -0.000580 0.003591 -15832 1 0.000221 1560.000000 -0.002745 0.000227 0.006172 -15833 1 0.000259 1560.000000 0.003052 -0.000857 0.005987 -15834 1 0.000207 1560.000000 -0.002498 -0.000380 0.002613 -15835 1 0.000242 1560.000000 0.002126 0.002400 0.004199 -15836 1 0.000212 1560.000000 0.000333 -0.003779 0.000125 -15837 1 0.000270 1560.000000 -0.001047 0.001439 0.007111 -15838 1 0.000251 1560.000000 0.000907 -0.003703 0.002375 -15839 1 0.000276 1560.000000 -0.003024 -0.000893 0.009046 -15840 1 0.000209 1560.000000 0.002599 0.002200 0.006561 -15841 1 0.000198 1560.000000 -0.000225 0.003648 0.005561 -15842 1 0.000193 1560.000000 -0.001952 -0.001151 0.007208 -15843 1 0.000242 1560.000000 -0.001922 0.002925 0.005358 -15844 1 0.000259 1560.000000 0.002719 -0.001342 0.006988 -15845 1 0.000214 1560.000000 -0.001384 0.001275 0.003830 -15846 1 0.000241 1560.000000 0.000647 0.002545 0.000319 -15847 1 0.000267 1560.000000 -0.000968 -0.003148 0.009824 -15848 1 0.000197 1560.000000 -0.002430 -0.002991 0.000178 -15849 1 0.000231 1560.000000 -0.001076 -0.003372 0.008007 -15850 1 0.000265 1560.000000 0.000375 -0.002760 0.000932 -15851 1 0.000260 1560.000000 -0.003702 0.000780 0.005673 -15852 1 0.000206 1560.000000 0.002981 -0.000560 0.005118 -15853 1 0.000195 1560.000000 -0.000899 -0.000063 0.004304 -15854 1 0.000261 1560.000000 -0.001847 -0.001348 0.005181 -15855 1 0.000215 1560.000000 -0.003074 0.001526 0.009185 -15856 1 0.000258 1560.000000 0.003769 0.000630 0.005670 -15857 1 0.000219 1560.000000 -0.001752 0.002175 0.009051 -15858 1 0.000210 1560.000000 -0.000387 -0.000793 0.008527 -15859 1 0.000249 1560.000000 0.003027 -0.000569 0.005812 -15860 1 0.000212 1560.000000 0.000895 -0.001202 0.003637 -15861 1 0.000199 1560.000000 0.000028 0.001433 0.001968 -15862 1 0.000247 1560.000000 -0.000975 -0.002717 0.006803 -15863 1 0.000238 1560.000000 0.001133 -0.000594 0.004439 -15864 1 0.000263 1560.000000 0.000603 -0.003271 0.007189 -15865 1 0.000211 1560.000000 0.000045 -0.003594 0.005290 -15866 1 0.000274 1560.000000 0.002836 -0.002519 0.000618 -15867 1 0.000225 1560.000000 0.000907 0.000868 0.008274 -15868 1 0.000246 1560.000000 0.001191 -0.002239 0.002544 -15869 1 0.000236 1560.000000 -0.002641 -0.001429 0.002757 -15870 1 0.000213 1560.000000 -0.002006 0.002893 0.007432 -15871 1 0.000245 1560.000000 -0.001231 0.002311 0.009339 -15872 1 0.000205 1560.000000 0.001395 -0.001880 0.005931 -15873 1 0.000194 1560.000000 0.002343 0.000426 0.003953 -15874 1 0.000211 1560.000000 -0.001499 -0.000981 0.001019 -15875 1 0.000198 1560.000000 -0.000905 -0.002974 0.002076 -15876 1 0.000238 1560.000000 -0.000077 0.001660 0.004818 -15877 1 0.000212 1560.000000 0.000366 -0.003818 0.008160 -15878 1 0.000239 1560.000000 -0.003223 -0.001986 0.003625 -15879 1 0.000218 1560.000000 -0.001823 -0.000332 0.006060 -15880 1 0.000259 1560.000000 -0.001941 -0.001029 0.006488 -15881 1 0.000264 1560.000000 0.001177 -0.001817 0.000256 -15882 1 0.000194 1560.000000 0.003127 -0.000306 0.001900 -15883 1 0.000194 1560.000000 -0.000076 0.000313 0.004816 -15884 1 0.000256 1560.000000 0.001414 -0.001787 0.003396 -15885 1 0.000194 1560.000000 0.000356 0.003379 0.006288 -15886 1 0.000240 1560.000000 -0.002502 -0.002076 0.009365 -15887 1 0.000211 1560.000000 0.001677 -0.002479 0.001974 -15888 1 0.000278 1560.000000 0.001924 0.002805 0.003343 -15889 1 0.000207 1560.000000 -0.001387 0.003115 0.008532 -15890 1 0.000234 1560.000000 -0.000225 0.002945 0.009334 -15891 1 0.000204 1560.000000 -0.002127 0.002953 0.002988 -15892 1 0.000250 1560.000000 -0.001284 0.002834 0.008081 -15893 1 0.000279 1560.000000 0.002934 -0.001470 0.008812 -15894 1 0.000263 1560.000000 0.003430 0.000054 0.005718 -15895 1 0.000260 1560.000000 -0.001723 -0.003410 0.000690 -15896 1 0.000287 1560.000000 0.000540 0.002737 0.009247 -15897 1 0.000277 1560.000000 -0.003097 -0.001739 0.001943 -15898 1 0.000233 1560.000000 0.002656 -0.002649 0.004556 -15899 1 0.000193 1560.000000 -0.002507 0.001032 0.008450 -15900 1 0.000239 1560.000000 0.000876 -0.003200 0.002114 -15901 1 0.000225 1560.000000 0.002766 0.002170 0.004909 -15902 1 0.000221 1560.000000 0.002608 -0.001796 0.005905 -15903 1 0.000262 1560.000000 -0.000339 -0.001686 0.002956 -15904 1 0.000204 1560.000000 0.001695 0.000028 0.008720 -15905 1 0.000227 1560.000000 0.000538 -0.002204 0.005358 -15906 1 0.000214 1560.000000 0.000973 0.001435 0.009528 -15907 1 0.000203 1560.000000 -0.002062 0.000497 0.006150 -15908 1 0.000216 1560.000000 0.003403 0.000095 0.008527 -15909 1 0.000197 1560.000000 0.000928 0.002747 0.004855 -15910 1 0.000201 1560.000000 0.002515 -0.001664 0.004586 -15911 1 0.000193 1560.000000 0.000725 0.002953 0.003357 -15912 1 0.000276 1560.000000 0.000304 0.001550 0.000742 -15913 1 0.000231 1560.000000 0.001717 -0.000535 0.005766 -15914 1 0.000241 1560.000000 0.000793 -0.001963 0.002212 -15915 1 0.000231 1560.000000 -0.003444 0.001566 0.005389 -15916 1 0.000222 1560.000000 0.000278 0.003150 0.006208 -15917 1 0.000244 1560.000000 -0.000717 0.003199 0.000126 -15918 1 0.000241 1560.000000 -0.000345 -0.001929 0.003446 -15919 1 0.000276 1560.000000 -0.000225 0.003815 0.009801 -15920 1 0.000212 1560.000000 0.000485 -0.000189 0.000327 -15921 1 0.000223 1560.000000 0.000111 -0.002106 0.000700 -15922 1 0.000225 1560.000000 -0.001563 -0.002803 0.000584 -15923 1 0.000243 1560.000000 -0.000011 0.001954 0.005173 -15924 1 0.000206 1560.000000 0.000102 0.001227 0.008325 -15925 1 0.000217 1560.000000 0.002056 0.002025 0.004270 -15926 1 0.000195 1560.000000 -0.000121 0.003406 0.003633 -15927 1 0.000253 1560.000000 -0.000288 -0.001938 0.002777 -15928 1 0.000224 1560.000000 -0.000451 0.002926 0.006275 -15929 1 0.000228 1560.000000 -0.001491 -0.000166 0.005269 -15930 1 0.000257 1560.000000 -0.000577 0.003074 0.001369 -15931 1 0.000216 1560.000000 0.003334 -0.000041 0.001762 -15932 1 0.000203 1560.000000 -0.001747 -0.001758 0.006871 -15933 1 0.000274 1560.000000 -0.002513 0.002822 0.008966 -15934 1 0.000276 1560.000000 0.002235 0.002774 0.003650 -15935 1 0.000239 1560.000000 -0.001543 0.003195 0.002764 -15936 1 0.000196 1560.000000 -0.002630 0.001003 0.007487 -15937 1 0.000210 1560.000000 0.000500 0.000084 0.002691 -15938 1 0.000199 1560.000000 -0.000117 -0.000414 0.002831 -15939 1 0.000207 1560.000000 -0.000998 0.001813 0.002917 -15940 1 0.000210 1560.000000 -0.000719 -0.002388 0.002130 -15941 1 0.000198 1560.000000 0.000015 0.002982 0.004111 -15942 1 0.000253 1560.000000 0.002801 0.001109 0.009044 -15943 1 0.000230 1560.000000 0.002449 0.000079 0.005693 -15944 1 0.000202 1560.000000 -0.002401 0.000178 0.008587 -15945 1 0.000263 1560.000000 0.003179 0.000906 0.002552 -15946 1 0.000202 1560.000000 0.001640 -0.001047 0.004324 -15947 1 0.000242 1560.000000 -0.001213 -0.001127 0.008828 -15948 1 0.000220 1560.000000 0.003245 -0.002067 0.000830 -15949 1 0.000247 1560.000000 -0.000232 -0.003476 0.005431 -15950 1 0.000205 1560.000000 -0.000459 -0.002109 0.003131 -15951 1 0.000195 1560.000000 -0.000751 -0.003049 0.003994 -15952 1 0.000265 1560.000000 0.000797 0.002771 0.007591 -15953 1 0.000228 1560.000000 0.001787 -0.000135 0.006093 -15954 1 0.000232 1560.000000 -0.002340 -0.001978 0.004990 -15955 1 0.000201 1560.000000 -0.001423 0.001131 0.007769 -15956 1 0.000227 1560.000000 -0.000247 0.000291 0.000847 -15957 1 0.000211 1560.000000 0.002337 0.000040 0.002008 -15958 1 0.000288 1560.000000 -0.003824 -0.000213 0.006459 -15959 1 0.000241 1560.000000 0.003469 -0.000703 0.005289 -15960 1 0.000283 1560.000000 -0.001838 -0.003052 0.008123 -15961 1 0.000198 1560.000000 -0.000271 -0.003347 0.003761 -15962 1 0.000198 1560.000000 0.000591 -0.003188 0.003919 -15963 1 0.000201 1560.000000 -0.003125 -0.001197 0.002330 -15964 1 0.000241 1560.000000 -0.001997 0.001657 0.003026 -15965 1 0.000239 1560.000000 -0.000032 0.000931 0.001320 -15966 1 0.000232 1560.000000 -0.003428 0.001684 0.007719 -15967 1 0.000253 1560.000000 0.001076 -0.003035 0.002753 -15968 1 0.000272 1560.000000 -0.002018 0.000583 0.003868 -15969 1 0.000260 1560.000000 -0.001574 0.000860 0.000185 -15970 1 0.000269 1560.000000 -0.000484 0.002206 0.000162 -15971 1 0.000223 1560.000000 -0.001100 0.002162 0.000181 -15972 1 0.000264 1560.000000 0.003374 0.000798 0.004530 -15973 1 0.000281 1560.000000 0.000406 0.003103 0.004307 -15974 1 0.000196 1560.000000 -0.000750 0.003616 0.004478 -15975 1 0.000205 1560.000000 0.002659 0.002654 0.000666 -15976 1 0.000236 1560.000000 -0.002967 -0.001142 0.003970 -15977 1 0.000235 1560.000000 -0.002618 -0.001270 0.003572 -15978 1 0.000263 1560.000000 -0.000548 -0.000939 0.002229 -15979 1 0.000250 1560.000000 0.002983 0.000762 0.004180 -15980 1 0.000207 1560.000000 -0.001560 -0.000053 0.008188 -15981 1 0.000248 1560.000000 0.002232 -0.003027 0.004215 -15982 1 0.000268 1560.000000 0.002148 -0.000721 0.007104 -15983 1 0.000231 1560.000000 -0.002245 0.000536 0.004711 -15984 1 0.000238 1560.000000 -0.001688 -0.003370 0.002866 -15985 1 0.000250 1560.000000 -0.003137 0.001793 0.003187 -15986 1 0.000270 1560.000000 0.000183 -0.002076 0.005948 -15987 1 0.000222 1560.000000 -0.000111 -0.003750 0.007690 -15988 1 0.000267 1560.000000 0.002266 0.000930 0.002163 -15989 1 0.000265 1560.000000 0.000785 -0.003758 0.001120 -15990 1 0.000264 1560.000000 -0.002716 0.000974 0.001607 -15991 1 0.000216 1560.000000 -0.001053 0.003330 0.009082 -15992 1 0.000199 1560.000000 0.003017 -0.001694 0.004995 -15993 1 0.000283 1560.000000 0.003748 0.000121 0.006341 -15994 1 0.000207 1560.000000 -0.001988 0.000284 0.003886 -15995 1 0.000200 1560.000000 -0.001388 -0.000779 0.001800 -15996 1 0.000288 1560.000000 0.001620 0.003338 0.003284 -15997 1 0.000258 1560.000000 -0.002946 0.000403 0.006425 -15998 1 0.000287 1560.000000 -0.001829 -0.000968 0.005505 -15999 1 0.000275 1560.000000 0.003480 -0.001511 0.001887 -16000 1 0.000213 1560.000000 -0.000150 0.003408 0.001771 -16001 1 0.000217 1560.000000 -0.001501 0.003544 0.003216 -16002 1 0.000207 1560.000000 -0.001820 0.000608 0.004503 -16003 1 0.000234 1560.000000 -0.000706 0.000013 0.001039 -16004 1 0.000195 1560.000000 -0.000851 0.002319 0.003777 -16005 1 0.000272 1560.000000 0.001463 -0.003559 0.003681 -16006 1 0.000253 1560.000000 -0.001816 0.002964 0.001196 -16007 1 0.000215 1560.000000 -0.000938 -0.000868 0.006736 -16008 1 0.000202 1560.000000 0.003024 0.001196 0.004994 -16009 1 0.000236 1560.000000 -0.001043 0.000133 0.005839 -16010 1 0.000264 1560.000000 0.003055 -0.001294 0.004583 -16011 1 0.000235 1560.000000 0.000607 0.003794 0.006931 -16012 1 0.000233 1560.000000 0.002666 -0.002092 0.003035 -16013 1 0.000252 1560.000000 -0.002103 0.001486 0.002707 -16014 1 0.000281 1560.000000 -0.001575 0.002458 0.005825 -16015 1 0.000206 1560.000000 -0.002474 0.000014 0.002403 -16016 1 0.000231 1560.000000 -0.003672 -0.000663 0.000278 -16017 1 0.000247 1560.000000 -0.002787 -0.001254 0.007670 -16018 1 0.000210 1560.000000 0.000848 -0.003252 0.009382 -16019 1 0.000223 1560.000000 -0.001791 -0.001870 0.005486 -16020 1 0.000235 1560.000000 -0.001261 0.002424 0.001063 -16021 1 0.000267 1560.000000 -0.002814 0.002267 0.007057 -16022 1 0.000225 1560.000000 0.001243 -0.001397 0.009428 -16023 1 0.000226 1560.000000 0.002262 0.000921 0.003306 -16024 1 0.000252 1560.000000 0.001725 0.003055 0.000405 -16025 1 0.000224 1560.000000 -0.002934 0.001382 0.006419 -16026 1 0.000205 1560.000000 -0.001590 -0.000157 0.003472 -16027 1 0.000251 1560.000000 -0.002242 0.001260 0.007330 -16028 1 0.000247 1560.000000 0.001808 0.002479 0.003129 -16029 1 0.000234 1560.000000 0.000917 0.000108 0.002561 -16030 1 0.000252 1560.000000 0.002167 0.003044 0.004111 -16031 1 0.000278 1560.000000 0.002320 -0.002736 0.009825 -16032 1 0.000268 1560.000000 0.002662 -0.001705 0.000217 -16033 1 0.000238 1560.000000 -0.003460 0.001200 0.002746 -16034 1 0.000245 1560.000000 0.000754 -0.001374 0.007199 -16035 1 0.000276 1560.000000 -0.002059 -0.001953 0.005700 -16036 1 0.000207 1560.000000 -0.002584 0.000293 0.008652 -16037 1 0.000227 1560.000000 -0.002025 -0.000085 0.003814 -16038 1 0.000219 1560.000000 -0.003584 0.000696 0.005195 -16039 1 0.000241 1560.000000 -0.002805 0.001642 0.002837 -16040 1 0.000253 1560.000000 0.002818 0.000081 0.003426 -16041 1 0.000201 1560.000000 -0.002364 0.000782 0.001120 -16042 1 0.000269 1560.000000 0.002334 -0.002636 0.005503 -16043 1 0.000193 1560.000000 0.001173 -0.002288 0.009590 -16044 1 0.000204 1560.000000 0.001543 0.002668 0.001255 -16045 1 0.000258 1560.000000 0.001070 -0.000599 0.001299 -16046 1 0.000195 1560.000000 -0.003017 0.001926 0.000882 -16047 1 0.000216 1560.000000 0.001986 0.000029 0.002928 -16048 1 0.000244 1560.000000 -0.000334 -0.002937 0.007301 -16049 1 0.000197 1560.000000 0.001112 0.003299 0.007300 -16050 1 0.000277 1560.000000 0.000302 -0.002981 0.008512 -16051 1 0.000197 1560.000000 0.002210 0.002292 0.000366 -16052 1 0.000288 1560.000000 0.003482 0.000489 0.004123 -16053 1 0.000214 1560.000000 0.002289 -0.002113 0.002304 -16054 1 0.000205 1560.000000 0.000395 0.000396 0.000458 -16055 1 0.000211 1560.000000 0.001930 -0.001408 0.004863 -16056 1 0.000217 1560.000000 -0.000956 0.002693 0.000731 -16057 1 0.000257 1560.000000 0.003270 0.001655 0.007490 -16058 1 0.000201 1560.000000 -0.001094 0.000887 0.002707 -16059 1 0.000212 1560.000000 0.002061 -0.002399 0.006674 -16060 1 0.000197 1560.000000 0.000259 0.000267 0.006994 -16061 1 0.000213 1560.000000 -0.002649 -0.001586 0.007031 -16062 1 0.000236 1560.000000 0.001778 0.002178 0.001507 -16063 1 0.000216 1560.000000 -0.002934 0.001680 0.007332 -16064 1 0.000235 1560.000000 -0.001449 -0.003185 0.007695 -16065 1 0.000227 1560.000000 0.003025 0.000114 0.004123 -16066 1 0.000200 1560.000000 0.001118 -0.002520 0.004942 -16067 1 0.000215 1560.000000 -0.001043 0.002878 0.007439 -16068 1 0.000253 1560.000000 0.000240 0.002672 0.004462 -16069 1 0.000203 1560.000000 0.000386 -0.002547 0.004428 -16070 1 0.000239 1560.000000 -0.002166 0.000696 0.008004 -16071 1 0.000219 1560.000000 -0.003503 -0.000701 0.007522 -16072 1 0.000234 1560.000000 -0.001548 0.000702 0.007487 -16073 1 0.000206 1560.000000 -0.001964 0.002893 0.008822 -16074 1 0.000207 1560.000000 0.000093 -0.002226 0.006161 -16075 1 0.000204 1560.000000 -0.002491 -0.002943 0.001102 -16076 1 0.000240 1560.000000 -0.001963 0.000508 0.001942 -16077 1 0.000267 1560.000000 -0.001569 -0.001036 0.004424 -16078 1 0.000254 1560.000000 0.002736 0.001708 0.008222 -16079 1 0.000204 1560.000000 -0.002034 0.002737 0.000212 -16080 1 0.000256 1560.000000 -0.001570 0.002363 0.003110 -16081 1 0.000250 1560.000000 -0.002580 -0.002328 0.007924 -16082 1 0.000236 1560.000000 0.002988 0.001531 0.006073 -16083 1 0.000255 1560.000000 0.001705 -0.000694 0.009806 -16084 1 0.000238 1560.000000 0.000415 -0.000835 0.006826 -16085 1 0.000249 1560.000000 -0.003699 -0.000312 0.000654 -16086 1 0.000233 1560.000000 -0.000691 0.002200 0.003667 -16087 1 0.000213 1560.000000 0.000827 0.002094 0.001947 -16088 1 0.000194 1560.000000 -0.001039 -0.001458 0.004857 -16089 1 0.000264 1560.000000 0.000026 0.002827 0.007711 -16090 1 0.000216 1560.000000 0.000718 0.002221 0.004226 -16091 1 0.000258 1560.000000 0.000839 0.002781 0.008589 -16092 1 0.000208 1560.000000 -0.003701 -0.000717 0.009431 -16093 1 0.000255 1560.000000 -0.003203 0.001700 0.005712 -16094 1 0.000207 1560.000000 0.001641 0.001683 0.004645 -16095 1 0.000231 1560.000000 -0.003137 -0.000751 0.004773 -16096 1 0.000232 1560.000000 -0.003250 0.001311 0.002525 -16097 1 0.000278 1560.000000 0.000662 -0.002971 0.005054 -16098 1 0.000274 1560.000000 -0.000280 0.000854 0.008692 -16099 1 0.000246 1560.000000 0.001601 -0.000210 0.005414 -16100 1 0.000261 1560.000000 0.002338 0.000739 0.005403 -16101 1 0.000263 1560.000000 0.003827 0.000385 0.007197 -16102 1 0.000286 1560.000000 -0.000583 0.003733 0.001174 -16103 1 0.000246 1560.000000 -0.001874 -0.000637 0.006403 -16104 1 0.000225 1560.000000 0.001007 -0.000094 0.008007 -16105 1 0.000266 1560.000000 0.001664 0.003236 0.009351 -16106 1 0.000238 1560.000000 -0.002933 -0.002425 0.001413 -16107 1 0.000272 1560.000000 0.003179 0.001943 0.009137 -16108 1 0.000199 1560.000000 -0.001911 0.000136 0.001284 -16109 1 0.000223 1560.000000 -0.002717 0.000002 0.002118 -16110 1 0.000235 1560.000000 -0.001445 0.002818 0.005313 -16111 1 0.000208 1560.000000 0.000516 -0.002174 0.007881 -16112 1 0.000224 1560.000000 0.000924 -0.002345 0.004022 -16113 1 0.000272 1560.000000 -0.000149 -0.003796 0.004054 -16114 1 0.000258 1560.000000 -0.003424 0.000096 0.002780 -16115 1 0.000248 1560.000000 0.003050 0.001111 0.005838 -16116 1 0.000203 1560.000000 -0.001147 -0.000825 0.004911 -16117 1 0.000250 1560.000000 -0.001471 -0.003011 0.000152 -16118 1 0.000231 1560.000000 -0.000200 -0.000414 0.009108 -16119 1 0.000194 1560.000000 0.003246 -0.002048 0.004211 -16120 1 0.000248 1560.000000 0.001000 -0.001299 0.006585 -16121 1 0.000209 1560.000000 0.000244 -0.001546 0.003044 -16122 1 0.000285 1560.000000 0.003837 0.000299 0.009675 -16123 1 0.000202 1560.000000 0.001579 -0.000054 0.007062 -16124 1 0.000250 1560.000000 0.003139 0.001856 0.008213 -16125 1 0.000238 1560.000000 -0.001699 0.003035 0.007449 -16126 1 0.000208 1560.000000 0.003208 0.001082 0.004167 -16127 1 0.000212 1560.000000 -0.003074 -0.001431 0.006243 -16128 1 0.000215 1560.000000 0.001391 -0.000324 0.000245 -16129 1 0.000237 1560.000000 -0.000424 -0.003081 0.004006 -16130 1 0.000201 1560.000000 0.000430 0.001041 0.006877 -16131 1 0.000218 1560.000000 0.003430 -0.000238 0.004257 -16132 1 0.000281 1560.000000 0.000535 0.003751 0.004038 -16133 1 0.000216 1560.000000 -0.003831 0.000117 0.009110 -16134 1 0.000195 1560.000000 -0.001816 -0.003190 0.009807 -16135 1 0.000222 1560.000000 -0.002158 0.001283 0.002399 -16136 1 0.000238 1560.000000 -0.002254 -0.000838 0.005847 -16137 1 0.000266 1560.000000 -0.002686 0.002716 0.008116 -16138 1 0.000270 1560.000000 -0.002314 0.002295 0.000802 -16139 1 0.000278 1560.000000 0.001608 -0.002368 0.007091 -16140 1 0.000277 1560.000000 0.001700 0.001239 0.002283 -16141 1 0.000277 1560.000000 0.001925 0.003282 0.003679 -16142 1 0.000194 1560.000000 -0.001372 0.002127 0.006135 -16143 1 0.000251 1560.000000 0.002738 0.000451 0.002648 -16144 1 0.000246 1560.000000 -0.001217 0.003656 0.006076 -16145 1 0.000281 1560.000000 0.001131 -0.002275 0.007274 -16146 1 0.000237 1560.000000 0.003131 -0.002232 0.007866 -16147 1 0.000231 1560.000000 -0.000783 0.000389 0.001992 -16148 1 0.000215 1560.000000 -0.003832 0.000010 0.006885 -16149 1 0.000217 1560.000000 0.003444 -0.000407 0.002896 -16150 1 0.000274 1560.000000 0.000781 0.003112 0.005626 -16151 1 0.000268 1560.000000 0.001546 -0.002045 0.009399 -16152 1 0.000229 1560.000000 0.003270 0.000417 0.004282 -16153 1 0.000250 1560.000000 -0.000590 -0.003288 0.006055 -16154 1 0.000284 1560.000000 -0.001164 0.002726 0.009155 -16155 1 0.000237 1560.000000 -0.002380 0.000952 0.002887 -16156 1 0.000211 1560.000000 0.000595 0.003692 0.001968 -16157 1 0.000224 1560.000000 0.001068 -0.001450 0.008526 -16158 1 0.000283 1560.000000 0.002209 0.002370 0.008487 -16159 1 0.000246 1560.000000 -0.002594 -0.000450 0.008764 -16160 1 0.000201 1560.000000 0.002251 0.000028 0.002482 -16161 1 0.000242 1560.000000 -0.000338 0.003126 0.003805 -16162 1 0.000241 1560.000000 0.000760 0.001800 0.007120 -16163 1 0.000216 1560.000000 0.001713 -0.002797 0.008038 -16164 1 0.000201 1560.000000 0.001753 0.001836 0.002815 -16165 1 0.000195 1560.000000 0.002253 0.000095 0.006545 -16166 1 0.000206 1560.000000 -0.002454 -0.000645 0.002967 -16167 1 0.000198 1560.000000 0.000519 0.003636 0.007124 -16168 1 0.000233 1560.000000 -0.000570 -0.002237 0.003755 -16169 1 0.000218 1560.000000 0.002286 0.002155 0.007451 -16170 1 0.000248 1560.000000 0.000598 -0.001906 0.005897 -16171 1 0.000246 1560.000000 -0.003208 0.002021 0.008383 -16172 1 0.000256 1560.000000 0.003836 0.000031 0.007283 -16173 1 0.000249 1560.000000 -0.002098 -0.002711 0.005915 -16174 1 0.000246 1560.000000 -0.001028 0.003341 0.002928 -16175 1 0.000196 1560.000000 -0.002012 -0.000411 0.006333 -16176 1 0.000254 1560.000000 0.002834 0.000502 0.009321 -16177 1 0.000211 1560.000000 -0.002424 -0.002919 0.005304 -16178 1 0.000215 1560.000000 -0.000241 0.003464 0.008633 -16179 1 0.000283 1560.000000 0.000938 -0.002443 0.000591 -16180 1 0.000236 1560.000000 -0.003049 -0.000727 0.005222 -16181 1 0.000198 1560.000000 0.001227 -0.001191 0.002450 -16182 1 0.000215 1560.000000 0.003831 0.000127 0.004975 -16183 1 0.000196 1560.000000 0.003299 0.001188 0.001271 -16184 1 0.000251 1560.000000 0.000311 -0.003291 0.008675 -16185 1 0.000195 1560.000000 -0.001337 0.001774 0.008404 -16186 1 0.000236 1560.000000 0.002584 -0.000620 0.006641 -16187 1 0.000259 1560.000000 -0.001103 -0.001843 0.006236 -16188 1 0.000262 1560.000000 -0.000972 -0.000805 0.004129 -16189 1 0.000254 1560.000000 0.001567 -0.001044 0.004935 -16190 1 0.000199 1560.000000 0.000800 -0.001669 0.002268 -16191 1 0.000237 1560.000000 -0.000830 -0.000689 0.006930 -16192 1 0.000229 1560.000000 0.000131 0.001726 0.002343 -16193 1 0.000225 1560.000000 -0.002526 -0.001158 0.000257 -16194 1 0.000264 1560.000000 -0.000758 -0.002097 0.005938 -16195 1 0.000279 1560.000000 -0.000041 -0.002059 0.005715 -16196 1 0.000231 1560.000000 0.000355 -0.002816 0.005815 -16197 1 0.000193 1560.000000 -0.000173 0.000688 0.008863 -16198 1 0.000248 1560.000000 -0.002083 -0.000113 0.002857 -16199 1 0.000196 1560.000000 0.000209 0.001809 0.004866 -16200 1 0.000208 1560.000000 -0.002418 -0.001687 0.008947 -16201 1 0.000232 1560.000000 0.001470 0.002944 0.002338 -16202 1 0.000270 1560.000000 0.003706 -0.000741 0.000155 -16203 1 0.000208 1560.000000 -0.001311 -0.002552 0.007463 -16204 1 0.000212 1560.000000 0.001388 0.001696 0.008771 -16205 1 0.000203 1560.000000 0.002499 -0.000330 0.004308 -16206 1 0.000210 1560.000000 -0.001765 0.000818 0.007141 -16207 1 0.000204 1560.000000 -0.003112 -0.000049 0.007469 -16208 1 0.000236 1560.000000 -0.001902 0.000501 0.005471 -16209 1 0.000273 1560.000000 -0.001361 -0.001505 0.000162 -16210 1 0.000228 1560.000000 0.000744 0.001464 0.004383 -16211 1 0.000238 1560.000000 0.003136 -0.001041 0.004915 -16212 1 0.000217 1560.000000 -0.001104 0.001344 0.000617 -16213 1 0.000201 1560.000000 0.000885 0.001583 0.004503 -16214 1 0.000209 1560.000000 0.002621 -0.000841 0.004545 -16215 1 0.000210 1560.000000 0.001543 0.003525 0.003716 -16216 1 0.000207 1560.000000 0.002992 0.000450 0.002027 -16217 1 0.000216 1560.000000 -0.001390 0.001632 0.006424 -16218 1 0.000258 1560.000000 -0.000075 0.003205 0.009074 -16219 1 0.000213 1560.000000 -0.003712 0.000482 0.007629 -16220 1 0.000201 1560.000000 -0.000087 -0.001834 0.001566 -16221 1 0.000208 1560.000000 0.001718 0.003360 0.006993 -16222 1 0.000265 1560.000000 0.001116 0.002629 0.000138 -16223 1 0.000271 1560.000000 -0.001515 0.003163 0.006805 -16224 1 0.000272 1560.000000 0.002088 -0.000267 0.008790 -16225 1 0.000244 1560.000000 0.001661 -0.002824 0.006127 -16226 1 0.000246 1560.000000 0.001953 -0.002408 0.000955 -16227 1 0.000201 1560.000000 -0.001743 -0.002071 0.001859 -16228 1 0.000239 1560.000000 0.003049 0.000239 0.002262 -16229 1 0.000202 1560.000000 0.000538 -0.000995 0.003986 -16230 1 0.000255 1560.000000 -0.003161 -0.000118 0.001610 -16231 1 0.000211 1560.000000 0.000120 -0.002470 0.002874 -16232 1 0.000272 1560.000000 -0.000797 -0.002546 0.000641 -16233 1 0.000208 1560.000000 -0.002468 0.001324 0.007796 -16234 1 0.000263 1560.000000 -0.003284 0.001395 0.000465 -16235 1 0.000225 1560.000000 -0.002372 0.001070 0.006495 -16236 1 0.000284 1560.000000 -0.002945 -0.002066 0.002331 -16237 1 0.000257 1560.000000 0.001107 -0.002609 0.005337 -16238 1 0.000197 1560.000000 -0.000693 -0.001393 0.005141 -16239 1 0.000230 1560.000000 -0.001194 -0.003646 0.007173 -16240 1 0.000251 1560.000000 0.000522 0.000017 0.001984 -16241 1 0.000255 1560.000000 0.001152 -0.003668 0.005874 -16242 1 0.000231 1560.000000 0.002616 0.000313 0.000842 -16243 1 0.000217 1560.000000 0.002314 0.000753 0.005699 -16244 1 0.000244 1560.000000 0.001263 0.001715 0.007737 -16245 1 0.000217 1560.000000 0.001987 -0.003246 0.008360 -16246 1 0.000264 1560.000000 -0.000386 0.002574 0.000361 -16247 1 0.000288 1560.000000 0.002539 0.000460 0.001383 -16248 1 0.000208 1560.000000 0.000242 -0.000660 0.008879 -16249 1 0.000261 1560.000000 -0.001170 0.000816 0.007085 -16250 1 0.000221 1560.000000 -0.002959 0.001620 0.004853 -16251 1 0.000217 1560.000000 0.000394 0.000430 0.004172 -16252 1 0.000218 1560.000000 0.002228 0.000935 0.002936 -16253 1 0.000275 1560.000000 0.002897 0.001186 0.004020 -16254 1 0.000249 1560.000000 -0.001280 0.001731 0.004934 -16255 1 0.000217 1560.000000 0.000339 0.003678 0.002128 -16256 1 0.000244 1560.000000 0.001092 -0.001657 0.003648 -16257 1 0.000273 1560.000000 -0.000801 0.000528 0.001175 -16258 1 0.000193 1560.000000 -0.001380 0.000839 0.009109 -16259 1 0.000272 1560.000000 0.003221 -0.001497 0.009759 -16260 1 0.000215 1560.000000 -0.001291 -0.001988 0.005095 -16261 1 0.000216 1560.000000 0.002597 -0.000282 0.008612 -16262 1 0.000222 1560.000000 0.002306 -0.001178 0.008890 -16263 1 0.000260 1560.000000 0.003694 -0.001036 0.007033 -16264 1 0.000200 1560.000000 -0.000802 -0.002402 0.006387 -16265 1 0.000278 1560.000000 0.002338 -0.001688 0.001623 -16266 1 0.000275 1560.000000 0.002317 -0.001771 0.000802 -16267 1 0.000281 1560.000000 0.000419 -0.003091 0.002510 -16268 1 0.000223 1560.000000 -0.002978 0.002096 0.003752 -16269 1 0.000202 1560.000000 0.000490 0.001881 0.009618 -16270 1 0.000252 1560.000000 -0.001691 -0.001240 0.008451 -16271 1 0.000200 1560.000000 -0.003244 -0.000348 0.001086 -16272 1 0.000215 1560.000000 0.003488 0.000246 0.001828 -16273 1 0.000192 1560.000000 0.000689 -0.000708 0.000169 -16274 1 0.000250 1560.000000 -0.000288 0.003693 0.007516 -16275 1 0.000245 1560.000000 -0.000729 0.001723 0.007327 -16276 1 0.000221 1560.000000 0.000680 -0.003410 0.004553 -16277 1 0.000204 1560.000000 -0.001499 0.002052 0.005312 -16278 1 0.000199 1560.000000 -0.003049 0.001968 0.005157 -16279 1 0.000200 1560.000000 0.001969 0.000051 0.005312 -16280 1 0.000233 1560.000000 0.002075 -0.000724 0.005453 -16281 1 0.000227 1560.000000 0.000585 -0.000770 0.008900 -16282 1 0.000205 1560.000000 -0.002158 -0.002794 0.007220 -16283 1 0.000194 1560.000000 0.002150 0.002126 0.008524 -16284 1 0.000239 1560.000000 -0.001399 -0.003538 0.007622 -16285 1 0.000274 1560.000000 -0.003230 -0.000915 0.003373 -16286 1 0.000229 1560.000000 -0.003244 -0.000936 0.005860 -16287 1 0.000237 1560.000000 0.002370 0.001660 0.001671 -16288 1 0.000215 1560.000000 0.001896 0.002640 0.004230 -16289 1 0.000280 1560.000000 0.002178 -0.000259 0.003302 -16290 1 0.000218 1560.000000 -0.000501 -0.001324 0.009279 -16291 1 0.000195 1560.000000 -0.000765 -0.002331 0.005983 -16292 1 0.000201 1560.000000 0.001387 0.002662 0.005837 -16293 1 0.000221 1560.000000 -0.001182 0.000173 0.003936 -16294 1 0.000216 1560.000000 0.000390 0.000615 0.008100 -16295 1 0.000230 1560.000000 0.002438 0.000236 0.005952 -16296 1 0.000286 1560.000000 -0.000828 0.002986 0.009173 -16297 1 0.000234 1560.000000 -0.000383 -0.003331 0.006887 -16298 1 0.000268 1560.000000 -0.003041 -0.002345 0.007780 -16299 1 0.000239 1560.000000 -0.000988 0.003039 0.002840 -16300 1 0.000263 1560.000000 -0.001976 -0.001474 0.008750 -16301 1 0.000274 1560.000000 -0.001575 -0.002011 0.004965 -16302 1 0.000216 1560.000000 -0.001809 -0.000165 0.004925 -16303 1 0.000199 1560.000000 0.000736 0.000951 0.005778 -16304 1 0.000217 1560.000000 -0.001948 -0.002139 0.003215 -16305 1 0.000266 1560.000000 -0.002385 -0.000132 0.007164 -16306 1 0.000258 1560.000000 0.002231 0.001696 0.007318 -16307 1 0.000279 1560.000000 -0.000438 -0.003739 0.004726 -16308 1 0.000193 1560.000000 -0.001268 0.001457 0.007765 -16309 1 0.000274 1560.000000 -0.002208 -0.001030 0.009511 -16310 1 0.000227 1560.000000 -0.002389 0.001382 0.006596 -16311 1 0.000223 1560.000000 0.001951 0.002374 0.009804 -16312 1 0.000269 1560.000000 -0.000665 -0.003429 0.001842 -16313 1 0.000228 1560.000000 0.000011 -0.002912 0.003366 -16314 1 0.000252 1560.000000 -0.001664 -0.002513 0.009017 -16315 1 0.000268 1560.000000 -0.002168 0.001869 0.003055 -16316 1 0.000266 1560.000000 -0.002086 0.001938 0.006693 -16317 1 0.000274 1560.000000 0.002667 -0.000848 0.004194 -16318 1 0.000194 1560.000000 0.001808 -0.001248 0.000389 -16319 1 0.000234 1560.000000 -0.000935 -0.002169 0.004063 -16320 1 0.000202 1560.000000 -0.000089 0.003815 0.008248 -16321 1 0.000203 1560.000000 -0.000363 0.001041 0.001468 -16322 1 0.000284 1560.000000 -0.002407 0.002605 0.004554 -16323 1 0.000284 1560.000000 -0.003459 0.000681 0.001440 -16324 1 0.000287 1560.000000 0.000544 0.003339 0.000773 -16325 1 0.000233 1560.000000 0.000738 -0.001224 0.000498 -16326 1 0.000231 1560.000000 -0.001700 -0.002862 0.003243 -16327 1 0.000242 1560.000000 -0.000570 0.001776 0.000427 -16328 1 0.000208 1560.000000 -0.000991 0.000025 0.005451 -16329 1 0.000196 1560.000000 0.003266 0.001832 0.007754 -16330 1 0.000243 1560.000000 0.002690 -0.001057 0.009654 -16331 1 0.000251 1560.000000 0.001781 -0.003117 0.008906 -16332 1 0.000266 1560.000000 -0.003434 -0.001381 0.005145 -16333 1 0.000194 1560.000000 -0.001848 0.001084 0.002767 -16334 1 0.000226 1560.000000 -0.001882 0.002924 0.005986 -16335 1 0.000207 1560.000000 0.002918 -0.001823 0.003485 -16336 1 0.000210 1560.000000 -0.001202 -0.001505 0.007342 -16337 1 0.000207 1560.000000 -0.000539 -0.000642 0.004423 -16338 1 0.000245 1560.000000 0.002229 -0.002586 0.003899 -16339 1 0.000230 1560.000000 -0.001239 0.003296 0.000564 -16340 1 0.000204 1560.000000 0.001479 -0.003203 0.004732 -16341 1 0.000212 1560.000000 0.000698 0.002740 0.000170 -16342 1 0.000196 1560.000000 0.002241 -0.000392 0.006298 -16343 1 0.000263 1560.000000 0.000160 -0.003694 0.009749 -16344 1 0.000235 1560.000000 -0.001338 -0.002599 0.008989 -16345 1 0.000234 1560.000000 0.002188 0.000537 0.004567 -16346 1 0.000219 1560.000000 -0.002517 -0.000279 0.003231 -16347 1 0.000264 1560.000000 -0.002759 -0.001991 0.005420 -16348 1 0.000234 1560.000000 0.001211 -0.000805 0.008038 -16349 1 0.000212 1560.000000 -0.003104 0.001052 0.001622 -16350 1 0.000194 1560.000000 0.001497 0.001944 0.006651 -16351 1 0.000244 1560.000000 0.000631 0.003410 0.005691 -16352 1 0.000259 1560.000000 -0.000650 0.002970 0.007724 -16353 1 0.000205 1560.000000 0.000543 0.002699 0.007750 -16354 1 0.000197 1560.000000 0.001327 0.002292 0.001541 -16355 1 0.000230 1560.000000 0.000809 -0.002568 0.006884 -16356 1 0.000285 1560.000000 0.002506 -0.001187 0.005193 -16357 1 0.000255 1560.000000 0.000647 0.003151 0.001065 -16358 1 0.000224 1560.000000 -0.000456 0.002594 0.003512 -16359 1 0.000266 1560.000000 0.002306 0.001478 0.003233 -16360 1 0.000197 1560.000000 0.000765 -0.000365 0.006910 -16361 1 0.000229 1560.000000 0.002848 -0.001852 0.006971 -16362 1 0.000219 1560.000000 0.002472 -0.002934 0.003050 -16363 1 0.000214 1560.000000 0.001074 0.001242 0.004006 -16364 1 0.000287 1560.000000 -0.001992 0.000058 0.007834 -16365 1 0.000202 1560.000000 -0.000237 -0.003523 0.003065 -16366 1 0.000199 1560.000000 0.001987 -0.000107 0.008611 -16367 1 0.000217 1560.000000 -0.001883 0.000930 0.003162 -16368 1 0.000195 1560.000000 0.000723 -0.001811 0.000105 -16369 1 0.000195 1560.000000 0.000963 -0.000091 0.008481 -16370 1 0.000205 1560.000000 -0.001245 -0.003260 0.004480 -16371 1 0.000219 1560.000000 -0.000093 -0.001716 0.005418 -16372 1 0.000231 1560.000000 -0.002221 0.001363 0.003046 -16373 1 0.000243 1560.000000 0.001968 0.002448 0.002925 -16374 1 0.000265 1560.000000 0.001728 0.001690 0.009363 -16375 1 0.000207 1560.000000 0.002924 0.001899 0.007929 -16376 1 0.000262 1560.000000 0.002658 0.001972 0.006517 -16377 1 0.000232 1560.000000 0.001731 0.001405 0.003801 -16378 1 0.000215 1560.000000 0.002558 0.000683 0.008370 -16379 1 0.000210 1560.000000 0.003268 0.001800 0.002644 -16380 1 0.000226 1560.000000 -0.002034 0.002475 0.003035 -16381 1 0.000236 1560.000000 0.000048 0.001450 0.005279 -16382 1 0.000210 1560.000000 -0.003843 0.000014 0.000204 -16383 1 0.000222 1560.000000 0.000706 0.000554 0.002192 -16384 1 0.000198 1560.000000 0.000881 -0.002113 0.008237 -16385 1 0.000253 1560.000000 -0.001305 0.002841 0.004785 -16386 1 0.000232 1560.000000 0.001713 -0.000048 0.004011 -16387 1 0.000237 1560.000000 -0.000764 -0.003725 0.000252 -16388 1 0.000251 1560.000000 -0.002831 0.001792 0.009559 -16389 1 0.000283 1560.000000 0.003275 0.000631 0.007139 -16390 1 0.000283 1560.000000 -0.002990 -0.002034 0.002750 -16391 1 0.000208 1560.000000 -0.000389 -0.002198 0.008785 -16392 1 0.000249 1560.000000 -0.002819 0.002623 0.006370 -16393 1 0.000216 1560.000000 0.001173 0.001073 0.000235 -16394 1 0.000226 1560.000000 0.000593 -0.000249 0.001081 -16395 1 0.000202 1560.000000 0.001342 -0.000697 0.004677 -16396 1 0.000217 1560.000000 0.000431 0.002908 0.007271 -16397 1 0.000233 1560.000000 0.000097 -0.000846 0.005279 -16398 1 0.000234 1560.000000 0.000940 -0.000858 0.004271 -16399 1 0.000262 1560.000000 -0.001792 -0.002344 0.002794 -16400 1 0.000266 1560.000000 -0.000409 -0.003376 0.000408 -16401 1 0.000217 1560.000000 0.001231 -0.000866 0.001009 -16402 1 0.000246 1560.000000 -0.002477 0.002712 0.006507 -16403 1 0.000197 1560.000000 0.000834 -0.002414 0.002723 -16404 1 0.000259 1560.000000 0.001121 -0.003450 0.004138 -16405 1 0.000254 1560.000000 -0.000582 0.002945 0.004708 -16406 1 0.000258 1560.000000 -0.001182 -0.001547 0.004497 -16407 1 0.000215 1560.000000 0.003232 0.000308 0.007335 -16408 1 0.000287 1560.000000 -0.002325 -0.003066 0.009034 -16409 1 0.000235 1560.000000 0.000469 0.003228 0.009456 -16410 1 0.000216 1560.000000 -0.000455 -0.000320 0.000304 -16411 1 0.000262 1560.000000 0.000615 -0.002087 0.002687 -16412 1 0.000205 1560.000000 0.002927 -0.002450 0.008741 -16413 1 0.000205 1560.000000 -0.001990 -0.003262 0.006446 -16414 1 0.000211 1560.000000 -0.001466 0.001377 0.004720 -16415 1 0.000276 1560.000000 0.001520 0.000355 0.007818 -16416 1 0.000266 1560.000000 -0.000523 -0.002027 0.004725 -16417 1 0.000262 1560.000000 -0.001122 0.003495 0.008100 -16418 1 0.000264 1560.000000 0.001973 0.001859 0.003491 -16419 1 0.000196 1560.000000 -0.003380 -0.001426 0.003319 -16420 1 0.000269 1560.000000 0.000293 -0.002419 0.000645 -16421 1 0.000210 1560.000000 -0.000010 0.001461 0.009143 -16422 1 0.000284 1560.000000 -0.001427 -0.002362 0.000182 -16423 1 0.000251 1560.000000 0.001217 0.000691 0.002709 -16424 1 0.000197 1560.000000 0.001479 -0.003138 0.008170 -16425 1 0.000214 1560.000000 0.001533 0.003148 0.000880 -16426 1 0.000272 1560.000000 -0.001999 -0.001848 0.004069 -16427 1 0.000213 1560.000000 -0.003384 0.001094 0.004298 -16428 1 0.000210 1560.000000 0.001408 0.001157 0.001232 -16429 1 0.000205 1560.000000 -0.001873 -0.001253 0.009344 -16430 1 0.000204 1560.000000 0.002823 -0.000086 0.005289 -16431 1 0.000239 1560.000000 -0.002627 0.002749 0.001621 -16432 1 0.000208 1560.000000 0.001672 -0.001333 0.006844 -16433 1 0.000286 1560.000000 0.001961 0.003101 0.000905 -16434 1 0.000209 1560.000000 0.000068 0.001699 0.005900 -16435 1 0.000235 1560.000000 0.000657 0.002673 0.003103 -16436 1 0.000245 1560.000000 -0.000920 -0.000482 0.000468 -16437 1 0.000220 1560.000000 0.001573 0.000735 0.007589 -16438 1 0.000220 1560.000000 -0.002722 -0.002644 0.004715 -16439 1 0.000219 1560.000000 -0.000419 -0.001688 0.006060 -16440 1 0.000213 1560.000000 -0.000845 -0.001060 0.004191 -16441 1 0.000195 1560.000000 -0.002998 0.001674 0.007851 -16442 1 0.000234 1560.000000 -0.000340 0.001446 0.003509 -16443 1 0.000274 1560.000000 -0.003571 0.000997 0.003686 -16444 1 0.000218 1560.000000 -0.001688 0.002597 0.008047 -16445 1 0.000222 1560.000000 0.002257 -0.000553 0.004155 -16446 1 0.000285 1560.000000 -0.001886 -0.002769 0.002409 -16447 1 0.000196 1560.000000 0.001822 0.002989 0.007683 -16448 1 0.000284 1560.000000 -0.000264 -0.003373 0.002546 -16449 1 0.000218 1560.000000 0.003351 0.000959 0.005778 -16450 1 0.000221 1560.000000 -0.003835 -0.000292 0.001622 -16451 1 0.000235 1560.000000 -0.002356 0.001656 0.004695 -16452 1 0.000257 1560.000000 -0.002565 0.002470 0.001882 -16453 1 0.000222 1560.000000 0.002029 -0.003261 0.005637 -16454 1 0.000263 1560.000000 -0.002282 0.000550 0.000395 -16455 1 0.000235 1560.000000 0.002543 0.002891 0.000586 -16456 1 0.000198 1560.000000 0.000330 -0.000588 0.000520 -16457 1 0.000250 1560.000000 -0.002823 0.000032 0.000427 -16458 1 0.000205 1560.000000 -0.001589 0.001913 0.009443 -16459 1 0.000281 1560.000000 0.002807 -0.000418 0.004673 -16460 1 0.000193 1560.000000 0.002340 -0.001448 0.000106 -16461 1 0.000238 1560.000000 -0.002538 -0.000184 0.009383 -16462 1 0.000251 1560.000000 0.001259 0.002411 0.007529 -16463 1 0.000262 1560.000000 0.001180 -0.001833 0.007997 -16464 1 0.000235 1560.000000 0.000535 0.002382 0.007481 -16465 1 0.000254 1560.000000 0.002425 -0.000181 0.008020 -16466 1 0.000266 1560.000000 -0.001293 0.003619 0.002710 -16467 1 0.000201 1560.000000 -0.003702 -0.000062 0.003990 -16468 1 0.000285 1560.000000 -0.002057 0.001833 0.008013 -16469 1 0.000223 1560.000000 -0.001285 -0.001702 0.008158 -16470 1 0.000272 1560.000000 0.002805 0.002546 0.006729 -16471 1 0.000219 1560.000000 0.001736 0.002118 0.005492 -16472 1 0.000248 1560.000000 0.002250 0.000144 0.000183 -16473 1 0.000288 1560.000000 -0.002138 0.001754 0.005519 -16474 1 0.000215 1560.000000 -0.000873 0.003112 0.001659 -16475 1 0.000236 1560.000000 -0.001488 0.001823 0.003436 -16476 1 0.000195 1560.000000 0.000616 -0.003226 0.008543 -16477 1 0.000214 1560.000000 0.001108 -0.001610 0.001336 -16478 1 0.000220 1560.000000 -0.001391 -0.002187 0.000766 -16479 1 0.000195 1560.000000 0.001422 -0.000269 0.001983 -16480 1 0.000231 1560.000000 -0.001916 0.002845 0.006560 -16481 1 0.000275 1560.000000 -0.001045 0.000177 0.000149 -16482 1 0.000270 1560.000000 -0.003308 0.001899 0.009835 -16483 1 0.000231 1560.000000 -0.002214 -0.000599 0.005302 -16484 1 0.000231 1560.000000 -0.003037 -0.000158 0.005996 -16485 1 0.000276 1560.000000 -0.000068 0.002723 0.008387 -16486 1 0.000196 1560.000000 -0.000496 -0.003654 0.008826 -16487 1 0.000214 1560.000000 0.002785 0.001394 0.002000 -16488 1 0.000258 1560.000000 -0.003394 0.000559 0.000738 -16489 1 0.000244 1560.000000 0.002117 -0.002625 0.001084 -16490 1 0.000212 1560.000000 -0.000678 -0.002537 0.007507 -16491 1 0.000240 1560.000000 0.001050 0.003488 0.000753 -16492 1 0.000256 1560.000000 -0.002188 0.000335 0.002099 -16493 1 0.000204 1560.000000 0.002179 0.002770 0.006906 -16494 1 0.000288 1560.000000 -0.003665 -0.000927 0.002661 -16495 1 0.000208 1560.000000 0.001392 -0.000337 0.005379 -16496 1 0.000221 1560.000000 -0.000769 0.002888 0.001887 -16497 1 0.000263 1560.000000 -0.001079 -0.003550 0.003849 -16498 1 0.000225 1560.000000 -0.003075 0.002275 0.004736 -16499 1 0.000260 1560.000000 -0.001245 0.000480 0.002749 -16500 1 0.000246 1560.000000 0.002239 -0.001031 0.005907 -16501 1 0.000270 1560.000000 0.001985 -0.001286 0.007418 -16502 1 0.000281 1560.000000 0.000005 0.002295 0.008931 -16503 1 0.000244 1560.000000 -0.001390 0.000391 0.007669 -16504 1 0.000202 1560.000000 -0.003280 -0.000784 0.006553 -16505 1 0.000196 1560.000000 -0.002632 -0.000368 0.005611 -16506 1 0.000250 1560.000000 -0.002511 0.000782 0.005009 -16507 1 0.000233 1560.000000 0.000297 0.000611 0.000119 -16508 1 0.000205 1560.000000 -0.000451 -0.003015 0.005398 -16509 1 0.000227 1560.000000 0.001483 0.003034 0.002123 -16510 1 0.000227 1560.000000 0.002768 0.000261 0.004228 -16511 1 0.000225 1560.000000 -0.000082 -0.002959 0.004880 -16512 1 0.000240 1560.000000 0.002471 -0.001199 0.000165 -16513 1 0.000264 1560.000000 -0.001954 0.001512 0.005519 -16514 1 0.000198 1560.000000 0.002383 0.001008 0.007096 -16515 1 0.000198 1560.000000 -0.000054 0.001863 0.005526 -16516 1 0.000275 1560.000000 -0.002784 -0.001976 0.001938 -16517 1 0.000234 1560.000000 0.001644 -0.000042 0.004255 -16518 1 0.000239 1560.000000 0.001637 -0.001728 0.002920 -16519 1 0.000264 1560.000000 0.000995 0.003721 0.007148 -16520 1 0.000273 1560.000000 0.001699 0.003347 0.000215 -16521 1 0.000252 1560.000000 0.000795 0.001439 0.000629 -16522 1 0.000236 1560.000000 0.000294 -0.002857 0.003231 -16523 1 0.000227 1560.000000 -0.001613 0.002709 0.005993 -16524 1 0.000215 1560.000000 0.000593 0.001124 0.003989 -16525 1 0.000237 1560.000000 0.003246 -0.000699 0.004193 -16526 1 0.000201 1560.000000 -0.000949 0.003046 0.006982 -16527 1 0.000244 1560.000000 -0.001926 0.003291 0.002814 -16528 1 0.000286 1560.000000 -0.003049 -0.001824 0.008894 -16529 1 0.000205 1560.000000 0.000797 -0.000633 0.003080 -16530 1 0.000199 1560.000000 -0.000904 0.003446 0.001000 -16531 1 0.000224 1560.000000 -0.001470 0.002956 0.003014 -16532 1 0.000247 1560.000000 -0.000227 -0.003628 0.005229 -16533 1 0.000284 1560.000000 0.002369 -0.000880 0.002712 -16534 1 0.000212 1560.000000 0.000643 -0.001762 0.005711 -16535 1 0.000254 1560.000000 -0.002130 0.002431 0.006802 -16536 1 0.000198 1560.000000 0.000970 -0.002396 0.006188 -16537 1 0.000193 1560.000000 -0.002061 0.002257 0.009440 -16538 1 0.000196 1560.000000 0.001804 0.000978 0.006155 -16539 1 0.000276 1560.000000 0.001078 -0.000971 0.008806 -16540 1 0.000227 1560.000000 0.000552 -0.001243 0.009818 -16541 1 0.000241 1560.000000 -0.001104 -0.003056 0.005898 -16542 1 0.000204 1560.000000 0.002828 -0.000667 0.002519 -16543 1 0.000227 1560.000000 -0.001369 -0.001657 0.009499 -16544 1 0.000195 1560.000000 -0.000628 -0.001928 0.001731 -16545 1 0.000198 1560.000000 -0.000632 0.000198 0.007349 -16546 1 0.000198 1560.000000 0.000007 0.002522 0.002885 -16547 1 0.000248 1560.000000 0.000931 0.000668 0.006443 -16548 1 0.000209 1560.000000 -0.002785 0.002171 0.003923 -16549 1 0.000276 1560.000000 0.003527 0.001479 0.005372 -16550 1 0.000199 1560.000000 0.001280 -0.003034 0.006609 -16551 1 0.000197 1560.000000 -0.001578 0.003062 0.004418 -16552 1 0.000201 1560.000000 0.000476 -0.002020 0.001166 -16553 1 0.000238 1560.000000 -0.000213 0.002300 0.003670 -16554 1 0.000217 1560.000000 0.002644 -0.001473 0.005449 -16555 1 0.000217 1560.000000 0.002298 -0.002600 0.004289 -16556 1 0.000229 1560.000000 -0.003230 -0.002035 0.005142 -16557 1 0.000230 1560.000000 -0.000932 0.002137 0.003384 -16558 1 0.000196 1560.000000 0.003594 0.000422 0.005198 -16559 1 0.000205 1560.000000 0.003588 -0.000437 0.000237 -16560 1 0.000207 1560.000000 -0.002543 -0.000103 0.007637 -16561 1 0.000219 1560.000000 0.000618 0.001822 0.003257 -16562 1 0.000208 1560.000000 -0.002140 0.000469 0.003371 -16563 1 0.000279 1560.000000 -0.000591 0.003784 0.004378 -16564 1 0.000204 1560.000000 0.003136 -0.000422 0.007809 -16565 1 0.000206 1560.000000 -0.000670 -0.000618 0.000607 -16566 1 0.000209 1560.000000 0.000102 -0.003031 0.007626 -16567 1 0.000196 1560.000000 -0.003273 0.000219 0.009651 -16568 1 0.000256 1560.000000 0.000933 0.001201 0.009686 -16569 1 0.000273 1560.000000 -0.002590 -0.002519 0.003304 -16570 1 0.000274 1560.000000 -0.000810 -0.002738 0.008003 -16571 1 0.000210 1560.000000 -0.001515 -0.001190 0.009283 -16572 1 0.000240 1560.000000 0.002886 -0.000610 0.002294 -16573 1 0.000246 1560.000000 -0.001861 -0.002187 0.009816 -16574 1 0.000221 1560.000000 0.001915 0.003309 0.005828 -16575 1 0.000276 1560.000000 -0.003520 0.001229 0.005403 -16576 1 0.000224 1560.000000 -0.002567 -0.000422 0.009310 -16577 1 0.000258 1560.000000 0.000490 0.003200 0.005756 -16578 1 0.000223 1560.000000 -0.000530 -0.002022 0.008558 -16579 1 0.000240 1560.000000 0.001079 -0.002799 0.001674 -16580 1 0.000218 1560.000000 0.002607 -0.002255 0.008085 -16581 1 0.000218 1560.000000 0.002960 -0.001935 0.004041 -16582 1 0.000220 1560.000000 0.001353 0.000119 0.000151 -16583 1 0.000282 1560.000000 0.000056 0.003808 0.001162 -16584 1 0.000233 1560.000000 0.000872 -0.000407 0.007146 -16585 1 0.000234 1560.000000 0.003098 0.002283 0.000547 -16586 1 0.000280 1560.000000 0.001173 0.003146 0.009828 -16587 1 0.000256 1560.000000 0.000660 0.002958 0.007182 -16588 1 0.000204 1560.000000 -0.001582 -0.002472 0.005136 -16589 1 0.000268 1560.000000 -0.001763 -0.001555 0.004026 -16590 1 0.000215 1560.000000 0.003593 0.000431 0.001621 -16591 1 0.000224 1560.000000 -0.002271 -0.002187 0.008569 -16592 1 0.000287 1560.000000 0.000853 -0.003039 0.005407 -16593 1 0.000246 1560.000000 -0.003510 -0.001427 0.003888 -16594 1 0.000222 1560.000000 0.002466 -0.001570 0.009607 -16595 1 0.000217 1560.000000 -0.002506 -0.000753 0.002108 -16596 1 0.000194 1560.000000 -0.000476 0.002613 0.003200 -16597 1 0.000225 1560.000000 0.000496 -0.003525 0.008433 -16598 1 0.000239 1560.000000 0.000366 0.003433 0.001342 -16599 1 0.000274 1560.000000 -0.000958 -0.001457 0.001837 -16600 1 0.000205 1560.000000 -0.000655 0.003633 0.005761 -16601 1 0.000211 1560.000000 0.001303 0.001054 0.008595 -16602 1 0.000232 1560.000000 0.000099 0.001680 0.000951 -16603 1 0.000198 1560.000000 0.003607 -0.000633 0.009096 -16604 1 0.000204 1560.000000 -0.002320 0.002380 0.003391 -16605 1 0.000230 1560.000000 0.001761 0.000222 0.008517 -16606 1 0.000225 1560.000000 -0.002314 0.002804 0.001391 -16607 1 0.000213 1560.000000 -0.001648 0.003214 0.008815 -16608 1 0.000196 1560.000000 -0.003625 0.000563 0.008646 -16609 1 0.000221 1560.000000 0.001933 -0.002428 0.002917 -16610 1 0.000248 1560.000000 0.001622 -0.002139 0.000503 -16611 1 0.000273 1560.000000 -0.000836 0.000602 0.005313 -16612 1 0.000258 1560.000000 -0.000289 -0.001321 0.007198 -16613 1 0.000224 1560.000000 -0.003561 0.000531 0.009806 -16614 1 0.000223 1560.000000 0.002067 -0.001564 0.001486 -16615 1 0.000228 1560.000000 -0.001072 -0.002575 0.000135 -16616 1 0.000194 1560.000000 0.000099 0.002939 0.000405 -16617 1 0.000266 1560.000000 -0.000882 0.002933 0.004191 -16618 1 0.000209 1560.000000 0.001382 -0.003309 0.000155 -16619 1 0.000224 1560.000000 -0.000738 0.003382 0.000431 -16620 1 0.000200 1560.000000 0.000620 -0.001693 0.006172 -16621 1 0.000244 1560.000000 0.002793 -0.002126 0.000314 -16622 1 0.000201 1560.000000 0.000278 0.001937 0.006435 -16623 1 0.000197 1560.000000 0.001001 0.000588 0.001415 -16624 1 0.000249 1560.000000 -0.003273 0.000045 0.004830 -16625 1 0.000198 1560.000000 -0.000285 0.003087 0.008335 -16626 1 0.000227 1560.000000 0.003421 -0.001435 0.005821 -16627 1 0.000259 1560.000000 -0.003718 0.000337 0.009750 -16628 1 0.000224 1560.000000 -0.002154 -0.001490 0.003159 -16629 1 0.000193 1560.000000 0.000318 -0.001409 0.009455 -16630 1 0.000271 1560.000000 0.001668 -0.002909 0.006844 -16631 1 0.000251 1560.000000 -0.000313 0.001129 0.002333 -16632 1 0.000202 1560.000000 -0.002478 0.000410 0.005291 -16633 1 0.000237 1560.000000 0.000202 -0.003640 0.005082 -16634 1 0.000284 1560.000000 0.002953 -0.001019 0.003219 -16635 1 0.000198 1560.000000 -0.001454 0.001601 0.005925 -16636 1 0.000204 1560.000000 0.000112 -0.001821 0.007784 -16637 1 0.000225 1560.000000 0.002458 0.000317 0.004624 -16638 1 0.000285 1560.000000 0.002318 -0.002214 0.008461 -16639 1 0.000242 1560.000000 -0.002592 0.000654 0.005593 -16640 1 0.000263 1560.000000 -0.002046 -0.000467 0.007724 -16641 1 0.000255 1560.000000 0.003427 -0.001749 0.005590 -16642 1 0.000281 1560.000000 0.002015 0.003270 0.002371 -16643 1 0.000238 1560.000000 -0.002177 -0.000930 0.002534 -16644 1 0.000229 1560.000000 0.002090 -0.002657 0.002327 -16645 1 0.000249 1560.000000 0.000651 -0.002379 0.007063 -16646 1 0.000207 1560.000000 -0.000562 0.002899 0.008868 -16647 1 0.000256 1560.000000 -0.000199 -0.002827 0.008383 -16648 1 0.000223 1560.000000 0.002464 0.001463 0.001262 -16649 1 0.000217 1560.000000 0.002861 0.002529 0.009400 -16650 1 0.000241 1560.000000 -0.002421 -0.000227 0.003954 -16651 1 0.000276 1560.000000 0.001423 -0.003536 0.006903 -16652 1 0.000247 1560.000000 -0.003022 0.000433 0.000233 -16653 1 0.000203 1560.000000 -0.001079 0.000004 0.004114 -16654 1 0.000278 1560.000000 -0.001119 0.000137 0.008295 -16655 1 0.000263 1560.000000 -0.000116 -0.003594 0.005812 -16656 1 0.000238 1560.000000 0.001860 0.002195 0.006933 -16657 1 0.000226 1560.000000 0.002598 0.001008 0.002939 -16658 1 0.000269 1560.000000 -0.003493 0.000354 0.005983 -16659 1 0.000195 1560.000000 0.000655 -0.002045 0.001671 -16660 1 0.000201 1560.000000 -0.000779 0.002643 0.005094 -16661 1 0.000229 1560.000000 0.002373 0.000694 0.000884 -16662 1 0.000214 1560.000000 0.001666 -0.003447 0.004359 -16663 1 0.000197 1560.000000 0.001002 0.003063 0.007547 -16664 1 0.000241 1560.000000 -0.002504 0.002543 0.003915 -16665 1 0.000208 1560.000000 0.000165 0.002203 0.003568 -16666 1 0.000247 1560.000000 -0.000566 -0.001902 0.007086 -16667 1 0.000270 1560.000000 0.000889 0.002950 0.001949 -16668 1 0.000269 1560.000000 0.000533 -0.001814 0.001637 -16669 1 0.000199 1560.000000 -0.001005 0.002877 0.004503 -16670 1 0.000193 1560.000000 0.002615 -0.000751 0.009069 -16671 1 0.000205 1560.000000 0.000810 -0.000301 0.003966 -16672 1 0.000248 1560.000000 0.001993 0.003000 0.007960 -16673 1 0.000213 1560.000000 0.001869 0.000196 0.002752 -16674 1 0.000197 1560.000000 0.000513 -0.001408 0.006233 -16675 1 0.000281 1560.000000 -0.002647 0.000410 0.003846 -16676 1 0.000228 1560.000000 0.000389 -0.003750 0.009238 -16677 1 0.000233 1560.000000 -0.001645 -0.002999 0.005109 -16678 1 0.000225 1560.000000 -0.002579 -0.000494 0.003410 -16679 1 0.000232 1560.000000 -0.000217 -0.001587 0.000202 -16680 1 0.000247 1560.000000 -0.002794 -0.001855 0.000785 -16681 1 0.000226 1560.000000 0.002280 0.001525 0.009147 -16682 1 0.000204 1560.000000 0.000670 0.002611 0.002050 -16683 1 0.000223 1560.000000 0.002177 0.002764 0.005909 -16684 1 0.000244 1560.000000 -0.000273 -0.003094 0.002096 -16685 1 0.000251 1560.000000 -0.003146 0.002168 0.007223 -16686 1 0.000206 1560.000000 -0.003843 0.000026 0.005154 -16687 1 0.000216 1560.000000 0.002916 0.001908 0.001054 -16688 1 0.000276 1560.000000 0.002566 0.000362 0.001852 -16689 1 0.000213 1560.000000 0.003300 -0.000743 0.000383 -16690 1 0.000229 1560.000000 -0.000986 0.000858 0.004671 -16691 1 0.000265 1560.000000 0.001666 -0.001404 0.003071 -16692 1 0.000213 1560.000000 0.000568 0.000675 0.006366 -16693 1 0.000281 1560.000000 0.003654 0.000003 0.000958 -16694 1 0.000239 1560.000000 0.003352 0.000605 0.000573 -16695 1 0.000246 1560.000000 0.002300 0.000597 0.008993 -16696 1 0.000195 1560.000000 0.003242 -0.000231 0.000716 -16697 1 0.000268 1560.000000 -0.000822 0.003570 0.003021 -16698 1 0.000220 1560.000000 0.000652 0.003289 0.008450 -16699 1 0.000269 1560.000000 0.003315 -0.001769 0.009220 -16700 1 0.000228 1560.000000 -0.001703 -0.002433 0.008129 -16701 1 0.000239 1560.000000 -0.002004 -0.000476 0.001487 -16702 1 0.000193 1560.000000 -0.000734 -0.002257 0.007617 -16703 1 0.000255 1560.000000 0.000373 0.003201 0.007957 -16704 1 0.000241 1560.000000 -0.001671 -0.000663 0.004819 -16705 1 0.000243 1560.000000 0.000484 -0.003358 0.009077 -16706 1 0.000236 1560.000000 -0.000676 -0.002184 0.009209 -16707 1 0.000272 1560.000000 -0.000543 0.002760 0.006860 -16708 1 0.000225 1560.000000 -0.000118 -0.001040 0.003461 -16709 1 0.000213 1560.000000 -0.001441 0.003563 0.009126 -16710 1 0.000215 1560.000000 0.000330 0.002461 0.008557 -16711 1 0.000250 1560.000000 -0.000803 -0.003110 0.003658 -16712 1 0.000228 1560.000000 -0.000886 0.001242 0.007704 -16713 1 0.000246 1560.000000 -0.002695 0.000662 0.006895 -16714 1 0.000215 1560.000000 0.001093 0.003409 0.004097 -16715 1 0.000227 1560.000000 0.002971 -0.001558 0.005462 -16716 1 0.000226 1560.000000 -0.000756 -0.000322 0.003006 -16717 1 0.000267 1560.000000 0.003645 0.000323 0.008962 -16718 1 0.000228 1560.000000 -0.000631 0.001992 0.001181 -16719 1 0.000286 1560.000000 -0.002879 0.000388 0.002532 -16720 1 0.000268 1560.000000 -0.002787 -0.001610 0.008116 -16721 1 0.000255 1560.000000 -0.000054 -0.001626 0.006893 -16722 1 0.000226 1560.000000 0.001698 0.001259 0.001676 -16723 1 0.000229 1560.000000 -0.002069 0.002433 0.001592 -16724 1 0.000255 1560.000000 -0.002626 0.002135 0.003108 -16725 1 0.000242 1560.000000 -0.001249 -0.001177 0.006644 -16726 1 0.000274 1560.000000 -0.002862 0.002527 0.007795 -16727 1 0.000194 1560.000000 -0.000091 0.000874 0.004880 -16728 1 0.000207 1560.000000 0.000527 -0.003438 0.003558 -16729 1 0.000238 1560.000000 0.000247 -0.001677 0.005135 -16730 1 0.000281 1560.000000 0.002677 -0.002102 0.008484 -16731 1 0.000244 1560.000000 0.001355 0.002170 0.004991 -16732 1 0.000194 1560.000000 -0.001406 0.001080 0.005381 -16733 1 0.000258 1560.000000 -0.003083 0.000653 0.007778 -16734 1 0.000203 1560.000000 -0.001448 0.000920 0.004140 -16735 1 0.000228 1560.000000 -0.000426 0.001177 0.002635 -16736 1 0.000199 1560.000000 0.000059 -0.003167 0.007424 -16737 1 0.000194 1560.000000 0.001826 -0.002299 0.000127 -16738 1 0.000230 1560.000000 -0.000113 -0.001516 0.004074 -16739 1 0.000218 1560.000000 0.002928 -0.001637 0.003280 -16740 1 0.000256 1560.000000 0.001748 0.000238 0.006462 -16741 1 0.000251 1560.000000 0.000779 -0.002627 0.009836 -16742 1 0.000265 1560.000000 0.001062 -0.001128 0.004749 -16743 1 0.000200 1560.000000 0.000183 0.000922 0.005838 -16744 1 0.000224 1560.000000 -0.002768 -0.000326 0.007873 -16745 1 0.000200 1560.000000 -0.001075 0.002078 0.004873 -16746 1 0.000207 1560.000000 -0.003127 -0.002050 0.007728 -16747 1 0.000216 1560.000000 -0.002140 0.002635 0.005736 -16748 1 0.000223 1560.000000 -0.003506 -0.000731 0.001807 -16749 1 0.000205 1560.000000 -0.000365 0.003690 0.000435 -16750 1 0.000241 1560.000000 0.000417 -0.002282 0.009168 -16751 1 0.000251 1560.000000 -0.002829 -0.002352 0.008508 -16752 1 0.000224 1560.000000 -0.002356 -0.000971 0.009778 -16753 1 0.000232 1560.000000 -0.001035 0.002959 0.002052 -16754 1 0.000281 1560.000000 -0.001815 0.000119 0.009363 -16755 1 0.000204 1560.000000 -0.000601 0.002205 0.005128 -16756 1 0.000217 1560.000000 0.002090 -0.001728 0.000321 -16757 1 0.000193 1560.000000 -0.000567 0.001457 0.000330 -16758 1 0.000200 1560.000000 -0.003437 0.001734 0.008251 -16759 1 0.000272 1560.000000 0.002717 -0.000873 0.003357 -16760 1 0.000211 1560.000000 -0.002809 -0.000283 0.001991 -16761 1 0.000193 1560.000000 -0.002629 -0.000806 0.009571 -16762 1 0.000196 1560.000000 -0.001255 0.002564 0.005328 -16763 1 0.000261 1560.000000 -0.000249 -0.002010 0.007972 -16764 1 0.000222 1560.000000 0.003152 -0.001825 0.004445 -16765 1 0.000287 1560.000000 -0.003251 0.002055 0.007601 -16766 1 0.000221 1560.000000 -0.002758 -0.001364 0.000224 -16767 1 0.000215 1560.000000 -0.002357 -0.001688 0.008390 -16768 1 0.000200 1560.000000 -0.002020 -0.001035 0.006114 -16769 1 0.000198 1560.000000 -0.000839 0.001396 0.006896 -16770 1 0.000264 1560.000000 0.003234 0.000571 0.003938 -16771 1 0.000196 1560.000000 -0.003076 0.001351 0.001152 -16772 1 0.000272 1560.000000 -0.002885 -0.000486 0.007547 -16773 1 0.000284 1560.000000 0.002464 -0.001907 0.006894 -16774 1 0.000245 1560.000000 0.001593 0.003189 0.008558 -16775 1 0.000221 1560.000000 0.003678 -0.000974 0.001270 -16776 1 0.000230 1560.000000 -0.000729 0.002211 0.002947 -16777 1 0.000274 1560.000000 -0.001933 -0.003203 0.003577 -16778 1 0.000227 1560.000000 -0.001973 -0.001579 0.001231 -16779 1 0.000205 1560.000000 0.000270 -0.002428 0.006421 -16780 1 0.000196 1560.000000 -0.002005 0.002198 0.003816 -16781 1 0.000282 1560.000000 0.000284 0.003024 0.009573 -16782 1 0.000231 1560.000000 0.002079 -0.001970 0.000940 -16783 1 0.000211 1560.000000 -0.001074 -0.002240 0.005701 -16784 1 0.000237 1560.000000 0.001425 0.002199 0.003160 -16785 1 0.000196 1560.000000 -0.002017 0.002680 0.007546 -16786 1 0.000205 1560.000000 -0.002867 0.001352 0.000275 -16787 1 0.000235 1560.000000 0.001535 0.001703 0.009067 -16788 1 0.000235 1560.000000 -0.001207 0.003394 0.007836 -16789 1 0.000258 1560.000000 -0.003132 0.000411 0.005540 -16790 1 0.000269 1560.000000 -0.000671 0.002253 0.009307 -16791 1 0.000261 1560.000000 0.001854 0.000958 0.003114 -16792 1 0.000237 1560.000000 0.001910 -0.003325 0.003535 -16793 1 0.000240 1560.000000 0.002547 -0.000022 0.006772 -16794 1 0.000200 1560.000000 -0.001359 -0.002133 0.008599 -16795 1 0.000238 1560.000000 -0.000386 -0.002397 0.009825 -16796 1 0.000239 1560.000000 0.001933 -0.001274 0.000183 -16797 1 0.000247 1560.000000 0.001500 0.002252 0.002689 -16798 1 0.000203 1560.000000 0.001418 0.000223 0.001554 -16799 1 0.000199 1560.000000 0.001335 0.003197 0.005232 -16800 1 0.000243 1560.000000 -0.001974 0.000785 0.001738 -16801 1 0.000219 1560.000000 0.002274 -0.001537 0.001306 -16802 1 0.000284 1560.000000 -0.003000 0.002387 0.006622 -16803 1 0.000231 1560.000000 -0.001701 -0.000401 0.001480 -16804 1 0.000238 1560.000000 0.002391 0.001125 0.003295 -16805 1 0.000194 1560.000000 -0.001557 -0.002025 0.001599 -16806 1 0.000212 1560.000000 -0.000116 -0.000249 0.001780 -16807 1 0.000192 1560.000000 0.000886 0.000939 0.007828 -16808 1 0.000216 1560.000000 0.000131 -0.001662 0.009799 -16809 1 0.000281 1560.000000 0.000807 0.002297 0.001799 -16810 1 0.000252 1560.000000 -0.002232 0.001451 0.003368 -16811 1 0.000254 1560.000000 -0.000236 0.003427 0.003222 -16812 1 0.000206 1560.000000 0.000541 -0.003815 0.009567 -16813 1 0.000225 1560.000000 -0.001543 -0.002932 0.003609 -16814 1 0.000279 1560.000000 0.001955 0.000462 0.006334 -16815 1 0.000284 1560.000000 -0.003794 0.000509 0.003820 -16816 1 0.000201 1560.000000 -0.002841 -0.002511 0.001103 -16817 1 0.000197 1560.000000 0.001413 0.000836 0.008370 -16818 1 0.000235 1560.000000 0.001440 -0.002524 0.005403 -16819 1 0.000249 1560.000000 0.001836 -0.002390 0.005419 -16820 1 0.000249 1560.000000 -0.003288 -0.000875 0.006879 -16821 1 0.000212 1560.000000 -0.002423 -0.002572 0.007458 -16822 1 0.000217 1560.000000 0.001236 0.002314 0.002115 -16823 1 0.000211 1560.000000 0.002667 -0.002729 0.009172 -16824 1 0.000240 1560.000000 -0.003179 -0.001764 0.000721 -16825 1 0.000270 1560.000000 0.002138 0.002102 0.000146 -16826 1 0.000246 1560.000000 -0.001543 -0.000615 0.001001 -16827 1 0.000242 1560.000000 0.001122 0.001872 0.001397 -16828 1 0.000230 1560.000000 0.000614 -0.003074 0.000120 -16829 1 0.000284 1560.000000 0.001183 -0.003561 0.009852 -16830 1 0.000205 1560.000000 -0.002147 -0.002419 0.009296 -16831 1 0.000204 1560.000000 -0.001750 -0.002446 0.002495 -16832 1 0.000227 1560.000000 0.002194 -0.002649 0.008386 -16833 1 0.000268 1560.000000 -0.003670 -0.000351 0.003111 -16834 1 0.000257 1560.000000 0.002489 -0.000719 0.006155 -16835 1 0.000273 1560.000000 -0.002396 0.000992 0.003189 -16836 1 0.000259 1560.000000 -0.001035 0.000855 0.006593 -16837 1 0.000205 1560.000000 0.000454 0.001820 0.001391 -16838 1 0.000222 1560.000000 0.001752 -0.001399 0.008259 -16839 1 0.000198 1560.000000 0.002943 0.000660 0.002587 -16840 1 0.000271 1560.000000 0.000445 -0.001593 0.007274 -16841 1 0.000201 1560.000000 -0.002876 -0.001629 0.008850 -16842 1 0.000220 1560.000000 -0.002321 0.000664 0.008331 -16843 1 0.000195 1560.000000 -0.000141 -0.000865 0.000981 -16844 1 0.000250 1560.000000 0.001220 0.003649 0.005742 -16845 1 0.000262 1560.000000 -0.001017 -0.000498 0.007421 -16846 1 0.000216 1560.000000 0.001423 -0.002293 0.006535 -16847 1 0.000240 1560.000000 0.000318 -0.001499 0.008918 -16848 1 0.000208 1560.000000 0.003078 0.001143 0.001951 -16849 1 0.000229 1560.000000 -0.002081 0.001733 0.000138 -16850 1 0.000223 1560.000000 -0.003632 0.000106 0.003239 -16851 1 0.000224 1560.000000 -0.001395 -0.003194 0.001851 -16852 1 0.000249 1560.000000 0.000741 0.003748 0.008067 -16853 1 0.000215 1560.000000 0.000112 0.000252 0.001134 -16854 1 0.000228 1560.000000 0.002068 -0.001187 0.003509 -16855 1 0.000203 1560.000000 0.000115 -0.001730 0.008104 -16856 1 0.000232 1560.000000 -0.003071 0.001064 0.008395 -16857 1 0.000212 1560.000000 -0.000106 0.003240 0.002736 -16858 1 0.000198 1560.000000 -0.002562 -0.002796 0.002382 -16859 1 0.000228 1560.000000 -0.001398 -0.002285 0.006443 -16860 1 0.000212 1560.000000 -0.000313 -0.001793 0.001323 -16861 1 0.000226 1560.000000 0.002323 -0.001847 0.009211 -16862 1 0.000194 1560.000000 -0.001345 -0.003331 0.008813 -16863 1 0.000281 1560.000000 0.002554 0.002509 0.002166 -16864 1 0.000220 1560.000000 -0.003307 0.001384 0.009590 -16865 1 0.000211 1560.000000 -0.000446 -0.002594 0.000389 -16866 1 0.000255 1560.000000 -0.002821 -0.000987 0.008884 -16867 1 0.000248 1560.000000 0.003440 0.001153 0.008793 -16868 1 0.000213 1560.000000 -0.003244 -0.000068 0.000931 -16869 1 0.000279 1560.000000 -0.001185 -0.002532 0.001763 -16870 1 0.000208 1560.000000 -0.002538 -0.001422 0.004137 -16871 1 0.000242 1560.000000 0.001120 -0.003615 0.004499 -16872 1 0.000246 1560.000000 -0.001973 -0.001572 0.000157 -16873 1 0.000203 1560.000000 0.001833 -0.001792 0.001936 -16874 1 0.000255 1560.000000 0.000618 -0.000820 0.006387 -16875 1 0.000262 1560.000000 0.002006 -0.001046 0.006311 -16876 1 0.000193 1560.000000 0.001276 -0.001430 0.003509 -16877 1 0.000215 1560.000000 -0.003380 0.000306 0.008216 -16878 1 0.000205 1560.000000 0.003097 -0.001803 0.009033 -16879 1 0.000284 1560.000000 0.003557 0.001397 0.006712 -16880 1 0.000206 1560.000000 -0.000032 -0.000231 0.005416 -16881 1 0.000222 1560.000000 -0.003789 0.000509 0.006115 -16882 1 0.000230 1560.000000 -0.001210 -0.001597 0.003903 -16883 1 0.000205 1560.000000 -0.002734 -0.001995 0.003383 -16884 1 0.000216 1560.000000 -0.000192 -0.003815 0.006286 -16885 1 0.000199 1560.000000 -0.000112 -0.003467 0.006832 -16886 1 0.000199 1560.000000 0.000110 -0.002806 0.006785 -16887 1 0.000234 1560.000000 0.001208 0.001063 0.002425 -16888 1 0.000193 1560.000000 0.000359 0.003829 0.001876 -16889 1 0.000207 1560.000000 -0.001278 -0.002995 0.007727 -16890 1 0.000275 1560.000000 0.002443 0.002923 0.005067 -16891 1 0.000204 1560.000000 0.001018 -0.002508 0.008337 -16892 1 0.000199 1560.000000 0.000915 0.001585 0.006686 -16893 1 0.000216 1560.000000 -0.001145 0.003071 0.000340 -16894 1 0.000235 1560.000000 0.003496 -0.000475 0.001801 -16895 1 0.000270 1560.000000 -0.001053 -0.003680 0.003163 -16896 1 0.000280 1560.000000 0.002167 -0.003161 0.003903 -16897 1 0.000196 1560.000000 -0.003297 -0.001471 0.008316 -16898 1 0.000231 1560.000000 0.002185 0.002417 0.007860 -16899 1 0.000199 1560.000000 0.001339 0.001545 0.006140 -16900 1 0.000194 1560.000000 -0.001125 -0.000442 0.002803 -16901 1 0.000222 1560.000000 -0.000044 -0.002372 0.009267 -16902 1 0.000225 1560.000000 0.000464 0.000251 0.009303 -16903 1 0.000258 1560.000000 -0.001468 0.003298 0.004334 -16904 1 0.000219 1560.000000 -0.003155 -0.000443 0.006405 -16905 1 0.000198 1560.000000 -0.000089 0.002401 0.006615 -16906 1 0.000260 1560.000000 -0.002615 -0.001817 0.007178 -16907 1 0.000198 1560.000000 -0.003091 0.001570 0.000605 -16908 1 0.000200 1560.000000 0.002654 0.001450 0.000471 -16909 1 0.000238 1560.000000 -0.001792 -0.001296 0.001270 -16910 1 0.000226 1560.000000 0.001953 -0.000512 0.006701 -16911 1 0.000194 1560.000000 -0.000304 0.000953 0.004395 -16912 1 0.000229 1560.000000 -0.000096 0.002436 0.000140 -16913 1 0.000234 1560.000000 -0.001414 0.002039 0.007202 -16914 1 0.000218 1560.000000 0.003130 -0.000643 0.002798 -16915 1 0.000260 1560.000000 -0.002540 -0.000958 0.007150 -16916 1 0.000200 1560.000000 0.000510 -0.001960 0.003816 -16917 1 0.000247 1560.000000 -0.002716 0.002275 0.009824 -16918 1 0.000214 1560.000000 0.001536 -0.002600 0.000388 -16919 1 0.000199 1560.000000 -0.001689 -0.000295 0.005057 -16920 1 0.000237 1560.000000 0.002549 0.001697 0.009357 -16921 1 0.000224 1560.000000 0.002535 0.002234 0.003150 -16922 1 0.000256 1560.000000 -0.001566 -0.002977 0.009078 -16923 1 0.000287 1560.000000 0.000498 -0.003758 0.001656 -16924 1 0.000210 1560.000000 -0.000266 -0.003615 0.007896 -16925 1 0.000257 1560.000000 -0.003712 -0.000162 0.000291 -16926 1 0.000195 1560.000000 0.001125 0.003676 0.009285 -16927 1 0.000197 1560.000000 -0.000267 -0.003608 0.003393 -16928 1 0.000199 1560.000000 0.001420 0.001258 0.007173 -16929 1 0.000269 1560.000000 -0.002547 -0.001796 0.009752 -16930 1 0.000219 1560.000000 -0.000872 -0.001327 0.005018 -16931 1 0.000202 1560.000000 0.002029 0.002027 0.007578 -16932 1 0.000269 1560.000000 -0.000386 -0.001134 0.007708 -16933 1 0.000258 1560.000000 0.001751 0.001366 0.005960 -16934 1 0.000222 1560.000000 -0.002088 -0.003223 0.000250 -16935 1 0.000218 1560.000000 -0.001684 0.002385 0.000161 -16936 1 0.000196 1560.000000 -0.003247 0.000560 0.002664 -16937 1 0.000282 1560.000000 0.002105 -0.001809 0.009345 -16938 1 0.000226 1560.000000 -0.000293 -0.003670 0.008682 -16939 1 0.000283 1560.000000 -0.001513 -0.003339 0.002240 -16940 1 0.000247 1560.000000 0.000715 -0.002652 0.000197 -16941 1 0.000201 1560.000000 0.000273 -0.003361 0.009148 -16942 1 0.000221 1560.000000 0.002540 -0.001290 0.002143 -16943 1 0.000234 1560.000000 -0.003743 0.000367 0.002724 -16944 1 0.000259 1560.000000 0.001800 -0.003349 0.003118 -16945 1 0.000192 1560.000000 -0.001541 -0.000642 0.002621 -16946 1 0.000258 1560.000000 0.003702 0.000890 0.002863 -16947 1 0.000247 1560.000000 0.002944 0.001817 0.000826 -16948 1 0.000230 1560.000000 -0.000969 0.000349 0.008537 -16949 1 0.000216 1560.000000 0.000927 -0.000791 0.008219 -16950 1 0.000250 1560.000000 0.002197 0.000319 0.006959 -16951 1 0.000273 1560.000000 -0.002923 -0.000938 0.006986 -16952 1 0.000217 1560.000000 0.000290 0.003823 0.004819 -16953 1 0.000253 1560.000000 0.002917 -0.000405 0.007673 -16954 1 0.000204 1560.000000 0.002691 0.001485 0.006554 -16955 1 0.000251 1560.000000 0.002281 -0.002748 0.006034 -16956 1 0.000221 1560.000000 0.003165 0.002150 0.004916 -16957 1 0.000211 1560.000000 0.000874 -0.002257 0.002119 -16958 1 0.000225 1560.000000 0.001501 0.003340 0.006447 -16959 1 0.000192 1560.000000 0.000439 -0.003808 0.008962 -16960 1 0.000253 1560.000000 0.003332 -0.001430 0.002156 -16961 1 0.000240 1560.000000 -0.003498 -0.001489 0.001446 -16962 1 0.000224 1560.000000 -0.003346 0.000195 0.005518 -16963 1 0.000259 1560.000000 -0.000883 0.000187 0.009277 -16964 1 0.000277 1560.000000 -0.002870 -0.000528 0.009665 -16965 1 0.000199 1560.000000 -0.001386 0.003174 0.009018 -16966 1 0.000201 1560.000000 0.000694 -0.001952 0.006987 -16967 1 0.000259 1560.000000 -0.002128 0.003110 0.000530 -16968 1 0.000200 1560.000000 -0.000327 0.001353 0.007438 -16969 1 0.000204 1560.000000 0.001798 0.001813 0.008377 -16970 1 0.000221 1560.000000 -0.001031 0.001833 0.004045 -16971 1 0.000194 1560.000000 0.002184 0.001730 0.009761 -16972 1 0.000265 1560.000000 -0.003735 -0.000025 0.008038 -16973 1 0.000205 1560.000000 0.000190 0.001850 0.006949 -16974 1 0.000284 1560.000000 0.001419 0.001415 0.007828 -16975 1 0.000235 1560.000000 -0.002355 0.002126 0.001139 -16976 1 0.000263 1560.000000 0.002503 0.001776 0.004911 -16977 1 0.000244 1560.000000 -0.000024 0.003292 0.000649 -16978 1 0.000271 1560.000000 -0.002283 -0.000062 0.008547 -16979 1 0.000286 1560.000000 0.002240 0.001944 0.002332 -16980 1 0.000279 1560.000000 -0.000247 0.003832 0.008952 -16981 1 0.000287 1560.000000 0.002720 -0.002523 0.005060 -16982 1 0.000278 1560.000000 -0.003292 0.000410 0.007856 -16983 1 0.000274 1560.000000 -0.002401 0.001026 0.009494 -16984 1 0.000249 1560.000000 -0.002163 -0.000189 0.004098 -16985 1 0.000260 1560.000000 0.000400 0.002306 0.002302 -16986 1 0.000208 1560.000000 -0.000523 0.000134 0.001169 -16987 1 0.000212 1560.000000 0.003236 0.000662 0.009763 -16988 1 0.000194 1560.000000 0.001300 0.002296 0.005364 -16989 1 0.000253 1560.000000 -0.000233 -0.003275 0.008701 -16990 1 0.000287 1560.000000 0.001998 0.003214 0.005579 -16991 1 0.000205 1560.000000 -0.001705 0.001769 0.006433 -16992 1 0.000261 1560.000000 -0.000758 0.001346 0.003118 -16993 1 0.000284 1560.000000 -0.000864 -0.003226 0.002376 -16994 1 0.000193 1560.000000 0.000745 0.002145 0.000736 -16995 1 0.000268 1560.000000 0.000592 -0.001331 0.000279 -16996 1 0.000213 1560.000000 -0.002345 0.002143 0.003148 -16997 1 0.000222 1560.000000 0.002963 0.000874 0.003677 -16998 1 0.000216 1560.000000 -0.000819 -0.000109 0.009368 -16999 1 0.000206 1560.000000 0.001104 -0.000098 0.005836 -17000 1 0.000271 1560.000000 0.002677 -0.001311 0.001217 -17001 1 0.000205 1560.000000 -0.001124 0.003680 0.002160 -17002 1 0.000242 1560.000000 0.002618 0.001235 0.005807 -17003 1 0.000274 1560.000000 -0.000654 0.002874 0.004420 -17004 1 0.000250 1560.000000 0.000118 -0.003509 0.006775 -17005 1 0.000228 1560.000000 0.001068 -0.003192 0.006938 -17006 1 0.000253 1560.000000 0.000191 0.002537 0.008374 -17007 1 0.000264 1560.000000 -0.001398 -0.002118 0.008181 -17008 1 0.000231 1560.000000 0.001915 0.000960 0.007237 -17009 1 0.000243 1560.000000 0.002709 0.002217 0.002116 -17010 1 0.000204 1560.000000 -0.000296 0.001513 0.004332 -17011 1 0.000198 1560.000000 -0.000867 -0.002810 0.001281 -17012 1 0.000258 1560.000000 0.002157 0.001513 0.009462 -17013 1 0.000197 1560.000000 -0.001901 0.002061 0.007664 -17014 1 0.000276 1560.000000 0.002384 0.000321 0.008254 -17015 1 0.000210 1560.000000 0.000809 -0.002979 0.008503 -17016 1 0.000259 1560.000000 0.000046 0.000933 0.002259 -17017 1 0.000196 1560.000000 0.001535 0.001584 0.008154 -17018 1 0.000281 1560.000000 0.001929 -0.002396 0.005969 -17019 1 0.000221 1560.000000 0.003070 0.002135 0.006394 -17020 1 0.000194 1560.000000 -0.000835 0.002197 0.006693 -17021 1 0.000241 1560.000000 0.001639 -0.001171 0.009513 -17022 1 0.000249 1560.000000 0.000787 0.002937 0.004044 -17023 1 0.000268 1560.000000 -0.002116 -0.001656 0.005244 -17024 1 0.000243 1560.000000 0.002303 -0.002080 0.001375 -17025 1 0.000227 1560.000000 0.000272 -0.001734 0.005499 -17026 1 0.000241 1560.000000 -0.001755 -0.002825 0.007663 -17027 1 0.000197 1560.000000 -0.000995 0.001575 0.008673 -17028 1 0.000277 1560.000000 -0.000265 -0.002637 0.002897 -17029 1 0.000193 1560.000000 -0.001198 -0.002105 0.000729 -17030 1 0.000212 1560.000000 0.001200 -0.001416 0.001388 -17031 1 0.000192 1560.000000 -0.000976 -0.003148 0.006792 -17032 1 0.000261 1560.000000 -0.002233 0.002350 0.000358 -17033 1 0.000225 1560.000000 -0.001623 -0.001549 0.008455 -17034 1 0.000256 1560.000000 0.003325 -0.000061 0.002619 -17035 1 0.000212 1560.000000 -0.001753 0.001150 0.002290 -17036 1 0.000252 1560.000000 0.000060 0.000589 0.006715 -17037 1 0.000262 1560.000000 -0.001677 -0.001286 0.006966 -17038 1 0.000202 1560.000000 -0.002704 -0.002093 0.002777 -17039 1 0.000244 1560.000000 0.000234 0.002386 0.003926 -17040 1 0.000284 1560.000000 0.002719 0.001753 0.005671 -17041 1 0.000229 1560.000000 0.003657 -0.001175 0.003125 -17042 1 0.000214 1560.000000 0.002107 0.000630 0.003895 -17043 1 0.000235 1560.000000 -0.001021 -0.001770 0.007455 -17044 1 0.000209 1560.000000 -0.000647 -0.001349 0.003702 -17045 1 0.000206 1560.000000 -0.000856 -0.002794 0.007224 -17046 1 0.000213 1560.000000 -0.001108 0.001043 0.008532 -17047 1 0.000219 1560.000000 -0.002287 0.000746 0.004818 -17048 1 0.000225 1560.000000 0.001069 0.002850 0.007526 -17049 1 0.000207 1560.000000 0.001691 0.003439 0.001384 -17050 1 0.000274 1560.000000 -0.003126 0.000415 0.001566 -17051 1 0.000201 1560.000000 0.001913 -0.001614 0.002424 -17052 1 0.000198 1560.000000 0.001187 -0.000095 0.002645 -17053 1 0.000278 1560.000000 0.002996 -0.000875 0.004083 -17054 1 0.000234 1560.000000 0.001585 -0.002556 0.002297 -17055 1 0.000220 1560.000000 -0.002195 0.002098 0.000386 -17056 1 0.000221 1560.000000 0.001711 0.000881 0.006902 -17057 1 0.000239 1560.000000 0.003457 0.000792 0.002039 -17058 1 0.000202 1560.000000 -0.001320 -0.000340 0.005825 -17059 1 0.000249 1560.000000 -0.000840 -0.003296 0.006117 -17060 1 0.000250 1560.000000 -0.001081 0.003407 0.009792 -17061 1 0.000266 1560.000000 -0.000034 0.002458 0.003509 -17062 1 0.000257 1560.000000 -0.002424 -0.001925 0.004763 -17063 1 0.000284 1560.000000 0.003815 -0.000339 0.004172 -17064 1 0.000213 1560.000000 -0.001162 -0.000355 0.007737 -17065 1 0.000202 1560.000000 -0.001542 0.003185 0.009333 -17066 1 0.000269 1560.000000 -0.003419 -0.001491 0.004781 -17067 1 0.000258 1560.000000 0.003819 -0.000424 0.007456 -17068 1 0.000247 1560.000000 -0.000428 -0.002038 0.003850 -17069 1 0.000287 1560.000000 -0.000522 -0.003497 0.009794 -17070 1 0.000195 1560.000000 -0.002465 -0.001092 0.006245 -17071 1 0.000268 1560.000000 -0.000267 -0.003184 0.003347 -17072 1 0.000242 1560.000000 0.002910 -0.000150 0.003865 -17073 1 0.000215 1560.000000 0.002372 0.000704 0.001764 -17074 1 0.000225 1560.000000 0.000260 -0.000046 0.004304 -17075 1 0.000204 1560.000000 -0.002027 0.000935 0.004884 -17076 1 0.000230 1560.000000 -0.002570 0.001026 0.000498 -17077 1 0.000202 1560.000000 0.000528 0.001549 0.007545 -17078 1 0.000263 1560.000000 -0.002441 -0.002661 0.006638 -17079 1 0.000200 1560.000000 0.003754 0.000613 0.002863 -17080 1 0.000284 1560.000000 -0.001481 -0.001819 0.002667 -17081 1 0.000272 1560.000000 0.003675 0.001158 0.002320 -17082 1 0.000231 1560.000000 0.002198 -0.001557 0.005056 -17083 1 0.000236 1560.000000 0.003818 0.000261 0.002643 -17084 1 0.000275 1560.000000 0.001497 -0.003504 0.007767 -17085 1 0.000284 1560.000000 -0.001919 -0.000913 0.008926 -17086 1 0.000198 1560.000000 -0.000389 -0.000628 0.008203 -17087 1 0.000233 1560.000000 0.000081 0.001080 0.000153 -17088 1 0.000223 1560.000000 0.001279 -0.002619 0.007107 -17089 1 0.000196 1560.000000 0.001292 -0.000391 0.001660 -17090 1 0.000199 1560.000000 0.000117 -0.000959 0.003449 -17091 1 0.000203 1560.000000 0.000876 0.002425 0.006163 -17092 1 0.000227 1560.000000 -0.002371 -0.002503 0.000148 -17093 1 0.000263 1560.000000 0.000532 -0.002019 0.008420 -17094 1 0.000194 1560.000000 -0.002748 0.002154 0.006157 -17095 1 0.000240 1560.000000 -0.003124 0.000569 0.007389 -17096 1 0.000221 1560.000000 0.001554 0.002788 0.003676 -17097 1 0.000202 1560.000000 0.000079 -0.002760 0.004659 -17098 1 0.000227 1560.000000 0.000671 -0.000845 0.001188 -17099 1 0.000213 1560.000000 0.003488 0.000607 0.004788 -17100 1 0.000212 1560.000000 0.003201 -0.001218 0.000483 -17101 1 0.000282 1560.000000 0.003752 -0.000784 0.004588 -17102 1 0.000236 1560.000000 0.003620 0.001114 0.003744 -17103 1 0.000284 1560.000000 -0.001906 -0.003348 0.001948 -17104 1 0.000194 1560.000000 -0.001653 -0.001493 0.004556 -17105 1 0.000206 1560.000000 -0.002547 0.002112 0.003430 -17106 1 0.000226 1560.000000 0.002466 -0.002484 0.004938 -17107 1 0.000250 1560.000000 -0.001818 -0.002536 0.007875 -17108 1 0.000205 1560.000000 -0.001370 0.000369 0.006194 -17109 1 0.000197 1560.000000 -0.000274 0.000325 0.004040 -17110 1 0.000212 1560.000000 0.001805 0.001985 0.008930 -17111 1 0.000253 1560.000000 0.003658 -0.000859 0.007218 -17112 1 0.000226 1560.000000 0.001415 -0.001184 0.000759 -17113 1 0.000210 1560.000000 0.001834 0.000562 0.006806 -17114 1 0.000227 1560.000000 0.002886 -0.001727 0.001010 -17115 1 0.000266 1560.000000 0.001635 0.003381 0.005958 -17116 1 0.000224 1560.000000 0.003161 0.000952 0.003492 -17117 1 0.000274 1560.000000 -0.001592 0.000625 0.007018 -17118 1 0.000277 1560.000000 0.003304 -0.000050 0.000541 -17119 1 0.000204 1560.000000 0.001594 0.002223 0.002169 -17120 1 0.000218 1560.000000 -0.003007 -0.000715 0.008033 -17121 1 0.000286 1560.000000 -0.000840 -0.002757 0.008405 -17122 1 0.000221 1560.000000 0.000035 0.002237 0.004733 -17123 1 0.000277 1560.000000 -0.000743 0.002888 0.005070 -17124 1 0.000265 1560.000000 -0.001495 0.001250 0.006183 -17125 1 0.000243 1560.000000 0.001414 0.000773 0.007375 -17126 1 0.000252 1560.000000 -0.002498 -0.002386 0.001048 -17127 1 0.000256 1560.000000 -0.001046 -0.002635 0.001067 -17128 1 0.000204 1560.000000 -0.000488 0.000588 0.009095 -17129 1 0.000210 1560.000000 0.000732 0.000016 0.001685 -17130 1 0.000247 1560.000000 -0.000347 -0.003590 0.001687 -17131 1 0.000202 1560.000000 0.000519 0.000388 0.002671 -17132 1 0.000247 1560.000000 0.001617 0.002093 0.005260 -17133 1 0.000233 1560.000000 -0.000354 0.001703 0.008904 -17134 1 0.000227 1560.000000 0.001471 0.003029 0.003270 -17135 1 0.000260 1560.000000 -0.001221 -0.002937 0.007011 -17136 1 0.000270 1560.000000 0.001331 0.002814 0.001675 -17137 1 0.000242 1560.000000 0.000969 -0.003140 0.000375 -17138 1 0.000227 1560.000000 0.002511 0.001290 0.006061 -17139 1 0.000229 1560.000000 0.001711 -0.002655 0.006442 -17140 1 0.000254 1560.000000 0.003080 -0.001827 0.009471 -17141 1 0.000215 1560.000000 -0.002170 -0.001939 0.003504 -17142 1 0.000213 1560.000000 0.003060 0.000029 0.006298 -17143 1 0.000219 1560.000000 0.001405 -0.003283 0.003733 -17144 1 0.000227 1560.000000 0.003539 -0.001376 0.005048 -17145 1 0.000243 1560.000000 -0.001938 -0.003065 0.005996 -17146 1 0.000267 1560.000000 -0.001170 0.000368 0.008881 -17147 1 0.000239 1560.000000 0.000896 -0.003666 0.006547 -17148 1 0.000219 1560.000000 -0.001564 0.002780 0.000388 -17149 1 0.000198 1560.000000 -0.001976 -0.001455 0.003389 -17150 1 0.000288 1560.000000 0.000066 -0.003170 0.005379 -17151 1 0.000271 1560.000000 -0.001482 0.001440 0.001367 -17152 1 0.000253 1560.000000 0.002054 -0.000685 0.002816 -17153 1 0.000260 1560.000000 0.002317 -0.000595 0.000186 -17154 1 0.000227 1560.000000 0.000010 0.002865 0.009680 -17155 1 0.000260 1560.000000 0.000594 -0.000273 0.004255 -17156 1 0.000229 1560.000000 -0.001921 -0.000878 0.005860 -17157 1 0.000286 1560.000000 -0.001005 0.002767 0.004739 -17158 1 0.000264 1560.000000 -0.003767 0.000787 0.005348 -17159 1 0.000246 1560.000000 0.000966 0.003501 0.001686 -17160 1 0.000255 1560.000000 0.003377 -0.000496 0.006590 -17161 1 0.000213 1560.000000 -0.003397 -0.000442 0.003681 -17162 1 0.000251 1560.000000 -0.001966 -0.002806 0.003512 -17163 1 0.000206 1560.000000 0.000713 -0.001654 0.009135 -17164 1 0.000200 1560.000000 0.003307 -0.001332 0.004547 -17165 1 0.000209 1560.000000 -0.002459 -0.000665 0.000194 -17166 1 0.000232 1560.000000 -0.000079 -0.000662 0.007627 -17167 1 0.000209 1560.000000 -0.002572 0.002366 0.002734 -17168 1 0.000195 1560.000000 0.001542 -0.002919 0.009353 -17169 1 0.000204 1560.000000 0.002468 0.002893 0.003802 -17170 1 0.000242 1560.000000 -0.000033 -0.002233 0.005162 -17171 1 0.000241 1560.000000 0.001632 0.002491 0.006257 -17172 1 0.000246 1560.000000 0.000688 -0.002989 0.002965 -17173 1 0.000225 1560.000000 -0.003015 -0.000567 0.000446 -17174 1 0.000197 1560.000000 0.000398 -0.001214 0.003950 -17175 1 0.000225 1560.000000 0.000007 0.003497 0.008674 -17176 1 0.000266 1560.000000 0.000664 -0.000305 0.006695 -17177 1 0.000260 1560.000000 -0.000450 -0.002490 0.007599 -17178 1 0.000246 1560.000000 0.003309 -0.000737 0.008008 -17179 1 0.000222 1560.000000 -0.000235 0.001744 0.003167 -17180 1 0.000267 1560.000000 0.003716 -0.001003 0.008893 -17181 1 0.000204 1560.000000 -0.000113 -0.000313 0.000985 -17182 1 0.000240 1560.000000 0.000881 -0.001746 0.008143 -17183 1 0.000256 1560.000000 0.001457 0.003563 0.002845 -17184 1 0.000283 1560.000000 0.002729 0.001387 0.001361 -17185 1 0.000213 1560.000000 -0.001118 -0.001438 0.008217 -17186 1 0.000193 1560.000000 0.002329 -0.002819 0.007689 -17187 1 0.000246 1560.000000 -0.003433 0.001586 0.008001 -17188 1 0.000194 1560.000000 0.002881 0.001867 0.003599 -17189 1 0.000227 1560.000000 0.002133 -0.001514 0.000793 -17190 1 0.000264 1560.000000 0.003787 -0.000551 0.006374 -17191 1 0.000199 1560.000000 0.000748 -0.003432 0.002471 -17192 1 0.000281 1560.000000 -0.002140 -0.000054 0.007282 -17193 1 0.000201 1560.000000 -0.003107 -0.002223 0.005770 -17194 1 0.000232 1560.000000 -0.001787 -0.001416 0.007392 -17195 1 0.000205 1560.000000 0.000666 -0.000549 0.009794 -17196 1 0.000232 1560.000000 0.000027 -0.001215 0.000352 -17197 1 0.000223 1560.000000 0.002881 -0.001834 0.004637 -17198 1 0.000247 1560.000000 -0.000418 -0.003245 0.008311 -17199 1 0.000269 1560.000000 0.002398 -0.000929 0.001690 -17200 1 0.000231 1560.000000 0.003125 0.002245 0.005991 -17201 1 0.000211 1560.000000 -0.000127 0.001141 0.004992 -17202 1 0.000224 1560.000000 -0.000784 0.000944 0.008238 -17203 1 0.000217 1560.000000 -0.001837 0.002996 0.007250 -17204 1 0.000221 1560.000000 -0.000168 0.001799 0.001364 -17205 1 0.000197 1560.000000 -0.001183 0.000615 0.008989 -17206 1 0.000231 1560.000000 0.003140 0.001723 0.003043 -17207 1 0.000202 1560.000000 -0.000705 -0.000983 0.004589 -17208 1 0.000265 1560.000000 0.000313 -0.003256 0.002804 -17209 1 0.000213 1560.000000 -0.002097 -0.001132 0.007638 -17210 1 0.000213 1560.000000 -0.000691 -0.000277 0.000640 -17211 1 0.000239 1560.000000 0.002107 0.003054 0.003433 -17212 1 0.000232 1560.000000 -0.001392 0.002576 0.000479 -17213 1 0.000234 1560.000000 0.003517 -0.000230 0.000161 -17214 1 0.000264 1560.000000 0.002868 -0.002414 0.000261 -17215 1 0.000247 1560.000000 -0.003763 0.000826 0.002611 -17216 1 0.000193 1560.000000 0.002624 0.001633 0.000169 -17217 1 0.000261 1560.000000 -0.001355 0.003486 0.005567 -17218 1 0.000225 1560.000000 0.002271 0.001502 0.006837 -17219 1 0.000228 1560.000000 -0.002698 -0.002299 0.006610 -17220 1 0.000260 1560.000000 0.000635 -0.002004 0.003270 -17221 1 0.000203 1560.000000 -0.001202 0.000349 0.006664 -17222 1 0.000226 1560.000000 0.003372 0.000243 0.006485 -17223 1 0.000223 1560.000000 -0.000726 0.003651 0.000172 -17224 1 0.000199 1560.000000 0.000140 0.003476 0.006191 -17225 1 0.000247 1560.000000 0.002823 0.000495 0.004093 -17226 1 0.000232 1560.000000 0.001024 0.000991 0.006813 -17227 1 0.000193 1560.000000 0.001429 0.003409 0.000463 -17228 1 0.000243 1560.000000 -0.000202 0.001994 0.003640 -17229 1 0.000274 1560.000000 -0.000383 -0.003664 0.000151 -17230 1 0.000233 1560.000000 -0.003027 0.001919 0.006714 -17231 1 0.000205 1560.000000 -0.000509 -0.002869 0.007655 -17232 1 0.000213 1560.000000 0.000238 0.003307 0.000331 -17233 1 0.000237 1560.000000 -0.001967 0.003046 0.008541 -17234 1 0.000275 1560.000000 -0.003711 0.000837 0.001614 -17235 1 0.000222 1560.000000 0.000035 -0.002828 0.001785 -17236 1 0.000208 1560.000000 -0.001930 -0.002726 0.005471 -17237 1 0.000205 1560.000000 0.002831 0.002014 0.000201 -17238 1 0.000218 1560.000000 -0.000895 -0.000400 0.008620 -17239 1 0.000209 1560.000000 -0.000458 -0.003802 0.009423 -17240 1 0.000249 1560.000000 0.001210 -0.001045 0.007164 -17241 1 0.000270 1560.000000 0.003650 0.000984 0.007391 -17242 1 0.000215 1560.000000 -0.003246 -0.001917 0.005500 -17243 1 0.000238 1560.000000 -0.000709 0.002473 0.000833 -17244 1 0.000216 1560.000000 0.002938 0.000833 0.007416 -17245 1 0.000204 1560.000000 0.000999 -0.003074 0.005792 -17246 1 0.000285 1560.000000 -0.002989 -0.001243 0.003472 -17247 1 0.000251 1560.000000 -0.002082 -0.002871 0.002912 -17248 1 0.000195 1560.000000 -0.002046 0.000926 0.002274 -17249 1 0.000250 1560.000000 -0.002960 0.000196 0.004709 -17250 1 0.000215 1560.000000 -0.001055 0.002909 0.005561 -17251 1 0.000281 1560.000000 -0.002403 0.001327 0.003871 -17252 1 0.000210 1560.000000 0.002430 0.002508 0.005755 -17253 1 0.000219 1560.000000 0.003150 -0.000520 0.009626 -17254 1 0.000257 1560.000000 -0.003272 -0.001079 0.007510 -17255 1 0.000230 1560.000000 0.000333 0.000185 0.004356 -17256 1 0.000196 1560.000000 0.000775 0.003208 0.006760 -17257 1 0.000207 1560.000000 0.002683 0.002366 0.005909 -17258 1 0.000202 1560.000000 0.001452 -0.001896 0.005073 -17259 1 0.000210 1560.000000 -0.001565 -0.001641 0.006121 -17260 1 0.000268 1560.000000 0.003781 0.000139 0.000699 -17261 1 0.000206 1560.000000 -0.000796 0.000582 0.007243 -17262 1 0.000255 1560.000000 -0.000658 -0.001163 0.005949 -17263 1 0.000280 1560.000000 -0.002928 0.001168 0.008759 -17264 1 0.000222 1560.000000 -0.002339 -0.002664 0.000586 -17265 1 0.000230 1560.000000 0.000232 0.003281 0.002419 -17266 1 0.000272 1560.000000 -0.001667 0.000741 0.002008 -17267 1 0.000248 1560.000000 -0.001362 -0.002094 0.004793 -17268 1 0.000192 1560.000000 -0.000168 -0.003474 0.007035 -17269 1 0.000219 1560.000000 -0.000546 0.001263 0.000839 -17270 1 0.000281 1560.000000 0.001184 -0.003663 0.003377 -17271 1 0.000272 1560.000000 0.003205 -0.002084 0.003814 -17272 1 0.000195 1560.000000 0.000062 0.003039 0.003456 -17273 1 0.000268 1560.000000 0.000098 0.001167 0.001084 -17274 1 0.000199 1560.000000 0.002470 0.002818 0.002324 -17275 1 0.000207 1560.000000 0.001781 0.000805 0.003566 -17276 1 0.000203 1560.000000 0.000848 0.001232 0.000988 -17277 1 0.000221 1560.000000 0.003177 -0.001896 0.006893 -17278 1 0.000208 1560.000000 -0.001189 -0.001454 0.001919 -17279 1 0.000237 1560.000000 -0.000165 -0.002431 0.003806 -17280 1 0.000197 1560.000000 0.003218 -0.000845 0.008445 -17281 1 0.000201 1560.000000 -0.002503 0.002436 0.008240 -17282 1 0.000258 1560.000000 0.000659 -0.003789 0.004622 -17283 1 0.000232 1560.000000 -0.001387 0.002672 0.008753 -17284 1 0.000242 1560.000000 0.000603 -0.001260 0.000702 -17285 1 0.000208 1560.000000 -0.000079 0.000403 0.006979 -17286 1 0.000272 1560.000000 0.000194 -0.002703 0.002733 -17287 1 0.000209 1560.000000 -0.001230 -0.003614 0.001973 -17288 1 0.000262 1560.000000 0.001355 -0.001553 0.006049 -17289 1 0.000232 1560.000000 0.002627 -0.002290 0.001033 -17290 1 0.000284 1560.000000 -0.001016 -0.003692 0.006081 -17291 1 0.000231 1560.000000 0.002286 -0.002556 0.007937 -17292 1 0.000262 1560.000000 -0.003376 -0.000024 0.003147 -17293 1 0.000214 1560.000000 -0.002156 0.003168 0.002744 -17294 1 0.000222 1560.000000 0.001090 -0.000815 0.009021 -17295 1 0.000226 1560.000000 0.001947 -0.003007 0.006003 -17296 1 0.000219 1560.000000 0.003448 0.001284 0.007350 -17297 1 0.000197 1560.000000 0.002550 0.002833 0.004149 -17298 1 0.000228 1560.000000 0.003222 -0.001003 0.006273 -17299 1 0.000223 1560.000000 -0.001493 -0.000439 0.004404 -17300 1 0.000198 1560.000000 -0.000338 -0.001999 0.005626 -17301 1 0.000222 1560.000000 0.002994 -0.000700 0.001153 -17302 1 0.000249 1560.000000 -0.002612 0.001577 0.007294 -17303 1 0.000216 1560.000000 -0.000736 0.001814 0.001859 -17304 1 0.000222 1560.000000 0.000346 0.003118 0.003090 -17305 1 0.000228 1560.000000 0.001221 0.002558 0.002556 -17306 1 0.000219 1560.000000 0.002985 -0.000966 0.005742 -17307 1 0.000206 1560.000000 0.001011 -0.001816 0.004494 -17308 1 0.000228 1560.000000 0.001263 -0.002853 0.009195 -17309 1 0.000238 1560.000000 0.001063 0.000974 0.002221 -17310 1 0.000285 1560.000000 0.001005 -0.003027 0.005053 -17311 1 0.000221 1560.000000 -0.001826 0.001838 0.004460 -17312 1 0.000211 1560.000000 -0.000699 0.002236 0.002656 -17313 1 0.000240 1560.000000 -0.003361 -0.001476 0.000846 -17314 1 0.000246 1560.000000 -0.000123 -0.000851 0.005965 -17315 1 0.000285 1560.000000 0.002521 0.000612 0.002682 -17316 1 0.000201 1560.000000 0.001101 0.003086 0.005999 -17317 1 0.000195 1560.000000 0.001248 0.002694 0.007446 -17318 1 0.000222 1560.000000 0.001392 -0.000878 0.007420 -17319 1 0.000225 1560.000000 -0.003001 0.000026 0.000925 -17320 1 0.000272 1560.000000 0.002885 0.002390 0.007117 -17321 1 0.000202 1560.000000 -0.000901 0.003210 0.008053 -17322 1 0.000192 1560.000000 0.001809 0.001590 0.005857 -17323 1 0.000200 1560.000000 -0.001982 0.000094 0.004026 -17324 1 0.000205 1560.000000 0.001483 -0.002125 0.008941 -17325 1 0.000207 1560.000000 -0.000672 -0.001690 0.006223 -17326 1 0.000261 1560.000000 0.002386 -0.000892 0.008450 -17327 1 0.000230 1560.000000 -0.002082 0.002138 0.003344 -17328 1 0.000227 1560.000000 0.000903 -0.000940 0.003921 -17329 1 0.000224 1560.000000 -0.002868 -0.002460 0.009525 -17330 1 0.000210 1560.000000 -0.001700 0.001321 0.002594 -17331 1 0.000270 1560.000000 0.002588 0.000765 0.007543 -17332 1 0.000204 1560.000000 0.000043 -0.002098 0.008383 -17333 1 0.000227 1560.000000 0.000183 -0.000403 0.004066 -17334 1 0.000197 1560.000000 -0.001627 -0.000784 0.000195 -17335 1 0.000226 1560.000000 0.003806 0.000137 0.001965 -17336 1 0.000193 1560.000000 -0.003165 0.001425 0.003716 -17337 1 0.000225 1560.000000 0.000041 -0.001110 0.007668 -17338 1 0.000211 1560.000000 0.001496 -0.002617 0.008710 -17339 1 0.000225 1560.000000 0.003205 -0.000137 0.006320 -17340 1 0.000278 1560.000000 -0.001779 -0.002961 0.003934 -17341 1 0.000196 1560.000000 0.001753 0.001231 0.001294 -17342 1 0.000203 1560.000000 -0.001739 0.001022 0.005623 -17343 1 0.000253 1560.000000 -0.002276 -0.002252 0.004226 -17344 1 0.000230 1560.000000 -0.001492 -0.000258 0.005685 -17345 1 0.000244 1560.000000 0.003472 0.000416 0.000477 -17346 1 0.000219 1560.000000 0.001972 0.002926 0.003079 -17347 1 0.000208 1560.000000 0.000148 0.002105 0.009311 -17348 1 0.000225 1560.000000 0.002888 0.000617 0.005240 -17349 1 0.000246 1560.000000 0.003344 -0.000437 0.004169 -17350 1 0.000240 1560.000000 -0.000152 -0.000231 0.008454 -17351 1 0.000209 1560.000000 -0.000164 0.003138 0.005020 -17352 1 0.000279 1560.000000 -0.003550 -0.001479 0.007109 -17353 1 0.000206 1560.000000 0.001879 0.000241 0.002968 -17354 1 0.000239 1560.000000 -0.002499 0.001731 0.006561 -17355 1 0.000194 1560.000000 -0.001883 0.001663 0.001966 -17356 1 0.000206 1560.000000 -0.001444 0.000341 0.004112 -17357 1 0.000206 1560.000000 -0.000438 -0.002226 0.003328 -17358 1 0.000195 1560.000000 0.003677 0.000496 0.009695 -17359 1 0.000200 1560.000000 -0.000615 0.003122 0.008247 -17360 1 0.000234 1560.000000 0.003069 -0.002284 0.001779 -17361 1 0.000198 1560.000000 0.001380 0.002181 0.001340 -17362 1 0.000203 1560.000000 -0.003204 0.001779 0.004703 -17363 1 0.000261 1560.000000 -0.002312 -0.001717 0.003609 -17364 1 0.000214 1560.000000 -0.002693 0.000360 0.002305 -17365 1 0.000219 1560.000000 -0.000456 0.002798 0.001919 -17366 1 0.000193 1560.000000 -0.001281 -0.001430 0.005281 -17367 1 0.000228 1560.000000 -0.000720 -0.003715 0.004801 -17368 1 0.000221 1560.000000 -0.000028 -0.002911 0.001389 -17369 1 0.000268 1560.000000 -0.000336 0.003592 0.005784 -17370 1 0.000253 1560.000000 0.000827 -0.002013 0.005686 -17371 1 0.000222 1560.000000 0.001106 0.002501 0.001578 -17372 1 0.000279 1560.000000 -0.000153 0.002312 0.009819 -17373 1 0.000211 1560.000000 0.001668 0.000955 0.002146 -17374 1 0.000204 1560.000000 -0.001452 0.002351 0.000544 -17375 1 0.000194 1560.000000 0.002202 -0.000197 0.007243 -17376 1 0.000209 1560.000000 -0.003041 -0.002329 0.006291 -17377 1 0.000245 1560.000000 -0.001189 0.000835 0.004077 -17378 1 0.000260 1560.000000 0.001592 0.000644 0.001984 -17379 1 0.000213 1560.000000 -0.000939 0.002540 0.001762 -17380 1 0.000226 1560.000000 -0.002682 -0.001057 0.004623 -17381 1 0.000208 1560.000000 -0.000374 0.003609 0.003938 -17382 1 0.000197 1560.000000 -0.001686 -0.001455 0.005689 -17383 1 0.000261 1560.000000 -0.002076 0.001732 0.007372 -17384 1 0.000276 1560.000000 -0.003499 0.001482 0.000864 -17385 1 0.000201 1560.000000 0.002985 -0.001316 0.006009 -17386 1 0.000261 1560.000000 -0.003235 0.000072 0.006314 -17387 1 0.000232 1560.000000 0.002044 0.001284 0.004249 -17388 1 0.000205 1560.000000 -0.000323 0.003391 0.009632 -17389 1 0.000200 1560.000000 -0.001994 0.002042 0.002319 -17390 1 0.000243 1560.000000 0.002978 -0.001034 0.003817 -17391 1 0.000212 1560.000000 -0.000934 -0.001138 0.007036 -17392 1 0.000257 1560.000000 0.000447 0.003354 0.001037 -17393 1 0.000207 1560.000000 -0.002422 -0.000423 0.001260 -17394 1 0.000204 1560.000000 0.002857 -0.001247 0.001502 -17395 1 0.000216 1560.000000 -0.000202 0.000179 0.007604 -17396 1 0.000266 1560.000000 -0.003796 0.000636 0.001829 -17397 1 0.000199 1560.000000 0.000569 0.002701 0.008359 -17398 1 0.000216 1560.000000 0.002907 0.000715 0.006039 -17399 1 0.000265 1560.000000 0.001900 -0.003169 0.002436 -17400 1 0.000281 1560.000000 0.000203 0.002843 0.007386 -17401 1 0.000222 1560.000000 -0.003281 -0.000792 0.008830 -17402 1 0.000236 1560.000000 0.000560 0.001203 0.001094 -17403 1 0.000261 1560.000000 0.003385 0.000862 0.006766 -17404 1 0.000204 1560.000000 0.001439 0.002223 0.008170 -17405 1 0.000227 1560.000000 -0.001441 -0.003328 0.009457 -17406 1 0.000258 1560.000000 -0.002981 0.001474 0.003156 -17407 1 0.000288 1560.000000 -0.002379 -0.002774 0.000292 -17408 1 0.000241 1560.000000 0.002916 0.000083 0.000126 -17409 1 0.000242 1560.000000 0.000588 0.001543 0.003905 -17410 1 0.000195 1560.000000 -0.001315 -0.002883 0.000553 -17411 1 0.000230 1560.000000 -0.001781 -0.002758 0.008736 -17412 1 0.000226 1560.000000 -0.002747 0.000904 0.006557 -17413 1 0.000229 1560.000000 0.000034 -0.002096 0.002799 -17414 1 0.000194 1560.000000 0.001450 -0.000226 0.009052 -17415 1 0.000216 1560.000000 0.000925 -0.001110 0.009417 -17416 1 0.000194 1560.000000 0.000554 0.002308 0.002948 -17417 1 0.000200 1560.000000 0.003290 -0.001367 0.002468 -17418 1 0.000234 1560.000000 -0.002410 -0.001162 0.008841 -17419 1 0.000236 1560.000000 0.001992 0.000472 0.007520 -17420 1 0.000286 1560.000000 0.002179 -0.002800 0.007502 -17421 1 0.000215 1560.000000 -0.000096 0.002929 0.000986 -17422 1 0.000278 1560.000000 0.000122 0.003052 0.004712 -17423 1 0.000219 1560.000000 0.000195 0.003581 0.004476 -17424 1 0.000242 1560.000000 0.001971 -0.001191 0.002191 -17425 1 0.000216 1560.000000 -0.000644 0.000805 0.001141 -17426 1 0.000253 1560.000000 -0.002419 -0.001417 0.001213 -17427 1 0.000268 1560.000000 -0.001071 0.001200 0.009654 -17428 1 0.000252 1560.000000 0.002265 0.002087 0.003732 -17429 1 0.000259 1560.000000 -0.001043 0.002785 0.002359 -17430 1 0.000204 1560.000000 -0.000236 -0.002592 0.006415 -17431 1 0.000260 1560.000000 0.001729 -0.002073 0.006367 -17432 1 0.000205 1560.000000 0.002809 0.000455 0.001002 -17433 1 0.000196 1560.000000 -0.000025 0.000162 0.004961 -17434 1 0.000288 1560.000000 -0.002544 0.002897 0.002181 -17435 1 0.000234 1560.000000 -0.001007 -0.002979 0.004162 -17436 1 0.000221 1560.000000 0.000018 -0.002568 0.006090 -17437 1 0.000288 1560.000000 -0.001646 0.002391 0.007095 -17438 1 0.000229 1560.000000 0.001487 0.003478 0.000942 -17439 1 0.000207 1560.000000 0.002455 -0.001719 0.003670 -17440 1 0.000201 1560.000000 -0.003450 0.000830 0.008934 -17441 1 0.000229 1560.000000 -0.001388 0.001514 0.008817 -17442 1 0.000206 1560.000000 0.002690 -0.001334 0.004005 -17443 1 0.000241 1560.000000 0.001855 0.002173 0.009650 -17444 1 0.000283 1560.000000 0.002051 -0.003199 0.004562 -17445 1 0.000208 1560.000000 0.002728 0.000594 0.005601 -17446 1 0.000227 1560.000000 -0.000298 0.000302 0.001227 -17447 1 0.000212 1560.000000 -0.000657 -0.000653 0.007608 -17448 1 0.000261 1560.000000 -0.001049 -0.003487 0.007776 -17449 1 0.000207 1560.000000 -0.002097 0.002865 0.009128 -17450 1 0.000196 1560.000000 -0.001561 -0.003488 0.008795 -17451 1 0.000201 1560.000000 -0.000100 0.000348 0.008730 -17452 1 0.000235 1560.000000 0.003153 0.000826 0.006058 -17453 1 0.000232 1560.000000 -0.000818 -0.000854 0.000314 -17454 1 0.000283 1560.000000 0.003325 0.000356 0.009089 -17455 1 0.000203 1560.000000 -0.001704 0.002474 0.009139 -17456 1 0.000276 1560.000000 0.000500 0.000816 0.006781 -17457 1 0.000229 1560.000000 -0.000613 -0.003164 0.000928 -17458 1 0.000200 1560.000000 0.001705 -0.000110 0.001602 -17459 1 0.000257 1560.000000 -0.002068 -0.000662 0.001744 -17460 1 0.000274 1560.000000 -0.001422 0.000263 0.009558 -17461 1 0.000283 1560.000000 -0.002155 -0.003086 0.008782 -17462 1 0.000227 1560.000000 0.001818 0.002718 0.005988 -17463 1 0.000223 1560.000000 -0.002855 -0.002194 0.006330 -17464 1 0.000222 1560.000000 0.001816 -0.000292 0.006778 -17465 1 0.000247 1560.000000 0.001361 -0.000667 0.004966 -17466 1 0.000234 1560.000000 0.001075 -0.002100 0.004605 -17467 1 0.000219 1560.000000 0.002177 0.000907 0.009525 -17468 1 0.000265 1560.000000 0.000167 0.001868 0.002642 -17469 1 0.000196 1560.000000 0.001849 0.002968 0.001268 -17470 1 0.000202 1560.000000 0.000846 -0.002774 0.005845 -17471 1 0.000282 1560.000000 -0.001751 0.002619 0.009839 -17472 1 0.000231 1560.000000 -0.002180 -0.002287 0.002668 -17473 1 0.000217 1560.000000 0.003206 -0.001615 0.002056 -17474 1 0.000262 1560.000000 -0.000283 -0.001749 0.009397 -17475 1 0.000284 1560.000000 -0.001013 0.003257 0.004431 -17476 1 0.000233 1560.000000 -0.000686 -0.002515 0.007237 -17477 1 0.000282 1560.000000 -0.001224 0.003656 0.006481 -17478 1 0.000281 1560.000000 0.002532 -0.000810 0.007816 -17479 1 0.000275 1560.000000 -0.002802 0.002589 0.007472 -17480 1 0.000227 1560.000000 0.001053 -0.000052 0.001188 -17481 1 0.000212 1560.000000 0.000418 -0.001114 0.003366 -17482 1 0.000217 1560.000000 -0.001683 0.002805 0.007600 -17483 1 0.000212 1560.000000 -0.002184 -0.001557 0.003761 -17484 1 0.000210 1560.000000 0.001918 0.000425 0.001891 -17485 1 0.000205 1560.000000 0.001001 -0.002205 0.006698 -17486 1 0.000221 1560.000000 0.003129 -0.000193 0.008639 -17487 1 0.000285 1560.000000 -0.001708 0.002204 0.003910 -17488 1 0.000203 1560.000000 0.002983 -0.000394 0.002925 -17489 1 0.000283 1560.000000 -0.002388 -0.001019 0.007909 -17490 1 0.000213 1560.000000 0.000806 0.001503 0.008812 -17491 1 0.000242 1560.000000 0.003501 0.001385 0.009804 -17492 1 0.000250 1560.000000 0.000095 -0.001657 0.000910 -17493 1 0.000245 1560.000000 -0.000865 0.000668 0.007465 -17494 1 0.000211 1560.000000 -0.001667 0.000160 0.005635 -17495 1 0.000242 1560.000000 0.001784 0.002416 0.002255 -17496 1 0.000206 1560.000000 0.002604 0.000161 0.000152 -17497 1 0.000193 1560.000000 0.000786 0.001441 0.004684 -17498 1 0.000229 1560.000000 -0.003237 -0.000358 0.009129 -17499 1 0.000276 1560.000000 0.001956 0.003243 0.002063 -17500 1 0.000199 1560.000000 0.001224 -0.003369 0.007317 -17501 1 0.000277 1560.000000 -0.003567 -0.000264 0.005997 -17502 1 0.000196 1560.000000 0.000993 0.002193 0.002630 -17503 1 0.000278 1560.000000 -0.002955 -0.001133 0.005823 -17504 1 0.000216 1560.000000 0.002577 0.002866 0.008700 -17505 1 0.000244 1560.000000 -0.000129 0.003146 0.007230 -17506 1 0.000200 1560.000000 -0.000320 -0.000199 0.001844 -17507 1 0.000205 1560.000000 -0.000284 -0.002088 0.008356 -17508 1 0.000214 1560.000000 -0.000625 0.003627 0.008842 -17509 1 0.000270 1560.000000 -0.001889 0.002068 0.003487 -17510 1 0.000212 1560.000000 0.000792 0.000962 0.002857 -17511 1 0.000285 1560.000000 0.000128 -0.003294 0.002378 -17512 1 0.000213 1560.000000 -0.003371 0.001856 0.001177 -17513 1 0.000269 1560.000000 -0.002267 0.002065 0.008534 -17514 1 0.000206 1560.000000 -0.001425 0.002742 0.002161 -17515 1 0.000268 1560.000000 -0.001982 -0.003254 0.001700 -17516 1 0.000214 1560.000000 0.000565 0.003161 0.003879 -17517 1 0.000204 1560.000000 0.000423 -0.002137 0.001399 -17518 1 0.000222 1560.000000 0.001826 0.000180 0.006934 -17519 1 0.000211 1560.000000 0.001364 0.002854 0.005585 -17520 1 0.000212 1560.000000 -0.001043 -0.000604 0.003230 -17521 1 0.000195 1560.000000 0.000558 0.001256 0.007851 -17522 1 0.000204 1560.000000 0.000903 0.003055 0.001723 -17523 1 0.000237 1560.000000 0.001357 0.000174 0.004970 -17524 1 0.000203 1560.000000 -0.002254 -0.002148 0.002514 -17525 1 0.000194 1560.000000 0.000229 0.000506 0.002578 -17526 1 0.000223 1560.000000 -0.000625 0.003802 0.007560 -17527 1 0.000254 1560.000000 0.002755 -0.000806 0.006613 -17528 1 0.000279 1560.000000 -0.000829 0.001684 0.001403 -17529 1 0.000251 1560.000000 0.003750 -0.000019 0.009184 -17530 1 0.000219 1560.000000 -0.000776 0.003103 0.006396 -17531 1 0.000203 1560.000000 -0.002752 -0.001698 0.001029 -17532 1 0.000201 1560.000000 -0.003344 -0.000905 0.007687 -17533 1 0.000271 1560.000000 0.001196 0.003001 0.008507 -17534 1 0.000276 1560.000000 -0.001409 -0.000840 0.002628 -17535 1 0.000203 1560.000000 0.000917 -0.000323 0.002898 -17536 1 0.000232 1560.000000 0.001978 -0.001848 0.007087 -17537 1 0.000281 1560.000000 -0.003847 0.000217 0.002222 -17538 1 0.000247 1560.000000 -0.000248 0.001183 0.007144 -17539 1 0.000249 1560.000000 -0.000801 -0.002118 0.009508 -17540 1 0.000268 1560.000000 -0.002526 -0.001832 0.000996 -17541 1 0.000261 1560.000000 0.001936 -0.000214 0.001031 -17542 1 0.000218 1560.000000 0.000898 0.003487 0.003087 -17543 1 0.000225 1560.000000 0.001647 -0.002923 0.003819 -17544 1 0.000241 1560.000000 -0.002831 0.000065 0.003690 -17545 1 0.000202 1560.000000 -0.000570 -0.000097 0.005002 -17546 1 0.000272 1560.000000 0.003850 0.000110 0.006735 -17547 1 0.000205 1560.000000 -0.002990 -0.000066 0.002806 -17548 1 0.000238 1560.000000 -0.000311 0.003128 0.001840 -17549 1 0.000253 1560.000000 -0.000995 0.002134 0.009399 -17550 1 0.000208 1560.000000 -0.000272 -0.002426 0.006974 -17551 1 0.000247 1560.000000 -0.001086 -0.003690 0.003479 -17552 1 0.000204 1560.000000 0.002802 0.000450 0.001623 -17553 1 0.000217 1560.000000 -0.000646 -0.000325 0.001081 -17554 1 0.000256 1560.000000 -0.003032 -0.001702 0.002986 -17555 1 0.000285 1560.000000 0.003628 0.001228 0.005042 -17556 1 0.000238 1560.000000 0.000310 0.003158 0.003343 -17557 1 0.000254 1560.000000 -0.000029 -0.002114 0.002328 -17558 1 0.000212 1560.000000 0.001646 -0.001224 0.001282 -17559 1 0.000240 1560.000000 -0.002886 0.000197 0.005249 -17560 1 0.000287 1560.000000 -0.001565 -0.000721 0.009821 -17561 1 0.000192 1560.000000 -0.001438 -0.001943 0.001134 -17562 1 0.000272 1560.000000 -0.001274 -0.003238 0.002629 -17563 1 0.000288 1560.000000 0.002240 0.002796 0.002542 -17564 1 0.000218 1560.000000 0.002034 0.000589 0.008850 -17565 1 0.000241 1560.000000 0.001495 -0.002545 0.009000 -17566 1 0.000206 1560.000000 0.000167 0.002646 0.005042 -17567 1 0.000205 1560.000000 0.000116 0.003324 0.009227 -17568 1 0.000210 1560.000000 0.002328 -0.000812 0.001245 -17569 1 0.000197 1560.000000 0.001369 -0.002858 0.002724 -17570 1 0.000214 1560.000000 0.001772 -0.000423 0.003213 -17571 1 0.000280 1560.000000 0.002953 0.001856 0.004174 -17572 1 0.000193 1560.000000 -0.002748 0.000297 0.004759 -17573 1 0.000237 1560.000000 -0.003386 -0.001759 0.002748 -17574 1 0.000204 1560.000000 0.000014 -0.002878 0.001045 -17575 1 0.000198 1560.000000 0.000022 -0.002845 0.007023 -17576 1 0.000194 1560.000000 -0.002098 -0.000880 0.004872 -17577 1 0.000227 1560.000000 0.000085 -0.002898 0.007811 -17578 1 0.000278 1560.000000 -0.001672 0.000770 0.009308 -17579 1 0.000250 1560.000000 0.000978 -0.003534 0.006913 -17580 1 0.000229 1560.000000 0.001805 0.001391 0.004257 -17581 1 0.000213 1560.000000 -0.003047 0.002339 0.000527 -17582 1 0.000221 1560.000000 0.002990 -0.001537 0.001816 -17583 1 0.000196 1560.000000 -0.001238 -0.000482 0.001537 -17584 1 0.000229 1560.000000 -0.002509 -0.000202 0.001231 -17585 1 0.000200 1560.000000 -0.001052 -0.002425 0.009800 -17586 1 0.000230 1560.000000 0.002542 -0.002878 0.009805 -17587 1 0.000197 1560.000000 -0.001701 0.002338 0.000730 -17588 1 0.000208 1560.000000 0.000531 -0.003745 0.002179 -17589 1 0.000218 1560.000000 -0.000007 0.003566 0.005568 -17590 1 0.000236 1560.000000 0.001669 -0.000110 0.002153 -17591 1 0.000251 1560.000000 -0.002520 -0.000632 0.006744 -17592 1 0.000245 1560.000000 -0.003105 -0.001457 0.002405 -17593 1 0.000204 1560.000000 -0.002586 0.000150 0.005811 -17594 1 0.000283 1560.000000 -0.001817 -0.002544 0.006331 -17595 1 0.000263 1560.000000 0.002258 -0.000537 0.006938 -17596 1 0.000251 1560.000000 -0.001777 0.002352 0.008102 -17597 1 0.000202 1560.000000 0.000172 -0.001738 0.003839 -17598 1 0.000195 1560.000000 0.003107 0.001611 0.007685 -17599 1 0.000205 1560.000000 -0.000488 0.003376 0.001797 -17600 1 0.000217 1560.000000 -0.003177 -0.000406 0.001587 -17601 1 0.000195 1560.000000 0.001987 0.002848 0.002106 -17602 1 0.000197 1560.000000 -0.003199 -0.001634 0.004165 -17603 1 0.000199 1560.000000 -0.002200 0.002460 0.005901 -17604 1 0.000213 1560.000000 0.000815 0.002160 0.002808 -17605 1 0.000238 1560.000000 -0.003543 0.000580 0.005422 -17606 1 0.000256 1560.000000 0.002902 0.001767 0.009630 -17607 1 0.000212 1560.000000 0.001290 0.000051 0.008362 -17608 1 0.000277 1560.000000 0.003374 -0.001028 0.007836 -17609 1 0.000194 1560.000000 -0.003375 0.000820 0.006957 -17610 1 0.000206 1560.000000 -0.001226 -0.001072 0.000657 -17611 1 0.000220 1560.000000 -0.000521 0.003552 0.000569 -17612 1 0.000237 1560.000000 -0.002858 -0.001694 0.002525 -17613 1 0.000220 1560.000000 -0.002866 0.001902 0.000552 -17614 1 0.000209 1560.000000 -0.003193 -0.001417 0.001951 -17615 1 0.000281 1560.000000 -0.000783 -0.003431 0.009017 -17616 1 0.000275 1560.000000 0.003500 0.000826 0.000886 -17617 1 0.000234 1560.000000 0.001734 0.002784 0.007420 -17618 1 0.000213 1560.000000 -0.002763 -0.001967 0.002190 -17619 1 0.000214 1560.000000 0.002109 -0.002522 0.008607 -17620 1 0.000201 1560.000000 -0.003613 0.000876 0.001206 -17621 1 0.000197 1560.000000 -0.000539 -0.001087 0.001958 -17622 1 0.000194 1560.000000 0.003356 0.000012 0.009590 -17623 1 0.000214 1560.000000 -0.000470 -0.002492 0.002868 -17624 1 0.000214 1560.000000 -0.001744 0.002049 0.008527 -17625 1 0.000195 1560.000000 -0.003124 0.000607 0.005030 -17626 1 0.000227 1560.000000 -0.002500 -0.000723 0.005290 -17627 1 0.000217 1560.000000 -0.001418 0.003061 0.005314 -17628 1 0.000214 1560.000000 0.001389 0.000248 0.002986 -17629 1 0.000245 1560.000000 -0.002607 0.001583 0.009616 -17630 1 0.000271 1560.000000 -0.002492 -0.000167 0.002848 -17631 1 0.000205 1560.000000 -0.002380 0.001302 0.003220 -17632 1 0.000206 1560.000000 -0.002177 -0.001754 0.006084 -17633 1 0.000240 1560.000000 -0.000654 -0.002676 0.000138 -17634 1 0.000218 1560.000000 0.001564 0.000863 0.004512 -17635 1 0.000272 1560.000000 -0.003272 0.000461 0.003022 -17636 1 0.000273 1560.000000 0.001893 -0.002960 0.007709 -17637 1 0.000281 1560.000000 -0.001876 0.000045 0.001709 -17638 1 0.000233 1560.000000 0.002307 0.000290 0.004176 -17639 1 0.000213 1560.000000 0.001333 -0.001880 0.000676 -17640 1 0.000239 1560.000000 -0.001379 -0.000580 0.007266 -17641 1 0.000209 1560.000000 0.002529 0.002796 0.008374 -17642 1 0.000276 1560.000000 -0.003166 0.001134 0.002747 -17643 1 0.000245 1560.000000 -0.000591 -0.002496 0.006166 -17644 1 0.000200 1560.000000 0.001334 -0.002770 0.006593 -17645 1 0.000249 1560.000000 -0.000060 -0.003275 0.005744 -17646 1 0.000286 1560.000000 -0.002347 0.001855 0.000746 -17647 1 0.000252 1560.000000 0.000418 -0.001524 0.005403 -17648 1 0.000238 1560.000000 -0.001423 -0.003248 0.003292 -17649 1 0.000207 1560.000000 0.001213 -0.001192 0.005834 -17650 1 0.000209 1560.000000 0.003404 -0.001151 0.000337 -17651 1 0.000278 1560.000000 0.003796 -0.000273 0.000828 -17652 1 0.000237 1560.000000 0.003108 -0.001255 0.007897 -17653 1 0.000278 1560.000000 -0.003778 -0.000367 0.003963 -17654 1 0.000223 1560.000000 -0.002246 -0.002162 0.006482 -17655 1 0.000216 1560.000000 -0.001214 -0.003152 0.005320 -17656 1 0.000240 1560.000000 0.003282 -0.001268 0.002725 -17657 1 0.000264 1560.000000 -0.001490 0.003117 0.004769 -17658 1 0.000273 1560.000000 0.001109 -0.001974 0.001064 -17659 1 0.000252 1560.000000 0.003094 0.001695 0.001590 -17660 1 0.000262 1560.000000 -0.003079 -0.000316 0.007726 -17661 1 0.000234 1560.000000 -0.002763 0.001201 0.006258 -17662 1 0.000259 1560.000000 -0.001247 -0.002966 0.006276 -17663 1 0.000247 1560.000000 0.003248 0.000164 0.001084 -17664 1 0.000255 1560.000000 0.001470 -0.002164 0.002504 -17665 1 0.000258 1560.000000 -0.003129 0.001281 0.001399 -17666 1 0.000263 1560.000000 0.001884 0.002167 0.003056 -17667 1 0.000208 1560.000000 -0.000619 -0.003441 0.006466 -17668 1 0.000268 1560.000000 -0.003128 0.000230 0.008935 -17669 1 0.000231 1560.000000 -0.000544 0.001829 0.004443 -17670 1 0.000274 1560.000000 -0.002096 -0.000549 0.004534 -17671 1 0.000257 1560.000000 0.001238 -0.002122 0.003029 -17672 1 0.000207 1560.000000 0.000926 0.001406 0.009811 -17673 1 0.000195 1560.000000 0.002395 0.002931 0.004512 -17674 1 0.000242 1560.000000 -0.000561 0.002774 0.000466 -17675 1 0.000193 1560.000000 0.002417 -0.000546 0.009661 -17676 1 0.000256 1560.000000 -0.003688 -0.000368 0.008261 -17677 1 0.000248 1560.000000 -0.003477 -0.001191 0.000259 -17678 1 0.000213 1560.000000 0.002059 -0.001852 0.002183 -17679 1 0.000272 1560.000000 -0.003075 0.002306 0.001734 -17680 1 0.000197 1560.000000 -0.001384 0.003537 0.000786 -17681 1 0.000267 1560.000000 0.002177 0.002955 0.002939 -17682 1 0.000271 1560.000000 -0.001929 -0.003324 0.003844 -17683 1 0.000269 1560.000000 0.003132 0.001519 0.000841 -17684 1 0.000257 1560.000000 -0.000930 -0.000863 0.007888 -17685 1 0.000225 1560.000000 -0.003235 -0.000051 0.003442 -17686 1 0.000261 1560.000000 0.002935 0.000337 0.000140 -17687 1 0.000197 1560.000000 -0.001877 0.000542 0.009714 -17688 1 0.000279 1560.000000 -0.002001 0.003115 0.005537 -17689 1 0.000228 1560.000000 0.001622 -0.000323 0.004338 -17690 1 0.000222 1560.000000 -0.002010 0.002512 0.005279 -17691 1 0.000232 1560.000000 -0.001983 0.000238 0.006789 -17692 1 0.000194 1560.000000 0.001595 0.002741 0.000486 -17693 1 0.000192 1560.000000 0.000245 -0.000909 0.004005 -17694 1 0.000250 1560.000000 0.001824 0.003324 0.007209 -17695 1 0.000231 1560.000000 -0.002539 -0.002514 0.002071 -17696 1 0.000285 1560.000000 -0.000750 0.002280 0.002317 -17697 1 0.000277 1560.000000 0.002865 -0.001070 0.006459 -17698 1 0.000211 1560.000000 0.002104 0.000222 0.008088 -17699 1 0.000230 1560.000000 -0.000176 0.002299 0.003932 -17700 1 0.000228 1560.000000 -0.000365 0.000504 0.002642 -17701 1 0.000241 1560.000000 0.000392 -0.002056 0.005108 -17702 1 0.000270 1560.000000 -0.002254 0.000075 0.001467 -17703 1 0.000250 1560.000000 0.001526 -0.002261 0.007359 -17704 1 0.000283 1560.000000 -0.000342 0.002711 0.004970 -17705 1 0.000201 1560.000000 0.000091 -0.000081 0.008115 -17706 1 0.000193 1560.000000 0.002801 -0.000065 0.008002 -17707 1 0.000220 1560.000000 0.002437 -0.000418 0.006421 -17708 1 0.000220 1560.000000 0.002724 0.001120 0.007211 -17709 1 0.000197 1560.000000 0.000433 -0.002605 0.001686 -17710 1 0.000237 1560.000000 -0.003520 0.000129 0.003685 -17711 1 0.000233 1560.000000 0.001723 0.003143 0.001343 -17712 1 0.000212 1560.000000 -0.001718 0.001208 0.004059 -17713 1 0.000232 1560.000000 0.002783 0.002147 0.003743 -17714 1 0.000202 1560.000000 -0.001296 -0.000067 0.001306 -17715 1 0.000222 1560.000000 0.001119 -0.002847 0.001966 -17716 1 0.000208 1560.000000 0.002753 0.000628 0.006967 -17717 1 0.000199 1560.000000 -0.003580 -0.000017 0.009338 -17718 1 0.000219 1560.000000 0.000270 0.002832 0.006772 -17719 1 0.000221 1560.000000 0.002744 0.001007 0.009494 -17720 1 0.000286 1560.000000 0.001497 -0.001556 0.009775 -17721 1 0.000266 1560.000000 -0.003256 -0.001269 0.006314 -17722 1 0.000217 1560.000000 -0.002256 -0.000201 0.007542 -17723 1 0.000235 1560.000000 -0.000892 -0.002970 0.006658 -17724 1 0.000212 1560.000000 0.002766 -0.001765 0.009348 -17725 1 0.000241 1560.000000 0.000381 0.002554 0.004992 -17726 1 0.000285 1560.000000 -0.001056 -0.001928 0.007664 -17727 1 0.000260 1560.000000 -0.001618 -0.002346 0.007019 -17728 1 0.000204 1560.000000 -0.000094 0.000846 0.004353 -17729 1 0.000251 1560.000000 0.002104 -0.000985 0.001861 -17730 1 0.000248 1560.000000 -0.001032 0.002018 0.002792 -17731 1 0.000262 1560.000000 0.002518 0.001267 0.000697 -17732 1 0.000229 1560.000000 -0.002442 -0.001134 0.007356 -17733 1 0.000283 1560.000000 0.001517 -0.000981 0.000467 -17734 1 0.000214 1560.000000 -0.002008 -0.001983 0.000634 -17735 1 0.000266 1560.000000 -0.001989 -0.002145 0.001098 -17736 1 0.000279 1560.000000 -0.001316 -0.003436 0.005652 -17737 1 0.000196 1560.000000 -0.002274 -0.001170 0.006341 -17738 1 0.000233 1560.000000 -0.000203 0.001761 0.006129 -17739 1 0.000243 1560.000000 0.002782 0.000560 0.003513 -17740 1 0.000194 1560.000000 0.001520 -0.000437 0.003886 -17741 1 0.000242 1560.000000 -0.001407 -0.001069 0.009468 -17742 1 0.000200 1560.000000 -0.000552 -0.001177 0.003641 -17743 1 0.000235 1560.000000 -0.000076 -0.002778 0.009744 -17744 1 0.000262 1560.000000 0.003325 -0.001850 0.003190 -17745 1 0.000255 1560.000000 0.003166 -0.000323 0.005149 -17746 1 0.000288 1560.000000 -0.001285 0.003622 0.005155 -17747 1 0.000203 1560.000000 -0.002853 0.000904 0.000321 -17748 1 0.000236 1560.000000 -0.000410 -0.003685 0.000753 -17749 1 0.000227 1560.000000 -0.002114 0.002571 0.002176 -17750 1 0.000221 1560.000000 -0.000106 0.001536 0.005989 -17751 1 0.000268 1560.000000 -0.002019 0.002820 0.000872 -17752 1 0.000212 1560.000000 0.002483 0.001611 0.003490 -17753 1 0.000226 1560.000000 0.000871 -0.000578 0.004654 -17754 1 0.000227 1560.000000 -0.000098 -0.003702 0.004303 -17755 1 0.000264 1560.000000 0.001255 0.003486 0.008111 -17756 1 0.000252 1560.000000 -0.003406 -0.001144 0.002206 -17757 1 0.000216 1560.000000 0.001324 0.003453 0.001553 -17758 1 0.000280 1560.000000 0.002042 -0.002224 0.009305 -17759 1 0.000205 1560.000000 -0.001995 0.002177 0.004822 -17760 1 0.000219 1560.000000 0.000935 0.000187 0.006782 -17761 1 0.000192 1560.000000 0.000477 0.002351 0.003800 -17762 1 0.000225 1560.000000 0.001412 0.001763 0.000629 -17763 1 0.000281 1560.000000 0.001531 -0.001706 0.008602 -17764 1 0.000219 1560.000000 0.000256 -0.000280 0.000500 -17765 1 0.000234 1560.000000 -0.002206 -0.001223 0.001868 -17766 1 0.000199 1560.000000 -0.001359 -0.000124 0.008739 -17767 1 0.000235 1560.000000 -0.001831 0.001118 0.006568 -17768 1 0.000227 1560.000000 0.003050 0.000242 0.006409 -17769 1 0.000280 1560.000000 0.002640 0.001031 0.006646 -17770 1 0.000259 1560.000000 0.003392 0.000142 0.009305 -17771 1 0.000212 1560.000000 -0.000541 -0.002503 0.001297 -17772 1 0.000255 1560.000000 -0.001753 0.002382 0.008929 -17773 1 0.000200 1560.000000 0.000457 -0.001781 0.008359 -17774 1 0.000221 1560.000000 -0.002792 -0.000196 0.002253 -17775 1 0.000233 1560.000000 0.001075 -0.003347 0.009531 -17776 1 0.000208 1560.000000 0.000870 0.001894 0.008701 -17777 1 0.000194 1560.000000 -0.000061 0.001131 0.002980 -17778 1 0.000276 1560.000000 -0.003064 -0.001513 0.008945 -17779 1 0.000272 1560.000000 0.002104 0.001144 0.009780 -17780 1 0.000196 1560.000000 -0.000344 0.002607 0.006551 -17781 1 0.000197 1560.000000 0.000134 -0.002253 0.001377 -17782 1 0.000278 1560.000000 -0.000448 0.002246 0.004840 -17783 1 0.000204 1560.000000 -0.002678 -0.000397 0.003090 -17784 1 0.000192 1560.000000 -0.002162 -0.003026 0.003597 -17785 1 0.000206 1560.000000 -0.000706 -0.003353 0.005857 -17786 1 0.000195 1560.000000 -0.001831 0.003269 0.004867 -17787 1 0.000241 1560.000000 0.003604 0.000115 0.002723 -17788 1 0.000222 1560.000000 0.001808 -0.001793 0.002687 -17789 1 0.000223 1560.000000 0.002109 -0.002619 0.000771 -17790 1 0.000256 1560.000000 0.002489 -0.001500 0.006536 -17791 1 0.000274 1560.000000 0.001086 -0.002908 0.008984 -17792 1 0.000194 1560.000000 -0.002192 0.000131 0.005715 -17793 1 0.000263 1560.000000 -0.003180 -0.001570 0.006511 -17794 1 0.000208 1560.000000 0.002666 0.002767 0.002956 -17795 1 0.000259 1560.000000 0.003291 0.000249 0.005531 -17796 1 0.000235 1560.000000 -0.000509 -0.003784 0.001478 -17797 1 0.000260 1560.000000 0.003646 -0.001204 0.003669 -17798 1 0.000206 1560.000000 -0.002149 0.003195 0.003354 -17799 1 0.000264 1560.000000 0.001114 0.000282 0.002993 -17800 1 0.000229 1560.000000 0.000649 0.000575 0.002669 -17801 1 0.000220 1560.000000 -0.003181 -0.001339 0.007280 -17802 1 0.000215 1560.000000 0.001651 0.002829 0.003180 -17803 1 0.000196 1560.000000 -0.002059 -0.001592 0.007722 -17804 1 0.000234 1560.000000 0.000225 -0.003554 0.004664 -17805 1 0.000208 1560.000000 0.003070 0.001885 0.004590 -17806 1 0.000204 1560.000000 0.002976 -0.002014 0.003604 -17807 1 0.000231 1560.000000 0.001389 -0.000626 0.007575 -17808 1 0.000206 1560.000000 -0.001793 0.002454 0.005246 -17809 1 0.000195 1560.000000 -0.000211 0.000156 0.003523 -17810 1 0.000203 1560.000000 0.003018 -0.002390 0.000482 -17811 1 0.000267 1560.000000 0.000384 0.001589 0.003560 -17812 1 0.000212 1560.000000 -0.001346 0.001509 0.003908 -17813 1 0.000277 1560.000000 -0.001317 0.001147 0.002007 -17814 1 0.000223 1560.000000 -0.000059 0.001275 0.007415 -17815 1 0.000195 1560.000000 -0.003538 -0.001516 0.002497 -17816 1 0.000225 1560.000000 0.000836 0.001026 0.003277 -17817 1 0.000287 1560.000000 -0.001916 -0.003265 0.006930 -17818 1 0.000248 1560.000000 -0.000810 0.002694 0.009778 -17819 1 0.000262 1560.000000 0.000873 0.003747 0.009154 -17820 1 0.000277 1560.000000 0.001492 -0.001946 0.005629 -17821 1 0.000282 1560.000000 -0.002464 0.001695 0.004221 -17822 1 0.000283 1560.000000 -0.000043 -0.003839 0.001906 -17823 1 0.000274 1560.000000 -0.003528 -0.000044 0.005208 -17824 1 0.000240 1560.000000 0.003613 0.000919 0.004260 -17825 1 0.000215 1560.000000 -0.001185 -0.001891 0.008674 -17826 1 0.000205 1560.000000 -0.002692 -0.002156 0.000658 -17827 1 0.000251 1560.000000 -0.002776 -0.001207 0.003125 -17828 1 0.000239 1560.000000 0.002317 0.000260 0.000591 -17829 1 0.000288 1560.000000 0.002134 0.000125 0.002684 -17830 1 0.000194 1560.000000 0.003081 0.000822 0.007242 -17831 1 0.000196 1560.000000 0.000930 -0.000502 0.008390 -17832 1 0.000200 1560.000000 -0.002542 -0.001262 0.001815 -17833 1 0.000203 1560.000000 -0.001011 0.000503 0.004395 -17834 1 0.000229 1560.000000 0.000278 -0.002858 0.008221 -17835 1 0.000265 1560.000000 0.001501 -0.003131 0.008824 -17836 1 0.000254 1560.000000 0.003261 0.002020 0.008871 -17837 1 0.000243 1560.000000 0.000394 -0.003831 0.001258 -17838 1 0.000285 1560.000000 0.002249 0.002179 0.000940 -17839 1 0.000199 1560.000000 0.001200 0.001214 0.008517 -17840 1 0.000207 1560.000000 -0.001065 -0.003114 0.005518 -17841 1 0.000245 1560.000000 0.000377 0.002926 0.000146 -17842 1 0.000195 1560.000000 0.001443 -0.002374 0.005014 -17843 1 0.000265 1560.000000 0.003339 0.000054 0.005065 -17844 1 0.000221 1560.000000 0.002442 -0.000908 0.009240 -17845 1 0.000268 1560.000000 -0.001879 0.000384 0.009275 -17846 1 0.000259 1560.000000 0.002789 0.002583 0.000879 -17847 1 0.000207 1560.000000 0.001844 -0.001678 0.001371 -17848 1 0.000287 1560.000000 0.001769 -0.002086 0.009801 -17849 1 0.000283 1560.000000 0.002579 -0.002039 0.001981 -17850 1 0.000257 1560.000000 -0.000400 -0.002790 0.001411 -17851 1 0.000259 1560.000000 -0.001350 -0.002116 0.003915 -17852 1 0.000224 1560.000000 -0.002713 -0.001347 0.007915 -17853 1 0.000271 1560.000000 -0.002806 -0.002585 0.002450 -17854 1 0.000198 1560.000000 -0.002032 0.003266 0.005101 -17855 1 0.000279 1560.000000 0.002638 0.000873 0.002280 -17856 1 0.000218 1560.000000 -0.000012 -0.000847 0.001862 -17857 1 0.000284 1560.000000 -0.002747 -0.000696 0.005843 -17858 1 0.000202 1560.000000 -0.003253 0.002048 0.003746 -17859 1 0.000213 1560.000000 0.002524 -0.002499 0.006405 -17860 1 0.000226 1560.000000 0.003271 0.001860 0.006810 -17861 1 0.000239 1560.000000 -0.000830 0.002311 0.004134 -17862 1 0.000243 1560.000000 -0.001058 -0.003061 0.001305 -17863 1 0.000228 1560.000000 -0.000609 0.001271 0.001302 -17864 1 0.000231 1560.000000 -0.001423 -0.000722 0.000295 -17865 1 0.000201 1560.000000 -0.000038 -0.000254 0.001434 -17866 1 0.000201 1560.000000 -0.003577 -0.000431 0.004378 -17867 1 0.000245 1560.000000 -0.000891 -0.002111 0.003216 -17868 1 0.000282 1560.000000 0.002760 0.001589 0.005127 -17869 1 0.000243 1560.000000 -0.003520 0.000296 0.004284 -17870 1 0.000271 1560.000000 0.000375 -0.001455 0.006000 -17871 1 0.000200 1560.000000 -0.001201 0.001094 0.000898 -17872 1 0.000203 1560.000000 -0.002812 0.002153 0.000142 -17873 1 0.000265 1560.000000 0.000299 -0.003019 0.006070 -17874 1 0.000237 1560.000000 0.003546 0.000550 0.002095 -17875 1 0.000218 1560.000000 -0.001582 0.001163 0.005585 -17876 1 0.000215 1560.000000 0.001640 0.000352 0.005055 -17877 1 0.000264 1560.000000 -0.003299 0.000911 0.003893 -17878 1 0.000281 1560.000000 -0.000798 0.001979 0.006807 -17879 1 0.000225 1560.000000 -0.002336 0.000764 0.009276 -17880 1 0.000258 1560.000000 -0.000071 0.000934 0.003884 -17881 1 0.000269 1560.000000 -0.001621 -0.003096 0.004805 -17882 1 0.000214 1560.000000 -0.001549 -0.002993 0.008283 -17883 1 0.000209 1560.000000 0.000681 0.000581 0.003129 -17884 1 0.000232 1560.000000 -0.001968 0.002894 0.007694 -17885 1 0.000211 1560.000000 0.000240 -0.003150 0.006920 -17886 1 0.000253 1560.000000 0.001475 -0.003193 0.003396 -17887 1 0.000229 1560.000000 0.003326 -0.001052 0.001735 -17888 1 0.000209 1560.000000 -0.000130 -0.003286 0.002343 -17889 1 0.000288 1560.000000 0.000540 0.003703 0.001457 -17890 1 0.000204 1560.000000 -0.000233 -0.000134 0.001445 -17891 1 0.000196 1560.000000 0.001414 0.001975 0.007041 -17892 1 0.000228 1560.000000 -0.001539 -0.001728 0.008991 -17893 1 0.000266 1560.000000 -0.000360 0.001580 0.001000 -17894 1 0.000206 1560.000000 0.000377 0.002060 0.003053 -17895 1 0.000198 1560.000000 0.000274 0.001966 0.009582 -17896 1 0.000282 1560.000000 0.003628 0.000115 0.009792 -17897 1 0.000194 1560.000000 -0.002339 -0.002679 0.004462 -17898 1 0.000194 1560.000000 0.003514 -0.000022 0.008759 -17899 1 0.000281 1560.000000 0.001615 0.003414 0.004195 -17900 1 0.000238 1560.000000 -0.001527 0.002310 0.000328 -17901 1 0.000195 1560.000000 -0.000763 -0.003166 0.006810 -17902 1 0.000202 1560.000000 -0.000052 -0.001309 0.000138 -17903 1 0.000225 1560.000000 -0.002378 0.002349 0.007471 -17904 1 0.000257 1560.000000 -0.002404 0.001651 0.001068 -17905 1 0.000219 1560.000000 -0.001646 -0.003246 0.004057 -17906 1 0.000194 1560.000000 0.001312 0.002039 0.008709 -17907 1 0.000285 1560.000000 -0.000626 -0.003552 0.008316 -17908 1 0.000230 1560.000000 -0.000207 0.000286 0.008507 -17909 1 0.000197 1560.000000 -0.000985 0.002594 0.002957 -17910 1 0.000275 1560.000000 -0.001153 0.002130 0.008101 -17911 1 0.000230 1560.000000 0.001373 -0.001281 0.003069 -17912 1 0.000222 1560.000000 0.001324 -0.002161 0.000128 -17913 1 0.000253 1560.000000 -0.001737 0.001924 0.009035 -17914 1 0.000254 1560.000000 0.000337 -0.002489 0.008502 -17915 1 0.000214 1560.000000 -0.000131 0.002503 0.006241 -17916 1 0.000255 1560.000000 -0.002784 0.000913 0.009432 -17917 1 0.000257 1560.000000 -0.003815 -0.000255 0.004620 -17918 1 0.000199 1560.000000 0.000406 0.003545 0.001834 -17919 1 0.000238 1560.000000 0.003209 0.000759 0.003109 -17920 1 0.000268 1560.000000 0.000290 -0.001848 0.006647 -17921 1 0.000282 1560.000000 -0.003753 0.000838 0.001011 -17922 1 0.000251 1560.000000 0.000486 -0.000970 0.008200 -17923 1 0.000196 1560.000000 0.000513 -0.000035 0.006707 -17924 1 0.000200 1560.000000 0.001310 -0.000126 0.007555 -17925 1 0.000206 1560.000000 0.000947 -0.002637 0.002505 -17926 1 0.000199 1560.000000 -0.001877 -0.000712 0.005446 -17927 1 0.000286 1560.000000 0.003769 0.000704 0.001633 -17928 1 0.000265 1560.000000 -0.002152 -0.001150 0.001245 -17929 1 0.000245 1560.000000 0.003104 -0.000836 0.000195 -17930 1 0.000195 1560.000000 -0.000557 -0.001389 0.000591 -17931 1 0.000233 1560.000000 0.002812 -0.002631 0.002847 -17932 1 0.000246 1560.000000 0.002636 -0.001009 0.008754 -17933 1 0.000283 1560.000000 0.000860 -0.002191 0.007465 -17934 1 0.000220 1560.000000 -0.000114 0.000710 0.004191 -17935 1 0.000268 1560.000000 0.003256 -0.000321 0.005963 -17936 1 0.000205 1560.000000 -0.002328 0.000705 0.008788 -17937 1 0.000275 1560.000000 0.002835 0.002564 0.004826 -17938 1 0.000258 1560.000000 0.000947 0.003455 0.002270 -17939 1 0.000216 1560.000000 0.000919 -0.003154 0.004377 -17940 1 0.000280 1560.000000 -0.001701 0.001944 0.005851 -17941 1 0.000249 1560.000000 0.000984 0.002259 0.001541 -17942 1 0.000199 1560.000000 -0.001270 -0.000529 0.006602 -17943 1 0.000212 1560.000000 -0.000045 -0.000869 0.009539 -17944 1 0.000278 1560.000000 0.001699 0.001337 0.009833 -17945 1 0.000260 1560.000000 0.000662 0.003509 0.004194 -17946 1 0.000233 1560.000000 0.002683 -0.000934 0.005410 -17947 1 0.000197 1560.000000 -0.002151 -0.002682 0.004294 -17948 1 0.000266 1560.000000 0.000770 0.003703 0.003242 -17949 1 0.000195 1560.000000 0.001930 0.003145 0.008925 -17950 1 0.000254 1560.000000 -0.003618 0.001320 0.007825 -17951 1 0.000281 1560.000000 -0.001927 0.001217 0.008149 -17952 1 0.000266 1560.000000 -0.002762 -0.000128 0.002685 -17953 1 0.000240 1560.000000 0.001337 -0.001204 0.008614 -17954 1 0.000193 1560.000000 -0.003126 0.000545 0.008723 -17955 1 0.000210 1560.000000 -0.001814 0.000321 0.008394 -17956 1 0.000205 1560.000000 0.000116 -0.000063 0.007584 -17957 1 0.000203 1560.000000 0.000827 0.000886 0.003938 -17958 1 0.000283 1560.000000 0.001494 0.000469 0.000783 -17959 1 0.000241 1560.000000 -0.001755 -0.003429 0.007153 -17960 1 0.000192 1560.000000 -0.002187 0.000606 0.005092 -17961 1 0.000214 1560.000000 -0.002229 -0.002163 0.000569 -17962 1 0.000205 1560.000000 0.000554 -0.000074 0.005044 -17963 1 0.000198 1560.000000 -0.003734 0.000952 0.007927 -17964 1 0.000232 1560.000000 0.001637 -0.001912 0.003210 -17965 1 0.000235 1560.000000 -0.002546 -0.002753 0.008103 -17966 1 0.000249 1560.000000 0.003310 -0.000553 0.008588 -17967 1 0.000214 1560.000000 -0.002449 0.002571 0.007311 -17968 1 0.000215 1560.000000 0.003173 -0.002003 0.008731 -17969 1 0.000238 1560.000000 0.000410 -0.003695 0.005886 -17970 1 0.000215 1560.000000 -0.001411 -0.001508 0.006793 -17971 1 0.000206 1560.000000 -0.002501 0.001563 0.007851 -17972 1 0.000276 1560.000000 -0.001023 -0.003565 0.008610 -17973 1 0.000276 1560.000000 0.001732 0.001379 0.006730 -17974 1 0.000201 1560.000000 -0.000621 -0.003065 0.004445 -17975 1 0.000240 1560.000000 0.002697 0.002255 0.005500 -17976 1 0.000272 1560.000000 0.000607 0.002305 0.008075 -17977 1 0.000210 1560.000000 -0.003490 0.001172 0.003198 -17978 1 0.000222 1560.000000 -0.000849 -0.002753 0.004019 -17979 1 0.000203 1560.000000 -0.000482 -0.001510 0.002161 -17980 1 0.000194 1560.000000 -0.002452 -0.001125 0.003594 -17981 1 0.000279 1560.000000 0.002481 0.000254 0.007408 -17982 1 0.000285 1560.000000 0.001471 -0.002046 0.001871 -17983 1 0.000205 1560.000000 0.003629 0.001034 0.000991 -17984 1 0.000202 1560.000000 -0.002446 0.000737 0.002788 -17985 1 0.000232 1560.000000 -0.002626 0.002560 0.003151 -17986 1 0.000264 1560.000000 0.002974 0.002346 0.004281 -17987 1 0.000282 1560.000000 -0.001988 -0.003044 0.007712 -17988 1 0.000243 1560.000000 0.003154 0.001609 0.004731 -17989 1 0.000227 1560.000000 0.002649 0.000463 0.007662 -17990 1 0.000270 1560.000000 0.002298 0.002628 0.007296 -17991 1 0.000220 1560.000000 -0.002108 -0.001298 0.009177 -17992 1 0.000193 1560.000000 0.000486 0.002798 0.001283 -17993 1 0.000247 1560.000000 0.000651 -0.001202 0.006315 -17994 1 0.000288 1560.000000 -0.001763 0.002619 0.006422 -17995 1 0.000204 1560.000000 0.002338 -0.002096 0.000966 -17996 1 0.000279 1560.000000 -0.003575 -0.000803 0.007133 -17997 1 0.000195 1560.000000 0.001006 -0.000962 0.001910 -17998 1 0.000273 1560.000000 -0.002637 0.000893 0.004466 -17999 1 0.000228 1560.000000 0.000950 -0.002471 0.005666 -18000 1 0.000282 1560.000000 0.001475 0.002813 0.007459 -18001 1 0.000209 1560.000000 -0.000987 0.003720 0.006153 -18002 1 0.000248 1560.000000 0.000730 0.003334 0.000290 -18003 1 0.000206 1560.000000 0.001847 0.000912 0.000114 -18004 1 0.000230 1560.000000 0.001078 -0.002579 0.003469 -18005 1 0.000251 1560.000000 -0.000563 0.003483 0.003468 -18006 1 0.000253 1560.000000 -0.000362 -0.002970 0.000931 -18007 1 0.000255 1560.000000 -0.001779 -0.000684 0.002240 -18008 1 0.000202 1560.000000 0.000115 -0.002244 0.009682 -18009 1 0.000196 1560.000000 0.003133 -0.001992 0.003228 -18010 1 0.000264 1560.000000 -0.000703 -0.003726 0.000667 -18011 1 0.000259 1560.000000 -0.000160 -0.002364 0.006166 -18012 1 0.000229 1560.000000 -0.003745 -0.000907 0.008411 -18013 1 0.000218 1560.000000 -0.003051 -0.000082 0.004380 -18014 1 0.000211 1560.000000 0.001570 0.000585 0.006356 -18015 1 0.000226 1560.000000 -0.001803 0.001598 0.003992 -18016 1 0.000246 1560.000000 -0.003188 -0.000389 0.005962 -18017 1 0.000220 1560.000000 -0.003104 0.000983 0.007185 -18018 1 0.000220 1560.000000 0.003750 0.000855 0.003872 -18019 1 0.000193 1560.000000 -0.000707 -0.003027 0.003236 -18020 1 0.000201 1560.000000 0.001234 -0.003580 0.006734 -18021 1 0.000231 1560.000000 -0.002826 0.002417 0.003346 -18022 1 0.000209 1560.000000 0.001071 -0.002417 0.006779 -18023 1 0.000230 1560.000000 -0.001336 -0.000198 0.009504 -18024 1 0.000202 1560.000000 0.001556 0.002103 0.004431 -18025 1 0.000252 1560.000000 -0.003049 0.001905 0.006244 -18026 1 0.000251 1560.000000 -0.002333 0.001117 0.000420 -18027 1 0.000219 1560.000000 -0.001146 0.002846 0.000486 -18028 1 0.000254 1560.000000 0.002119 -0.001005 0.000136 -18029 1 0.000223 1560.000000 0.001032 0.001957 0.007520 -18030 1 0.000267 1560.000000 0.000785 -0.002845 0.007730 -18031 1 0.000223 1560.000000 -0.001307 0.001291 0.007227 -18032 1 0.000208 1560.000000 0.000224 -0.000484 0.001590 -18033 1 0.000194 1560.000000 -0.003062 -0.002101 0.003480 -18034 1 0.000207 1560.000000 0.000810 -0.000607 0.002007 -18035 1 0.000236 1560.000000 0.001916 0.001631 0.006501 -18036 1 0.000193 1560.000000 0.001585 -0.001039 0.003801 -18037 1 0.000202 1560.000000 0.002269 0.002280 0.002767 -18038 1 0.000192 1560.000000 -0.001059 -0.002282 0.004519 -18039 1 0.000205 1560.000000 0.003409 -0.001006 0.000873 -18040 1 0.000198 1560.000000 -0.002325 0.001697 0.003259 -18041 1 0.000245 1560.000000 0.003408 -0.000844 0.002288 -18042 1 0.000222 1560.000000 0.000889 0.000990 0.006332 -18043 1 0.000226 1560.000000 0.002433 -0.001097 0.004893 -18044 1 0.000277 1560.000000 -0.002316 0.002764 0.001071 -18045 1 0.000208 1560.000000 0.003434 -0.000100 0.006578 -18046 1 0.000267 1560.000000 -0.001397 -0.000191 0.006378 -18047 1 0.000242 1560.000000 -0.000912 0.001138 0.000727 -18048 1 0.000277 1560.000000 -0.002452 -0.001383 0.007268 -18049 1 0.000250 1560.000000 -0.001816 -0.002091 0.009394 -18050 1 0.000198 1560.000000 -0.000394 0.003434 0.009372 -18051 1 0.000231 1560.000000 -0.000801 -0.001415 0.000553 -18052 1 0.000246 1560.000000 0.000424 -0.002477 0.007528 -18053 1 0.000228 1560.000000 -0.000292 0.002838 0.000190 -18054 1 0.000235 1560.000000 -0.001865 0.000484 0.002778 -18055 1 0.000251 1560.000000 -0.001322 -0.002382 0.006144 -18056 1 0.000251 1560.000000 0.002819 0.002601 0.004247 -18057 1 0.000198 1560.000000 0.000094 0.001533 0.008276 -18058 1 0.000220 1560.000000 -0.002249 0.002446 0.008634 -18059 1 0.000285 1560.000000 0.003210 -0.002018 0.001930 -18060 1 0.000211 1560.000000 0.000545 0.002722 0.001681 -18061 1 0.000246 1560.000000 -0.003313 0.001257 0.007504 -18062 1 0.000246 1560.000000 -0.002373 0.002052 0.007692 -18063 1 0.000210 1560.000000 0.000171 0.002967 0.007874 -18064 1 0.000269 1560.000000 0.000541 0.003716 0.009541 -18065 1 0.000226 1560.000000 -0.000337 0.000872 0.007131 -18066 1 0.000228 1560.000000 0.000751 0.003690 0.006288 -18067 1 0.000238 1560.000000 0.000797 0.001877 0.000983 -18068 1 0.000206 1560.000000 -0.003813 -0.000473 0.001470 -18069 1 0.000248 1560.000000 -0.000586 -0.003370 0.003423 -18070 1 0.000286 1560.000000 0.000545 0.002121 0.000221 -18071 1 0.000230 1560.000000 -0.001557 0.000129 0.006488 -18072 1 0.000239 1560.000000 0.000113 -0.003311 0.001455 -18073 1 0.000268 1560.000000 0.002203 -0.003120 0.000986 -18074 1 0.000231 1560.000000 -0.000743 0.002018 0.007270 -18075 1 0.000225 1560.000000 -0.001618 -0.001877 0.008114 -18076 1 0.000247 1560.000000 0.002600 -0.002671 0.003008 -18077 1 0.000275 1560.000000 -0.003561 0.001369 0.006881 -18078 1 0.000284 1560.000000 0.000676 0.003255 0.007444 -18079 1 0.000237 1560.000000 -0.002189 0.001781 0.006180 -18080 1 0.000228 1560.000000 0.002844 -0.001105 0.008470 -18081 1 0.000261 1560.000000 0.001513 0.001997 0.000290 -18082 1 0.000219 1560.000000 -0.000200 0.001986 0.001810 -18083 1 0.000205 1560.000000 0.001113 0.003492 0.007063 -18084 1 0.000277 1560.000000 -0.002268 0.001440 0.005024 -18085 1 0.000195 1560.000000 -0.000053 -0.000620 0.006333 -18086 1 0.000208 1560.000000 -0.000276 0.000334 0.006958 -18087 1 0.000271 1560.000000 -0.001563 0.003447 0.004557 -18088 1 0.000284 1560.000000 -0.001526 -0.001324 0.009707 -18089 1 0.000288 1560.000000 -0.000280 -0.003186 0.009322 -18090 1 0.000261 1560.000000 0.002899 0.000147 0.006685 -18091 1 0.000255 1560.000000 -0.000723 -0.001462 0.007752 -18092 1 0.000207 1560.000000 -0.001801 0.002741 0.002901 -18093 1 0.000203 1560.000000 0.002980 -0.002379 0.004793 -18094 1 0.000220 1560.000000 0.001271 0.002240 0.000490 -18095 1 0.000265 1560.000000 0.002141 0.002419 0.006610 -18096 1 0.000202 1560.000000 0.001708 0.001654 0.000174 -18097 1 0.000209 1560.000000 0.000199 0.003815 0.000937 -18098 1 0.000200 1560.000000 0.001901 0.002417 0.004268 -18099 1 0.000214 1560.000000 0.002221 0.002496 0.005644 -18100 1 0.000237 1560.000000 0.001915 0.001425 0.000133 -18101 1 0.000261 1560.000000 -0.000893 0.002481 0.000637 -18102 1 0.000193 1560.000000 -0.000491 -0.002067 0.009044 -18103 1 0.000254 1560.000000 0.002170 -0.001219 0.006451 -18104 1 0.000251 1560.000000 0.000775 -0.002099 0.005351 -18105 1 0.000221 1560.000000 -0.000610 0.002360 0.004354 -18106 1 0.000220 1560.000000 0.002192 -0.001398 0.007767 -18107 1 0.000283 1560.000000 0.000804 0.003399 0.002791 -18108 1 0.000230 1560.000000 -0.001703 0.000468 0.000923 -18109 1 0.000220 1560.000000 0.000889 0.001756 0.005940 -18110 1 0.000222 1560.000000 0.000613 0.001829 0.003520 -18111 1 0.000204 1560.000000 -0.000610 0.000097 0.009167 -18112 1 0.000198 1560.000000 0.001656 0.002099 0.001834 -18113 1 0.000205 1560.000000 0.000185 -0.000033 0.005805 -18114 1 0.000283 1560.000000 -0.001498 -0.003549 0.003059 -18115 1 0.000226 1560.000000 -0.003055 0.001989 0.001198 -18116 1 0.000245 1560.000000 0.002181 0.002930 0.009813 -18117 1 0.000262 1560.000000 -0.001988 0.003160 0.007945 -18118 1 0.000211 1560.000000 -0.002150 -0.002894 0.009419 -18119 1 0.000198 1560.000000 -0.002175 0.000154 0.004404 -18120 1 0.000230 1560.000000 0.003564 -0.001431 0.000886 -18121 1 0.000197 1560.000000 -0.001653 -0.002475 0.001670 -18122 1 0.000207 1560.000000 -0.002134 0.000788 0.007140 -18123 1 0.000213 1560.000000 0.001914 -0.002859 0.007084 -18124 1 0.000195 1560.000000 -0.002458 -0.001609 0.005064 -18125 1 0.000214 1560.000000 0.002871 0.001961 0.001634 -18126 1 0.000237 1560.000000 0.000023 -0.002485 0.009772 -18127 1 0.000248 1560.000000 0.002593 0.002190 0.001529 -18128 1 0.000287 1560.000000 0.003014 0.001392 0.009833 -18129 1 0.000235 1560.000000 -0.000790 0.002967 0.008113 -18130 1 0.000283 1560.000000 -0.002799 0.000236 0.000145 -18131 1 0.000227 1560.000000 0.000956 0.003349 0.007135 -18132 1 0.000258 1560.000000 -0.002392 0.002387 0.001218 -18133 1 0.000273 1560.000000 -0.001884 0.001105 0.009848 -18134 1 0.000247 1560.000000 -0.002089 -0.001771 0.002392 -18135 1 0.000237 1560.000000 0.000680 -0.003291 0.004776 -18136 1 0.000197 1560.000000 -0.000457 0.002544 0.004676 -18137 1 0.000210 1560.000000 0.003313 -0.001894 0.007705 -18138 1 0.000281 1560.000000 -0.002123 -0.003202 0.005776 -18139 1 0.000204 1560.000000 -0.001302 0.000732 0.005390 -18140 1 0.000239 1560.000000 -0.002742 0.000097 0.005577 -18141 1 0.000268 1560.000000 0.002240 0.001812 0.008360 -18142 1 0.000282 1560.000000 -0.003563 0.001343 0.002535 -18143 1 0.000196 1560.000000 -0.000171 0.002709 0.008653 -18144 1 0.000213 1560.000000 -0.000775 0.001539 0.008986 -18145 1 0.000247 1560.000000 -0.002335 -0.000462 0.009607 -18146 1 0.000256 1560.000000 0.002627 0.002517 0.006104 -18147 1 0.000249 1560.000000 0.001454 0.002688 0.009817 -18148 1 0.000195 1560.000000 0.003245 -0.000812 0.001001 -18149 1 0.000247 1560.000000 0.001385 0.002223 0.005640 -18150 1 0.000209 1560.000000 0.001270 0.001616 0.002623 -18151 1 0.000256 1560.000000 -0.000432 -0.001689 0.004724 -18152 1 0.000199 1560.000000 -0.003242 -0.000743 0.004484 -18153 1 0.000283 1560.000000 -0.002853 -0.002572 0.004236 -18154 1 0.000211 1560.000000 0.001622 0.001754 0.001574 -18155 1 0.000223 1560.000000 0.002314 -0.001599 0.005690 -18156 1 0.000284 1560.000000 0.000475 -0.002159 0.004149 -18157 1 0.000216 1560.000000 0.000577 -0.003318 0.006417 -18158 1 0.000241 1560.000000 -0.002052 -0.002633 0.000783 -18159 1 0.000195 1560.000000 0.000018 0.000706 0.005360 -18160 1 0.000211 1560.000000 -0.002618 0.001232 0.008404 -18161 1 0.000247 1560.000000 0.001668 -0.000268 0.001276 -18162 1 0.000199 1560.000000 -0.000186 -0.002549 0.009249 -18163 1 0.000202 1560.000000 0.000316 0.001326 0.000141 -18164 1 0.000243 1560.000000 -0.003442 -0.001030 0.009076 -18165 1 0.000215 1560.000000 -0.000001 0.000628 0.009681 -18166 1 0.000224 1560.000000 0.001172 -0.002248 0.001026 -18167 1 0.000204 1560.000000 0.002169 -0.001712 0.006279 -18168 1 0.000283 1560.000000 -0.001923 0.001067 0.001502 -18169 1 0.000231 1560.000000 -0.000564 -0.000778 0.002447 -18170 1 0.000199 1560.000000 -0.001806 0.000830 0.006027 -18171 1 0.000231 1560.000000 -0.002266 0.001280 0.001874 -18172 1 0.000193 1560.000000 0.000184 0.001210 0.009219 -18173 1 0.000273 1560.000000 -0.000033 -0.002250 0.004114 -18174 1 0.000199 1560.000000 -0.000684 0.003386 0.008530 -18175 1 0.000197 1560.000000 0.000563 0.001697 0.004692 -18176 1 0.000208 1560.000000 -0.001226 -0.001598 0.000913 -18177 1 0.000216 1560.000000 0.001535 0.001866 0.005335 -18178 1 0.000220 1560.000000 -0.000043 0.001890 0.007342 -18179 1 0.000215 1560.000000 -0.001087 -0.001628 0.005240 -18180 1 0.000193 1560.000000 0.001196 0.002534 0.009015 -18181 1 0.000265 1560.000000 0.000192 0.000615 0.007224 -18182 1 0.000197 1560.000000 -0.000348 0.003113 0.002426 -18183 1 0.000221 1560.000000 -0.001798 -0.002271 0.008315 -18184 1 0.000242 1560.000000 -0.003260 0.001934 0.002342 -18185 1 0.000211 1560.000000 0.000417 0.001168 0.007490 -18186 1 0.000246 1560.000000 0.003357 0.001522 0.005574 -18187 1 0.000192 1560.000000 -0.002323 0.000136 0.009172 -18188 1 0.000236 1560.000000 -0.002321 -0.001524 0.003392 -18189 1 0.000259 1560.000000 0.000644 0.002294 0.001422 -18190 1 0.000248 1560.000000 0.000932 -0.000932 0.000136 -18191 1 0.000204 1560.000000 0.000020 -0.003734 0.000719 -18192 1 0.000214 1560.000000 -0.001955 -0.001947 0.000175 -18193 1 0.000229 1560.000000 0.001594 0.000370 0.004223 -18194 1 0.000270 1560.000000 0.001197 0.001764 0.003733 -18195 1 0.000245 1560.000000 -0.000186 0.002758 0.005785 -18196 1 0.000206 1560.000000 -0.001697 -0.000547 0.003125 -18197 1 0.000215 1560.000000 -0.000591 0.002528 0.006409 -18198 1 0.000220 1560.000000 -0.001552 -0.002821 0.002948 -18199 1 0.000212 1560.000000 0.000016 -0.003845 0.005690 -18200 1 0.000198 1560.000000 0.001494 -0.003373 0.008681 -18201 1 0.000222 1560.000000 -0.003099 -0.000287 0.006832 -18202 1 0.000201 1560.000000 0.001052 -0.000644 0.004236 -18203 1 0.000253 1560.000000 -0.003474 -0.001331 0.006899 -18204 1 0.000247 1560.000000 0.001047 0.003269 0.001766 -18205 1 0.000208 1560.000000 -0.002066 -0.002963 0.006438 -18206 1 0.000260 1560.000000 0.003391 -0.000462 0.002038 -18207 1 0.000218 1560.000000 -0.002437 0.002415 0.000590 -18208 1 0.000273 1560.000000 0.001084 0.001941 0.009186 -18209 1 0.000221 1560.000000 0.000305 -0.003757 0.001938 -18210 1 0.000211 1560.000000 0.001437 0.001484 0.007081 -18211 1 0.000233 1560.000000 0.002455 -0.002931 0.005857 -18212 1 0.000205 1560.000000 0.001572 -0.001723 0.003787 -18213 1 0.000197 1560.000000 0.000084 -0.000579 0.003371 -18214 1 0.000216 1560.000000 0.001030 0.000162 0.006123 -18215 1 0.000195 1560.000000 0.001974 -0.002333 0.003533 -18216 1 0.000246 1560.000000 0.003702 -0.000806 0.006045 -18217 1 0.000201 1560.000000 0.002193 0.000942 0.005378 -18218 1 0.000225 1560.000000 -0.000229 -0.001041 0.007532 -18219 1 0.000287 1560.000000 -0.001325 0.003578 0.003975 -18220 1 0.000242 1560.000000 0.000257 0.002573 0.001666 -18221 1 0.000283 1560.000000 0.003290 0.001926 0.003469 -18222 1 0.000274 1560.000000 0.000032 -0.003816 0.007440 -18223 1 0.000245 1560.000000 0.001196 -0.000713 0.009818 -18224 1 0.000211 1560.000000 -0.000234 0.003812 0.001388 -18225 1 0.000196 1560.000000 0.000020 -0.000329 0.007407 -18226 1 0.000222 1560.000000 0.001378 -0.000897 0.004557 -18227 1 0.000238 1560.000000 -0.000031 0.002478 0.002660 -18228 1 0.000214 1560.000000 -0.001513 0.002396 0.009368 -18229 1 0.000208 1560.000000 0.002975 -0.001638 0.004188 -18230 1 0.000209 1560.000000 0.001452 0.001647 0.002031 -18231 1 0.000192 1560.000000 -0.001420 0.000955 0.004980 -18232 1 0.000194 1560.000000 -0.000712 -0.003284 0.000192 -18233 1 0.000251 1560.000000 0.001807 0.000578 0.004533 -18234 1 0.000284 1560.000000 -0.001330 0.002926 0.003964 -18235 1 0.000226 1560.000000 0.000574 -0.000733 0.004012 -18236 1 0.000197 1560.000000 -0.001931 -0.000325 0.000648 -18237 1 0.000193 1560.000000 -0.000993 -0.002016 0.005140 -18238 1 0.000198 1560.000000 0.002348 -0.000605 0.002992 -18239 1 0.000199 1560.000000 -0.002212 0.001487 0.008567 -18240 1 0.000239 1560.000000 -0.003662 -0.000666 0.003577 -18241 1 0.000246 1560.000000 0.001364 -0.001374 0.007450 -18242 1 0.000288 1560.000000 -0.002653 0.002250 0.009362 -18243 1 0.000233 1560.000000 0.002201 -0.000713 0.008876 -18244 1 0.000212 1560.000000 0.001417 0.003206 0.003069 -18245 1 0.000271 1560.000000 -0.001078 -0.002080 0.001601 -18246 1 0.000235 1560.000000 0.000519 0.003240 0.004764 -18247 1 0.000221 1560.000000 -0.001888 0.001383 0.007872 -18248 1 0.000246 1560.000000 0.002491 0.001786 0.006915 -18249 1 0.000283 1560.000000 0.002192 0.000785 0.009157 -18250 1 0.000283 1560.000000 0.001840 0.002001 0.008066 -18251 1 0.000254 1560.000000 -0.001351 -0.002767 0.001659 -18252 1 0.000283 1560.000000 0.003770 -0.000687 0.008070 -18253 1 0.000210 1560.000000 -0.003318 -0.000674 0.003141 -18254 1 0.000262 1560.000000 -0.001285 0.001390 0.009839 -18255 1 0.000230 1560.000000 0.002281 0.002392 0.001537 -18256 1 0.000232 1560.000000 -0.000792 -0.001792 0.005830 -18257 1 0.000271 1560.000000 0.000162 0.003669 0.009810 -18258 1 0.000255 1560.000000 0.002836 -0.000150 0.000476 -18259 1 0.000219 1560.000000 0.000610 0.003108 0.002478 -18260 1 0.000259 1560.000000 0.001471 -0.001361 0.000213 -18261 1 0.000238 1560.000000 0.000048 0.002688 0.006906 -18262 1 0.000207 1560.000000 -0.000157 -0.003149 0.003612 -18263 1 0.000271 1560.000000 -0.001346 0.002975 0.002555 -18264 1 0.000218 1560.000000 -0.000676 -0.000693 0.003619 -18265 1 0.000219 1560.000000 -0.000703 0.002973 0.002781 -18266 1 0.000239 1560.000000 -0.000955 0.003438 0.005444 -18267 1 0.000213 1560.000000 -0.001232 0.000805 0.005617 -18268 1 0.000262 1560.000000 0.002280 -0.001657 0.004594 -18269 1 0.000250 1560.000000 -0.000971 0.001700 0.007845 -18270 1 0.000219 1560.000000 -0.002663 -0.002718 0.008334 -18271 1 0.000236 1560.000000 0.002332 -0.002672 0.007315 -18272 1 0.000216 1560.000000 -0.002608 -0.000139 0.005072 -18273 1 0.000227 1560.000000 0.003791 -0.000561 0.000628 -18274 1 0.000199 1560.000000 -0.000841 -0.002599 0.003466 -18275 1 0.000207 1560.000000 -0.000896 0.003215 0.001849 -18276 1 0.000265 1560.000000 -0.001078 -0.001995 0.008182 -18277 1 0.000218 1560.000000 0.002082 -0.003032 0.000513 -18278 1 0.000232 1560.000000 0.000638 -0.002738 0.007926 -18279 1 0.000224 1560.000000 0.001966 0.002286 0.006321 -18280 1 0.000217 1560.000000 0.000162 -0.002734 0.004284 -18281 1 0.000193 1560.000000 -0.001451 0.002340 0.001830 -18282 1 0.000195 1560.000000 -0.001871 -0.000775 0.003469 -18283 1 0.000218 1560.000000 -0.001944 0.002633 0.004302 -18284 1 0.000266 1560.000000 -0.002409 0.000273 0.004775 -18285 1 0.000282 1560.000000 0.002978 0.000093 0.006055 -18286 1 0.000225 1560.000000 0.001686 -0.002780 0.008913 -18287 1 0.000231 1560.000000 -0.002377 0.002516 0.003154 -18288 1 0.000205 1560.000000 -0.001256 0.001755 0.000351 -18289 1 0.000201 1560.000000 -0.001887 0.000927 0.006365 -18290 1 0.000212 1560.000000 0.003210 0.001702 0.009516 -18291 1 0.000220 1560.000000 0.003472 -0.001210 0.005907 -18292 1 0.000249 1560.000000 0.001806 -0.000295 0.000509 -18293 1 0.000212 1560.000000 -0.000817 -0.001154 0.003918 -18294 1 0.000194 1560.000000 0.003823 0.000252 0.000141 -18295 1 0.000203 1560.000000 -0.002869 0.002156 0.007400 -18296 1 0.000231 1560.000000 0.000902 0.002012 0.004868 -18297 1 0.000279 1560.000000 -0.002477 -0.000588 0.009077 -18298 1 0.000244 1560.000000 -0.001398 -0.002307 0.001439 -18299 1 0.000237 1560.000000 -0.003339 -0.001924 0.000340 -18300 1 0.000247 1560.000000 0.000481 0.003782 0.004486 -18301 1 0.000218 1560.000000 0.000970 0.002492 0.006749 -18302 1 0.000259 1560.000000 0.000327 0.002669 0.009047 -18303 1 0.000207 1560.000000 0.003700 -0.000527 0.005565 -18304 1 0.000215 1560.000000 0.000095 -0.001238 0.001087 -18305 1 0.000202 1560.000000 0.002431 -0.001195 0.001226 -18306 1 0.000208 1560.000000 0.001542 -0.002723 0.005817 -18307 1 0.000264 1560.000000 0.003628 -0.001031 0.006372 -18308 1 0.000192 1560.000000 -0.002288 0.000666 0.007289 -18309 1 0.000197 1560.000000 0.002611 0.000227 0.002815 -18310 1 0.000211 1560.000000 -0.002378 0.000328 0.004231 -18311 1 0.000229 1560.000000 0.000992 -0.002264 0.002735 -18312 1 0.000193 1560.000000 0.002919 0.001077 0.001840 -18313 1 0.000197 1560.000000 -0.002033 0.002474 0.007540 -18314 1 0.000210 1560.000000 0.003483 0.001635 0.009537 -18315 1 0.000236 1560.000000 -0.003458 -0.000579 0.007919 -18316 1 0.000273 1560.000000 -0.001083 -0.001308 0.007183 -18317 1 0.000199 1560.000000 0.002540 -0.001325 0.006162 -18318 1 0.000209 1560.000000 0.000270 -0.002765 0.009312 -18319 1 0.000223 1560.000000 -0.002192 -0.002477 0.005429 -18320 1 0.000282 1560.000000 -0.001824 0.003379 0.006905 -18321 1 0.000273 1560.000000 0.001077 -0.002886 0.007267 -18322 1 0.000258 1560.000000 0.002624 0.000108 0.004353 -18323 1 0.000258 1560.000000 0.000150 0.001527 0.003684 -18324 1 0.000195 1560.000000 0.002794 0.001488 0.002469 -18325 1 0.000213 1560.000000 0.001798 -0.002088 0.004870 -18326 1 0.000213 1560.000000 -0.000666 -0.002606 0.005311 -18327 1 0.000197 1560.000000 0.001412 0.001262 0.001483 -18328 1 0.000195 1560.000000 0.000015 -0.003842 0.002800 -18329 1 0.000209 1560.000000 -0.001214 0.000304 0.000905 -18330 1 0.000197 1560.000000 0.000397 -0.001674 0.004828 -18331 1 0.000214 1560.000000 -0.002511 0.001807 0.009516 -18332 1 0.000214 1560.000000 0.003763 0.000709 0.005023 -18333 1 0.000225 1560.000000 0.001554 -0.002929 0.004477 -18334 1 0.000213 1560.000000 -0.003387 -0.001061 0.006420 -18335 1 0.000259 1560.000000 0.001795 0.002865 0.004416 -18336 1 0.000246 1560.000000 -0.000903 -0.002706 0.002291 -18337 1 0.000261 1560.000000 -0.000436 -0.000958 0.008335 -18338 1 0.000276 1560.000000 -0.000451 0.002786 0.002218 -18339 1 0.000202 1560.000000 0.003467 0.001584 0.005137 -18340 1 0.000193 1560.000000 -0.000771 0.001099 0.000299 -18341 1 0.000281 1560.000000 0.000056 0.003076 0.002059 -18342 1 0.000241 1560.000000 -0.002936 0.000831 0.003069 -18343 1 0.000203 1560.000000 -0.000188 -0.001474 0.005507 -18344 1 0.000224 1560.000000 -0.000130 -0.003012 0.008851 -18345 1 0.000212 1560.000000 -0.002431 0.000242 0.005416 -18346 1 0.000216 1560.000000 0.003669 0.000944 0.009097 -18347 1 0.000195 1560.000000 0.002833 -0.002390 0.003521 -18348 1 0.000229 1560.000000 -0.002258 -0.000471 0.005519 -18349 1 0.000267 1560.000000 -0.002873 0.000191 0.001611 -18350 1 0.000227 1560.000000 0.000428 0.002249 0.000587 -18351 1 0.000209 1560.000000 0.002979 0.001864 0.008406 -18352 1 0.000260 1560.000000 -0.002461 0.002864 0.006728 -18353 1 0.000269 1560.000000 0.002747 0.000504 0.004715 -18354 1 0.000232 1560.000000 -0.002411 -0.000862 0.002971 -18355 1 0.000222 1560.000000 0.003345 -0.001157 0.006792 -18356 1 0.000243 1560.000000 -0.001876 0.001821 0.002425 -18357 1 0.000207 1560.000000 0.000534 -0.000309 0.002760 -18358 1 0.000287 1560.000000 -0.002223 0.001588 0.009854 -18359 1 0.000225 1560.000000 0.001093 -0.001975 0.005913 -18360 1 0.000196 1560.000000 0.002879 0.000905 0.004428 -18361 1 0.000224 1560.000000 0.001137 -0.001472 0.003160 -18362 1 0.000263 1560.000000 0.000801 0.002993 0.004809 -18363 1 0.000271 1560.000000 -0.001592 -0.001223 0.000204 -18364 1 0.000197 1560.000000 -0.001547 -0.001296 0.000525 -18365 1 0.000206 1560.000000 0.002998 -0.000277 0.001010 -18366 1 0.000229 1560.000000 -0.000547 -0.003197 0.000537 -18367 1 0.000193 1560.000000 -0.000305 0.000070 0.008161 -18368 1 0.000283 1560.000000 -0.000784 -0.003775 0.001525 -18369 1 0.000268 1560.000000 -0.001626 -0.000491 0.008429 -18370 1 0.000205 1560.000000 0.002133 0.002593 0.003849 -18371 1 0.000238 1560.000000 0.001453 -0.003210 0.005625 -18372 1 0.000193 1560.000000 0.001151 -0.000622 0.005769 -18373 1 0.000230 1560.000000 0.000822 -0.002819 0.006766 -18374 1 0.000218 1560.000000 0.001616 -0.002365 0.003571 -18375 1 0.000273 1560.000000 0.002137 0.002618 0.003235 -18376 1 0.000196 1560.000000 0.002347 0.000369 0.007933 -18377 1 0.000224 1560.000000 -0.000611 0.003766 0.000722 -18378 1 0.000210 1560.000000 0.000557 -0.000660 0.003026 -18379 1 0.000281 1560.000000 0.002764 0.001771 0.007771 -18380 1 0.000207 1560.000000 -0.002542 -0.000974 0.002788 -18381 1 0.000222 1560.000000 0.002296 0.002138 0.005608 -18382 1 0.000210 1560.000000 0.002544 -0.002324 0.002542 -18383 1 0.000231 1560.000000 0.002632 -0.001905 0.007152 -18384 1 0.000284 1560.000000 0.000343 -0.003838 0.006271 -18385 1 0.000227 1560.000000 0.001202 -0.002069 0.006130 -18386 1 0.000251 1560.000000 -0.003661 0.000243 0.000628 -18387 1 0.000249 1560.000000 -0.002337 -0.001801 0.006241 -18388 1 0.000232 1560.000000 -0.002892 -0.001805 0.003211 -18389 1 0.000203 1560.000000 -0.002260 0.001061 0.006276 -18390 1 0.000282 1560.000000 -0.002613 -0.001008 0.008293 -18391 1 0.000219 1560.000000 0.001631 0.000927 0.008827 -18392 1 0.000252 1560.000000 -0.002993 0.002367 0.004227 -18393 1 0.000203 1560.000000 -0.000540 -0.002074 0.004382 -18394 1 0.000216 1560.000000 0.001002 0.001590 0.003288 -18395 1 0.000201 1560.000000 -0.001205 -0.000251 0.000598 -18396 1 0.000250 1560.000000 0.003475 -0.001484 0.005475 -18397 1 0.000206 1560.000000 -0.002535 0.002124 0.007102 -18398 1 0.000208 1560.000000 0.001682 -0.002281 0.004875 -18399 1 0.000278 1560.000000 0.001221 -0.000965 0.003805 -18400 1 0.000239 1560.000000 -0.002385 -0.001607 0.001449 -18401 1 0.000218 1560.000000 -0.003260 0.000802 0.002444 -18402 1 0.000201 1560.000000 -0.001127 0.003391 0.001199 -18403 1 0.000201 1560.000000 -0.001275 -0.002751 0.002521 -18404 1 0.000217 1560.000000 0.002095 -0.001912 0.002805 -18405 1 0.000243 1560.000000 -0.001192 0.000715 0.003426 -18406 1 0.000288 1560.000000 -0.002636 -0.001848 0.008303 -18407 1 0.000245 1560.000000 -0.002176 -0.000765 0.000135 -18408 1 0.000287 1560.000000 0.002713 -0.002312 0.009712 -18409 1 0.000202 1560.000000 0.001947 -0.001134 0.004976 -18410 1 0.000219 1560.000000 0.000915 0.002403 0.004127 -18411 1 0.000210 1560.000000 -0.000622 0.003116 0.004951 -18412 1 0.000263 1560.000000 -0.003536 0.000841 0.001863 -18413 1 0.000211 1560.000000 0.002188 0.002288 0.007607 -18414 1 0.000237 1560.000000 0.002499 -0.000331 0.001020 -18415 1 0.000195 1560.000000 0.001833 -0.003002 0.001538 -18416 1 0.000232 1560.000000 -0.002525 0.001415 0.009810 -18417 1 0.000196 1560.000000 -0.000890 0.001264 0.003745 -18418 1 0.000213 1560.000000 0.001368 -0.001037 0.009390 -18419 1 0.000220 1560.000000 -0.003420 0.000057 0.006091 -18420 1 0.000217 1560.000000 -0.002462 -0.001545 0.000291 -18421 1 0.000203 1560.000000 -0.001752 -0.002937 0.005653 -18422 1 0.000259 1560.000000 0.001628 -0.000989 0.007368 -18423 1 0.000272 1560.000000 0.002038 -0.001548 0.003885 -18424 1 0.000275 1560.000000 -0.000349 0.003121 0.000531 -18425 1 0.000274 1560.000000 -0.001012 0.003129 0.003799 -18426 1 0.000199 1560.000000 -0.000325 -0.001619 0.008019 -18427 1 0.000209 1560.000000 -0.000692 0.000120 0.000589 -18428 1 0.000286 1560.000000 -0.003352 -0.001768 0.007989 -18429 1 0.000240 1560.000000 0.002028 -0.002920 0.000243 -18430 1 0.000246 1560.000000 -0.000134 -0.001754 0.003103 -18431 1 0.000196 1560.000000 0.000332 0.001129 0.001987 -18432 1 0.000235 1560.000000 0.001796 0.000166 0.002279 -18433 1 0.000247 1560.000000 0.001347 0.002236 0.006837 -18434 1 0.000214 1560.000000 -0.000800 -0.001673 0.005631 -18435 1 0.000278 1560.000000 -0.002209 -0.001192 0.009749 -18436 1 0.000238 1560.000000 -0.000495 0.001756 0.006903 -18437 1 0.000229 1560.000000 0.000735 0.003772 0.007124 -18438 1 0.000278 1560.000000 0.001487 -0.002285 0.005828 -18439 1 0.000228 1560.000000 0.003076 0.001674 0.007343 -18440 1 0.000240 1560.000000 0.000893 0.002818 0.009821 -18441 1 0.000287 1560.000000 -0.002643 -0.002709 0.001099 -18442 1 0.000282 1560.000000 0.000454 0.002829 0.004404 -18443 1 0.000251 1560.000000 0.001063 -0.001803 0.001475 -18444 1 0.000218 1560.000000 -0.001386 -0.003485 0.001801 -18445 1 0.000218 1560.000000 0.001525 -0.000969 0.002309 -18446 1 0.000217 1560.000000 -0.000658 0.002211 0.000780 -18447 1 0.000212 1560.000000 0.002687 0.002650 0.003297 -18448 1 0.000280 1560.000000 -0.001715 0.002392 0.001204 -18449 1 0.000211 1560.000000 0.002346 0.001574 0.008419 -18450 1 0.000284 1560.000000 0.000999 0.003712 0.005534 -18451 1 0.000235 1560.000000 -0.003161 -0.001124 0.008663 -18452 1 0.000256 1560.000000 -0.001594 -0.000132 0.000145 -18453 1 0.000201 1560.000000 -0.001695 -0.003381 0.006334 -18454 1 0.000251 1560.000000 0.001236 -0.000114 0.005250 -18455 1 0.000221 1560.000000 -0.000235 -0.002134 0.001650 -18456 1 0.000273 1560.000000 -0.001903 0.003221 0.008288 -18457 1 0.000275 1560.000000 0.001000 -0.003277 0.001094 -18458 1 0.000226 1560.000000 0.002055 -0.000471 0.004026 -18459 1 0.000227 1560.000000 0.000408 -0.003831 0.008686 -18460 1 0.000222 1560.000000 -0.001171 0.003183 0.005948 -18461 1 0.000194 1560.000000 0.000546 0.001154 0.003344 -18462 1 0.000217 1560.000000 -0.000403 -0.002984 0.002329 -18463 1 0.000266 1560.000000 -0.000798 -0.000516 0.009088 -18464 1 0.000196 1560.000000 0.000687 0.000996 0.009267 -18465 1 0.000193 1560.000000 -0.003176 0.001301 0.004953 -18466 1 0.000239 1560.000000 -0.003575 0.001398 0.004014 -18467 1 0.000200 1560.000000 0.003237 -0.000298 0.004720 -18468 1 0.000220 1560.000000 -0.001073 0.003266 0.006940 -18469 1 0.000243 1560.000000 -0.000364 -0.001678 0.008813 -18470 1 0.000249 1560.000000 -0.002395 -0.001544 0.000822 -18471 1 0.000203 1560.000000 0.000364 -0.003428 0.000437 -18472 1 0.000236 1560.000000 0.000601 0.002251 0.003538 -18473 1 0.000265 1560.000000 -0.001645 -0.000907 0.001892 -18474 1 0.000240 1560.000000 -0.003379 -0.000968 0.005651 -18475 1 0.000269 1560.000000 0.002112 -0.002410 0.004129 -18476 1 0.000192 1560.000000 -0.000931 -0.001540 0.009270 -18477 1 0.000230 1560.000000 -0.002126 -0.003197 0.007271 -18478 1 0.000239 1560.000000 0.003307 -0.001131 0.006511 -18479 1 0.000261 1560.000000 0.000802 0.003336 0.000938 -18480 1 0.000229 1560.000000 -0.002686 0.000062 0.008248 -18481 1 0.000203 1560.000000 0.001690 -0.000434 0.006476 -18482 1 0.000260 1560.000000 -0.002704 0.002291 0.009017 -18483 1 0.000220 1560.000000 -0.000707 -0.001851 0.000535 -18484 1 0.000210 1560.000000 0.003055 -0.000367 0.003265 -18485 1 0.000273 1560.000000 0.001053 0.003145 0.006462 -18486 1 0.000284 1560.000000 -0.003616 -0.001233 0.005933 -18487 1 0.000203 1560.000000 -0.001837 -0.002453 0.000827 -18488 1 0.000266 1560.000000 0.002671 -0.002185 0.006026 -18489 1 0.000255 1560.000000 0.003124 -0.000151 0.002329 -18490 1 0.000257 1560.000000 0.000806 0.003467 0.003983 -18491 1 0.000277 1560.000000 -0.001886 -0.003346 0.005260 -18492 1 0.000286 1560.000000 -0.002197 -0.003115 0.003060 -18493 1 0.000255 1560.000000 0.001024 -0.001571 0.004647 -18494 1 0.000216 1560.000000 -0.000842 -0.002343 0.006957 -18495 1 0.000258 1560.000000 0.001380 0.003155 0.009139 -18496 1 0.000283 1560.000000 0.003541 0.000242 0.008221 -18497 1 0.000205 1560.000000 0.003369 0.001363 0.000758 -18498 1 0.000267 1560.000000 -0.002015 -0.000238 0.009150 -18499 1 0.000282 1560.000000 -0.003271 -0.001899 0.001764 -18500 1 0.000210 1560.000000 -0.000602 0.001717 0.005134 -18501 1 0.000226 1560.000000 0.001961 0.003212 0.008456 -18502 1 0.000198 1560.000000 0.001586 -0.003470 0.009326 -18503 1 0.000240 1560.000000 0.000927 -0.002290 0.008087 -18504 1 0.000219 1560.000000 0.003257 -0.001592 0.008755 -18505 1 0.000221 1560.000000 -0.001551 -0.003523 0.009685 -18506 1 0.000280 1560.000000 0.000883 -0.000257 0.009801 -18507 1 0.000276 1560.000000 -0.002971 -0.001511 0.001769 -18508 1 0.000200 1560.000000 -0.000977 -0.002646 0.000835 -18509 1 0.000263 1560.000000 0.003479 0.001405 0.004334 -18510 1 0.000266 1560.000000 -0.002210 -0.001486 0.006720 -18511 1 0.000282 1560.000000 0.001989 -0.000024 0.003914 -18512 1 0.000210 1560.000000 -0.001316 0.002211 0.005050 -18513 1 0.000206 1560.000000 -0.001285 0.001602 0.007915 -18514 1 0.000226 1560.000000 -0.002279 -0.001201 0.003169 -18515 1 0.000280 1560.000000 -0.002891 0.001895 0.004517 -18516 1 0.000197 1560.000000 -0.001690 0.001457 0.002246 -18517 1 0.000256 1560.000000 -0.001407 0.000062 0.005267 -18518 1 0.000231 1560.000000 0.001544 -0.002995 0.004249 -18519 1 0.000227 1560.000000 -0.001115 -0.001180 0.001711 -18520 1 0.000247 1560.000000 -0.002157 -0.001640 0.009266 -18521 1 0.000210 1560.000000 0.003492 -0.001617 0.006087 -18522 1 0.000225 1560.000000 -0.002900 0.002295 0.002151 -18523 1 0.000257 1560.000000 0.003649 -0.001236 0.001896 -18524 1 0.000202 1560.000000 0.000437 -0.002797 0.004167 -18525 1 0.000216 1560.000000 0.000209 -0.003790 0.005253 -18526 1 0.000216 1560.000000 -0.000128 0.002695 0.004180 -18527 1 0.000219 1560.000000 -0.001487 0.000585 0.005195 -18528 1 0.000196 1560.000000 0.002760 0.001622 0.003159 -18529 1 0.000222 1560.000000 -0.001379 0.002735 0.005524 -18530 1 0.000204 1560.000000 0.000168 -0.002734 0.007136 -18531 1 0.000209 1560.000000 -0.000564 0.001642 0.007699 -18532 1 0.000224 1560.000000 -0.001234 -0.002571 0.004346 -18533 1 0.000223 1560.000000 0.000857 -0.002776 0.007195 -18534 1 0.000194 1560.000000 0.002645 0.000788 0.003732 -18535 1 0.000219 1560.000000 -0.003653 0.000842 0.004959 -18536 1 0.000269 1560.000000 -0.000613 -0.003800 0.003868 -18537 1 0.000208 1560.000000 -0.000654 -0.001917 0.009365 -18538 1 0.000195 1560.000000 0.002610 0.000491 0.009348 -18539 1 0.000213 1560.000000 0.001289 -0.000986 0.006332 -18540 1 0.000258 1560.000000 0.002546 0.001124 0.001195 -18541 1 0.000226 1560.000000 -0.003210 0.000567 0.008496 -18542 1 0.000274 1560.000000 0.003416 0.001430 0.001254 -18543 1 0.000219 1560.000000 -0.001093 -0.000941 0.003586 -18544 1 0.000251 1560.000000 0.001633 0.002349 0.009201 -18545 1 0.000272 1560.000000 0.001098 0.003031 0.003040 -18546 1 0.000195 1560.000000 0.000070 -0.000691 0.009552 -18547 1 0.000204 1560.000000 -0.001659 -0.001267 0.008218 -18548 1 0.000244 1560.000000 -0.003022 -0.001144 0.000156 -18549 1 0.000199 1560.000000 0.001636 -0.001792 0.004804 -18550 1 0.000255 1560.000000 -0.001568 0.000697 0.008163 -18551 1 0.000222 1560.000000 0.000970 -0.000829 0.005353 -18552 1 0.000242 1560.000000 -0.003778 -0.000686 0.006759 -18553 1 0.000215 1560.000000 0.001778 -0.000101 0.008248 -18554 1 0.000231 1560.000000 -0.002554 -0.002128 0.008453 -18555 1 0.000227 1560.000000 0.001711 -0.002415 0.007446 -18556 1 0.000272 1560.000000 -0.002000 0.001022 0.002541 -18557 1 0.000228 1560.000000 0.002587 -0.001904 0.000678 -18558 1 0.000214 1560.000000 0.003087 0.000010 0.005656 -18559 1 0.000242 1560.000000 -0.003124 -0.001721 0.002745 -18560 1 0.000261 1560.000000 -0.002493 -0.000422 0.003646 -18561 1 0.000280 1560.000000 0.002825 -0.000744 0.005849 -18562 1 0.000202 1560.000000 -0.000204 -0.002618 0.002277 -18563 1 0.000224 1560.000000 -0.002420 -0.002339 0.002441 -18564 1 0.000242 1560.000000 0.002824 0.001270 0.009503 -18565 1 0.000217 1560.000000 0.001310 0.000035 0.000577 -18566 1 0.000213 1560.000000 -0.001346 0.000682 0.003925 -18567 1 0.000276 1560.000000 0.003810 0.000370 0.005043 -18568 1 0.000218 1560.000000 0.002603 0.002837 0.004855 -18569 1 0.000213 1560.000000 -0.002103 -0.002116 0.001745 -18570 1 0.000224 1560.000000 0.001055 0.000139 0.005858 -18571 1 0.000251 1560.000000 -0.002577 0.000803 0.000859 -18572 1 0.000204 1560.000000 -0.003153 0.000188 0.000145 -18573 1 0.000211 1560.000000 0.000925 0.001382 0.008092 -18574 1 0.000226 1560.000000 0.002144 -0.002666 0.004104 -18575 1 0.000231 1560.000000 0.001531 0.000013 0.008958 -18576 1 0.000265 1560.000000 0.002940 -0.001584 0.009746 -18577 1 0.000229 1560.000000 -0.001966 -0.002482 0.004706 -18578 1 0.000209 1560.000000 0.003245 -0.002052 0.008476 -18579 1 0.000251 1560.000000 0.003091 0.002289 0.005296 -18580 1 0.000218 1560.000000 0.003610 0.001247 0.002622 -18581 1 0.000209 1560.000000 0.000221 -0.000971 0.006161 -18582 1 0.000243 1560.000000 -0.001022 -0.002358 0.001160 -18583 1 0.000267 1560.000000 0.000734 0.003616 0.002516 -18584 1 0.000231 1560.000000 -0.002171 0.002066 0.009679 -18585 1 0.000240 1560.000000 -0.001087 -0.000196 0.008037 -18586 1 0.000208 1560.000000 0.000615 -0.000612 0.007740 -18587 1 0.000259 1560.000000 0.001937 -0.000287 0.005784 -18588 1 0.000276 1560.000000 0.003330 0.001821 0.007254 -18589 1 0.000244 1560.000000 -0.000330 0.001577 0.000429 -18590 1 0.000202 1560.000000 0.001810 -0.000761 0.001154 -18591 1 0.000201 1560.000000 0.003094 -0.001053 0.001772 -18592 1 0.000277 1560.000000 -0.001002 -0.001707 0.006914 -18593 1 0.000197 1560.000000 0.000449 -0.002695 0.003521 -18594 1 0.000198 1560.000000 0.002298 -0.000069 0.004086 -18595 1 0.000275 1560.000000 -0.003475 -0.001532 0.000213 -18596 1 0.000212 1560.000000 0.002527 0.000792 0.006288 -18597 1 0.000260 1560.000000 0.001707 -0.003455 0.008496 -18598 1 0.000210 1560.000000 -0.000620 -0.002304 0.000911 -18599 1 0.000254 1560.000000 -0.002504 -0.001094 0.000857 -18600 1 0.000194 1560.000000 -0.001023 -0.003256 0.002190 -18601 1 0.000220 1560.000000 -0.001631 0.002001 0.009811 -18602 1 0.000194 1560.000000 0.003722 -0.000834 0.002755 -18603 1 0.000283 1560.000000 0.002279 -0.001219 0.007401 -18604 1 0.000262 1560.000000 -0.000793 0.002090 0.006025 -18605 1 0.000214 1560.000000 0.001213 -0.001299 0.000136 -18606 1 0.000209 1560.000000 -0.000808 0.000569 0.002338 -18607 1 0.000239 1560.000000 0.003726 -0.000648 0.005763 -18608 1 0.000246 1560.000000 0.001502 0.001772 0.007866 -18609 1 0.000240 1560.000000 -0.000187 0.001288 0.000420 -18610 1 0.000230 1560.000000 -0.000608 -0.002695 0.006502 -18611 1 0.000200 1560.000000 0.002598 -0.002795 0.002248 -18612 1 0.000226 1560.000000 -0.000456 0.002648 0.001608 -18613 1 0.000253 1560.000000 -0.002700 0.002675 0.002226 -18614 1 0.000224 1560.000000 -0.002071 -0.002506 0.007003 -18615 1 0.000260 1560.000000 0.002954 0.001265 0.005611 -18616 1 0.000194 1560.000000 -0.000165 -0.000960 0.008716 -18617 1 0.000251 1560.000000 0.002025 -0.000635 0.006074 -18618 1 0.000270 1560.000000 -0.000810 0.001861 0.005057 -18619 1 0.000268 1560.000000 -0.000611 -0.001115 0.008486 -18620 1 0.000216 1560.000000 0.002435 -0.001585 0.002137 -18621 1 0.000208 1560.000000 0.000767 -0.001063 0.009801 -18622 1 0.000246 1560.000000 0.003499 -0.001436 0.003572 -18623 1 0.000199 1560.000000 0.001844 0.002333 0.008456 -18624 1 0.000273 1560.000000 0.002531 0.002796 0.000868 -18625 1 0.000200 1560.000000 -0.001301 -0.000062 0.000482 -18626 1 0.000232 1560.000000 0.000620 -0.002791 0.005584 -18627 1 0.000203 1560.000000 -0.001934 0.001950 0.005434 -18628 1 0.000270 1560.000000 -0.001149 -0.000575 0.006910 -18629 1 0.000221 1560.000000 -0.001672 -0.003457 0.000362 -18630 1 0.000259 1560.000000 0.002056 0.002770 0.001699 -18631 1 0.000246 1560.000000 -0.003577 0.000260 0.003883 -18632 1 0.000193 1560.000000 -0.003181 0.000001 0.002917 -18633 1 0.000284 1560.000000 -0.001161 0.001872 0.006687 -18634 1 0.000216 1560.000000 -0.003269 0.002034 0.004645 -18635 1 0.000198 1560.000000 -0.002413 0.002876 0.002714 -18636 1 0.000209 1560.000000 0.000464 -0.003143 0.006927 -18637 1 0.000264 1560.000000 -0.002032 -0.002461 0.001859 -18638 1 0.000196 1560.000000 -0.000355 -0.001825 0.008255 -18639 1 0.000199 1560.000000 0.000310 0.000095 0.009140 -18640 1 0.000199 1560.000000 -0.001765 0.002125 0.007803 -18641 1 0.000210 1560.000000 -0.000916 -0.002954 0.004856 -18642 1 0.000227 1560.000000 -0.001644 -0.000238 0.007017 -18643 1 0.000207 1560.000000 0.001580 -0.000306 0.009386 -18644 1 0.000221 1560.000000 -0.000936 -0.003365 0.007043 -18645 1 0.000198 1560.000000 -0.002644 -0.001331 0.000500 -18646 1 0.000237 1560.000000 -0.002443 -0.002231 0.001848 -18647 1 0.000205 1560.000000 0.000480 -0.000313 0.002050 -18648 1 0.000265 1560.000000 -0.002846 -0.002476 0.004916 -18649 1 0.000200 1560.000000 0.003069 0.000090 0.003000 -18650 1 0.000269 1560.000000 0.000798 0.002820 0.002711 -18651 1 0.000227 1560.000000 0.001075 0.002771 0.007237 -18652 1 0.000199 1560.000000 0.002063 -0.001270 0.005430 -18653 1 0.000258 1560.000000 -0.002028 -0.000876 0.008210 -18654 1 0.000243 1560.000000 0.001451 0.000931 0.006491 -18655 1 0.000210 1560.000000 -0.000599 -0.003405 0.003793 -18656 1 0.000192 1560.000000 -0.002766 0.002053 0.005690 -18657 1 0.000231 1560.000000 -0.000106 0.000632 0.006466 -18658 1 0.000196 1560.000000 -0.000251 -0.002691 0.001676 -18659 1 0.000195 1560.000000 -0.002134 0.001578 0.005228 -18660 1 0.000263 1560.000000 -0.001977 -0.001839 0.006740 -18661 1 0.000202 1560.000000 -0.000934 -0.000341 0.006398 -18662 1 0.000241 1560.000000 -0.001521 -0.002024 0.008996 -18663 1 0.000218 1560.000000 -0.001477 -0.001481 0.008211 -18664 1 0.000234 1560.000000 -0.000043 -0.001355 0.008584 -18665 1 0.000202 1560.000000 0.000391 -0.000491 0.002180 -18666 1 0.000285 1560.000000 -0.002551 0.002796 0.005836 -18667 1 0.000223 1560.000000 -0.002519 -0.001966 0.004213 -18668 1 0.000249 1560.000000 -0.001809 0.002693 0.000454 -18669 1 0.000207 1560.000000 0.000908 0.003561 0.009475 -18670 1 0.000219 1560.000000 0.001289 -0.003208 0.003134 -18671 1 0.000281 1560.000000 0.000818 -0.003701 0.007473 -18672 1 0.000214 1560.000000 -0.001656 0.000368 0.008153 -18673 1 0.000237 1560.000000 -0.002892 -0.001361 0.005402 -18674 1 0.000241 1560.000000 -0.001894 0.000678 0.000467 -18675 1 0.000213 1560.000000 0.002442 0.001957 0.000719 -18676 1 0.000199 1560.000000 0.003278 -0.001406 0.005193 -18677 1 0.000231 1560.000000 -0.000161 0.001655 0.008272 -18678 1 0.000240 1560.000000 -0.001266 -0.003299 0.004734 -18679 1 0.000256 1560.000000 0.003083 0.002190 0.008677 -18680 1 0.000208 1560.000000 0.001858 -0.001259 0.005665 -18681 1 0.000216 1560.000000 0.003347 -0.000455 0.006969 -18682 1 0.000216 1560.000000 -0.002229 0.000449 0.008228 -18683 1 0.000217 1560.000000 0.003337 0.000510 0.002347 -18684 1 0.000277 1560.000000 -0.001113 -0.001084 0.004555 -18685 1 0.000252 1560.000000 0.000512 0.001781 0.000212 -18686 1 0.000249 1560.000000 0.002156 0.003164 0.004417 -18687 1 0.000208 1560.000000 0.001869 -0.002441 0.003158 -18688 1 0.000247 1560.000000 0.001474 0.002453 0.003468 -18689 1 0.000237 1560.000000 -0.002445 0.001837 0.007983 -18690 1 0.000217 1560.000000 -0.002985 0.000256 0.004152 -18691 1 0.000213 1560.000000 -0.002236 -0.001479 0.002612 -18692 1 0.000251 1560.000000 -0.003330 0.001727 0.007423 -18693 1 0.000269 1560.000000 0.001291 0.001885 0.008129 -18694 1 0.000200 1560.000000 0.003375 0.000760 0.006293 -18695 1 0.000264 1560.000000 -0.000463 -0.002826 0.003659 -18696 1 0.000241 1560.000000 0.000228 0.001197 0.000317 -18697 1 0.000236 1560.000000 -0.000822 -0.003067 0.007913 -18698 1 0.000261 1560.000000 -0.002061 0.002430 0.008020 -18699 1 0.000263 1560.000000 -0.003383 -0.001131 0.001881 -18700 1 0.000241 1560.000000 -0.000541 -0.001320 0.007148 -18701 1 0.000213 1560.000000 -0.002930 -0.000295 0.008052 -18702 1 0.000232 1560.000000 -0.002909 -0.002507 0.002989 -18703 1 0.000261 1560.000000 0.003707 0.000754 0.008291 -18704 1 0.000204 1560.000000 0.003407 -0.001733 0.001801 -18705 1 0.000264 1560.000000 0.003359 -0.000568 0.009110 -18706 1 0.000216 1560.000000 -0.003300 -0.000712 0.001541 -18707 1 0.000273 1560.000000 -0.001955 0.001000 0.008538 -18708 1 0.000252 1560.000000 -0.001941 -0.002861 0.001726 -18709 1 0.000243 1560.000000 0.000825 0.000841 0.006120 -18710 1 0.000225 1560.000000 -0.003673 0.000993 0.005545 -18711 1 0.000226 1560.000000 0.001463 -0.000905 0.008455 -18712 1 0.000243 1560.000000 0.000788 0.001258 0.005253 -18713 1 0.000223 1560.000000 -0.002309 -0.000989 0.008477 -18714 1 0.000210 1560.000000 -0.003397 -0.000239 0.004265 -18715 1 0.000221 1560.000000 -0.000498 0.001479 0.003728 -18716 1 0.000215 1560.000000 0.003558 -0.000946 0.003913 -18717 1 0.000216 1560.000000 0.001391 0.000092 0.009116 -18718 1 0.000200 1560.000000 -0.003786 0.000425 0.006706 -18719 1 0.000259 1560.000000 -0.001481 0.001687 0.008633 -18720 1 0.000282 1560.000000 0.002953 -0.002326 0.005055 -18721 1 0.000233 1560.000000 -0.002126 0.002466 0.002809 -18722 1 0.000234 1560.000000 0.001216 -0.001943 0.007353 -18723 1 0.000200 1560.000000 -0.000177 0.000287 0.005696 -18724 1 0.000207 1560.000000 0.000225 -0.003819 0.007018 -18725 1 0.000263 1560.000000 -0.001172 -0.001453 0.002821 -18726 1 0.000237 1560.000000 -0.000559 0.003155 0.006913 -18727 1 0.000255 1560.000000 -0.002785 -0.002139 0.004823 -18728 1 0.000271 1560.000000 0.002108 -0.001497 0.009783 -18729 1 0.000205 1560.000000 -0.003156 0.000357 0.003982 -18730 1 0.000193 1560.000000 0.000260 -0.000638 0.001307 -18731 1 0.000200 1560.000000 -0.000605 -0.002381 0.002714 -18732 1 0.000198 1560.000000 -0.002893 -0.001035 0.004229 -18733 1 0.000225 1560.000000 -0.000506 -0.000531 0.005904 -18734 1 0.000223 1560.000000 0.001490 0.001147 0.008697 -18735 1 0.000251 1560.000000 0.001362 0.002618 0.003146 -18736 1 0.000256 1560.000000 -0.002316 0.001273 0.000138 -18737 1 0.000263 1560.000000 -0.002025 0.000076 0.000160 -18738 1 0.000278 1560.000000 -0.001061 0.002328 0.008813 -18739 1 0.000240 1560.000000 0.002265 0.002814 0.006369 -18740 1 0.000222 1560.000000 0.003212 -0.000093 0.005242 -18741 1 0.000261 1560.000000 0.003460 0.001672 0.008356 -18742 1 0.000217 1560.000000 0.002348 -0.001606 0.004235 -18743 1 0.000194 1560.000000 0.002294 -0.000177 0.004251 -18744 1 0.000260 1560.000000 -0.000216 -0.002030 0.004811 -18745 1 0.000212 1560.000000 -0.000699 0.001448 0.001174 -18746 1 0.000208 1560.000000 0.002579 0.001477 0.002327 -18747 1 0.000198 1560.000000 -0.003577 -0.000812 0.000875 -18748 1 0.000240 1560.000000 -0.001075 -0.001671 0.008309 -18749 1 0.000208 1560.000000 -0.001249 0.002865 0.002811 -18750 1 0.000237 1560.000000 0.001257 0.003219 0.006299 -18751 1 0.000229 1560.000000 0.001381 -0.000405 0.003594 -18752 1 0.000203 1560.000000 -0.003155 0.000959 0.000622 -18753 1 0.000223 1560.000000 0.002684 0.001137 0.005536 -18754 1 0.000213 1560.000000 0.001773 -0.000647 0.004311 -18755 1 0.000212 1560.000000 0.001283 -0.000287 0.002258 -18756 1 0.000259 1560.000000 -0.002257 0.000178 0.007846 -18757 1 0.000218 1560.000000 -0.001572 -0.001098 0.004842 -18758 1 0.000249 1560.000000 0.001893 0.000715 0.009047 -18759 1 0.000280 1560.000000 0.003425 -0.001704 0.009810 -18760 1 0.000218 1560.000000 0.000634 0.000417 0.005577 -18761 1 0.000203 1560.000000 0.000672 -0.000011 0.000513 -18762 1 0.000195 1560.000000 -0.001330 -0.001538 0.008421 -18763 1 0.000210 1560.000000 0.002398 -0.000824 0.009037 -18764 1 0.000241 1560.000000 -0.000965 0.000005 0.001823 -18765 1 0.000227 1560.000000 -0.000144 -0.002966 0.003001 -18766 1 0.000285 1560.000000 -0.003590 0.000522 0.003586 -18767 1 0.000201 1560.000000 -0.000228 0.002351 0.008843 -18768 1 0.000248 1560.000000 -0.000529 0.003329 0.007715 -18769 1 0.000287 1560.000000 -0.001584 -0.001681 0.000729 -18770 1 0.000206 1560.000000 -0.002406 -0.001607 0.009485 -18771 1 0.000225 1560.000000 0.001222 -0.002116 0.009344 -18772 1 0.000230 1560.000000 0.001865 -0.002736 0.005143 -18773 1 0.000257 1560.000000 -0.003826 0.000472 0.000137 -18774 1 0.000229 1560.000000 -0.001617 0.002287 0.008501 -18775 1 0.000235 1560.000000 -0.001796 -0.002449 0.005297 -18776 1 0.000203 1560.000000 -0.001719 -0.001204 0.008772 -18777 1 0.000207 1560.000000 -0.000718 0.001924 0.000676 -18778 1 0.000282 1560.000000 -0.000402 -0.003532 0.000967 -18779 1 0.000230 1560.000000 0.001147 -0.002036 0.003445 -18780 1 0.000249 1560.000000 -0.000698 0.002002 0.002083 -18781 1 0.000264 1560.000000 -0.003126 -0.001565 0.004392 -18782 1 0.000287 1560.000000 -0.000613 0.003358 0.009844 -18783 1 0.000208 1560.000000 0.001434 -0.003033 0.007834 -18784 1 0.000193 1560.000000 0.001140 0.000206 0.009197 -18785 1 0.000256 1560.000000 0.001270 -0.000822 0.006842 -18786 1 0.000269 1560.000000 0.002658 -0.002167 0.006494 -18787 1 0.000231 1560.000000 -0.002208 0.002315 0.004893 -18788 1 0.000227 1560.000000 -0.001498 -0.002669 0.009298 -18789 1 0.000249 1560.000000 0.002631 -0.000456 0.001831 -18790 1 0.000254 1560.000000 -0.000684 -0.000988 0.001438 -18791 1 0.000260 1560.000000 -0.000317 -0.003406 0.004591 -18792 1 0.000210 1560.000000 0.001002 -0.000757 0.003450 -18793 1 0.000285 1560.000000 0.000640 0.001987 0.004845 -18794 1 0.000196 1560.000000 -0.003573 0.000586 0.006007 -18795 1 0.000279 1560.000000 -0.001911 -0.002662 0.003741 -18796 1 0.000279 1560.000000 0.000533 -0.003790 0.007925 -18797 1 0.000203 1560.000000 0.001844 0.001586 0.008624 -18798 1 0.000228 1560.000000 0.001583 -0.002018 0.006984 -18799 1 0.000230 1560.000000 -0.003716 -0.000988 0.003923 -18800 1 0.000245 1560.000000 -0.000542 0.002106 0.004541 -18801 1 0.000210 1560.000000 -0.003522 0.001540 0.007475 -18802 1 0.000195 1560.000000 0.000192 -0.000108 0.000922 -18803 1 0.000273 1560.000000 0.001336 -0.001191 0.001227 -18804 1 0.000246 1560.000000 -0.001812 -0.000285 0.007242 -18805 1 0.000198 1560.000000 -0.001891 0.000684 0.005334 -18806 1 0.000195 1560.000000 0.000295 -0.000869 0.001299 -18807 1 0.000262 1560.000000 -0.002595 0.001386 0.001781 -18808 1 0.000250 1560.000000 0.000050 -0.000795 0.009782 -18809 1 0.000220 1560.000000 -0.001002 0.000350 0.005287 -18810 1 0.000197 1560.000000 -0.002421 -0.002944 0.000815 -18811 1 0.000211 1560.000000 -0.000457 0.002077 0.005376 -18812 1 0.000224 1560.000000 -0.002058 0.002042 0.004488 -18813 1 0.000288 1560.000000 -0.003324 -0.001277 0.008129 -18814 1 0.000193 1560.000000 0.001228 0.001717 0.001599 -18815 1 0.000215 1560.000000 -0.002029 -0.000913 0.006755 -18816 1 0.000267 1560.000000 -0.001364 0.001364 0.004138 -18817 1 0.000247 1560.000000 -0.000017 0.002656 0.009369 -18818 1 0.000241 1560.000000 -0.002878 -0.002179 0.005737 -18819 1 0.000225 1560.000000 -0.002594 0.000793 0.003954 -18820 1 0.000247 1560.000000 -0.002188 -0.000114 0.007930 -18821 1 0.000244 1560.000000 -0.002586 0.000521 0.001826 -18822 1 0.000234 1560.000000 0.001225 0.001599 0.009802 -18823 1 0.000252 1560.000000 -0.001959 0.000847 0.003642 -18824 1 0.000257 1560.000000 -0.003635 0.001224 0.009155 -18825 1 0.000272 1560.000000 -0.000225 -0.002804 0.000138 -18826 1 0.000205 1560.000000 0.002665 0.002762 0.007656 -18827 1 0.000228 1560.000000 0.000496 -0.003621 0.001930 -18828 1 0.000234 1560.000000 -0.000987 0.003217 0.000160 -18829 1 0.000243 1560.000000 -0.000771 -0.003762 0.006171 -18830 1 0.000271 1560.000000 0.003222 0.000389 0.002131 -18831 1 0.000236 1560.000000 0.000553 0.003533 0.005183 -18832 1 0.000246 1560.000000 0.000544 0.001286 0.003085 -18833 1 0.000260 1560.000000 0.002548 -0.000008 0.000584 -18834 1 0.000200 1560.000000 -0.003839 -0.000048 0.002535 -18835 1 0.000278 1560.000000 0.001320 0.003208 0.003454 -18836 1 0.000229 1560.000000 -0.001256 0.003615 0.001688 -18837 1 0.000199 1560.000000 0.002225 0.002459 0.006935 -18838 1 0.000241 1560.000000 0.001869 -0.000751 0.009293 -18839 1 0.000213 1560.000000 -0.003396 0.000103 0.004478 -18840 1 0.000203 1560.000000 -0.000387 0.003185 0.009560 -18841 1 0.000217 1560.000000 0.001367 -0.001789 0.003090 -18842 1 0.000220 1560.000000 0.002946 -0.000726 0.003571 -18843 1 0.000262 1560.000000 -0.000426 -0.001774 0.004254 -18844 1 0.000250 1560.000000 0.001175 -0.000622 0.000729 -18845 1 0.000223 1560.000000 0.002489 0.001391 0.008087 -18846 1 0.000231 1560.000000 -0.002852 -0.001155 0.008617 -18847 1 0.000242 1560.000000 0.000614 0.002607 0.000990 -18848 1 0.000271 1560.000000 -0.000712 0.003777 0.006926 -18849 1 0.000283 1560.000000 0.001213 0.003305 0.008825 -18850 1 0.000232 1560.000000 0.002253 0.002977 0.006816 -18851 1 0.000233 1560.000000 -0.001611 -0.002345 0.005719 -18852 1 0.000243 1560.000000 -0.001504 -0.000247 0.004934 -18853 1 0.000210 1560.000000 -0.001662 -0.000680 0.003372 -18854 1 0.000266 1560.000000 0.001204 -0.002878 0.009817 -18855 1 0.000205 1560.000000 -0.000958 0.003305 0.000788 -18856 1 0.000230 1560.000000 -0.003211 -0.001098 0.007098 -18857 1 0.000284 1560.000000 0.001755 0.000012 0.009470 -18858 1 0.000245 1560.000000 0.000864 -0.002824 0.001189 -18859 1 0.000245 1560.000000 0.002193 0.002037 0.009486 -18860 1 0.000228 1560.000000 0.002580 0.000563 0.005357 -18861 1 0.000259 1560.000000 0.002906 -0.000502 0.000751 -18862 1 0.000257 1560.000000 -0.000868 -0.001038 0.007400 -18863 1 0.000195 1560.000000 -0.001299 0.002817 0.006416 -18864 1 0.000193 1560.000000 -0.001748 0.000243 0.008003 -18865 1 0.000263 1560.000000 0.001385 -0.000161 0.005725 -18866 1 0.000246 1560.000000 -0.002338 -0.001012 0.003888 -18867 1 0.000246 1560.000000 0.002362 0.000945 0.008613 -18868 1 0.000205 1560.000000 -0.002707 0.000550 0.004800 -18869 1 0.000270 1560.000000 -0.001102 0.001341 0.008493 -18870 1 0.000226 1560.000000 -0.002331 -0.002925 0.003956 -18871 1 0.000221 1560.000000 0.002003 0.001099 0.005616 -18872 1 0.000198 1560.000000 -0.001559 -0.001803 0.003625 -18873 1 0.000275 1560.000000 -0.002628 -0.002329 0.002913 -18874 1 0.000245 1560.000000 -0.001186 0.002461 0.001574 -18875 1 0.000231 1560.000000 0.002271 0.000164 0.008796 -18876 1 0.000287 1560.000000 -0.002520 -0.001331 0.006428 -18877 1 0.000247 1560.000000 0.002463 0.000937 0.008153 -18878 1 0.000252 1560.000000 -0.003402 0.000547 0.009398 -18879 1 0.000244 1560.000000 0.000330 0.001799 0.008177 -18880 1 0.000193 1560.000000 0.003090 0.001041 0.001553 -18881 1 0.000202 1560.000000 0.003280 0.001032 0.002301 -18882 1 0.000196 1560.000000 -0.000814 -0.001790 0.004863 -18883 1 0.000205 1560.000000 0.002806 0.001753 0.009030 -18884 1 0.000203 1560.000000 0.000247 0.002269 0.002084 -18885 1 0.000198 1560.000000 0.000137 0.002677 0.000544 -18886 1 0.000258 1560.000000 0.003482 0.000079 0.006148 -18887 1 0.000239 1560.000000 -0.002098 0.001249 0.004279 -18888 1 0.000206 1560.000000 -0.002334 0.000625 0.002382 -18889 1 0.000201 1560.000000 -0.000465 0.000927 0.009126 -18890 1 0.000275 1560.000000 0.002449 0.000506 0.009571 -18891 1 0.000218 1560.000000 0.001090 0.000353 0.001933 -18892 1 0.000223 1560.000000 -0.000652 0.002541 0.002247 -18893 1 0.000208 1560.000000 -0.001813 -0.002540 0.002198 -18894 1 0.000263 1560.000000 -0.000995 -0.003698 0.002309 -18895 1 0.000287 1560.000000 -0.000591 0.001399 0.006291 -18896 1 0.000229 1560.000000 -0.001056 -0.003143 0.008032 -18897 1 0.000195 1560.000000 0.001393 0.002430 0.001103 -18898 1 0.000258 1560.000000 -0.001402 -0.000398 0.009264 -18899 1 0.000211 1560.000000 0.000861 0.003112 0.004217 -18900 1 0.000277 1560.000000 0.002124 -0.000387 0.001428 -18901 1 0.000269 1560.000000 -0.002086 0.000063 0.008103 -18902 1 0.000195 1560.000000 -0.001575 -0.002892 0.000826 -18903 1 0.000210 1560.000000 -0.002475 0.000043 0.004568 -18904 1 0.000194 1560.000000 0.002146 -0.000839 0.001005 -18905 1 0.000235 1560.000000 -0.003312 0.001923 0.003297 -18906 1 0.000220 1560.000000 -0.001910 -0.002722 0.001393 -18907 1 0.000208 1560.000000 -0.001048 0.001033 0.001416 -18908 1 0.000252 1560.000000 0.002414 0.000832 0.004105 -18909 1 0.000251 1560.000000 -0.003213 -0.001219 0.000474 -18910 1 0.000237 1560.000000 0.003417 -0.000710 0.002801 -18911 1 0.000280 1560.000000 0.002265 -0.003074 0.007925 -18912 1 0.000283 1560.000000 -0.000486 0.000993 0.008543 -18913 1 0.000227 1560.000000 -0.002610 -0.002028 0.001567 -18914 1 0.000283 1560.000000 -0.000105 0.002612 0.001052 -18915 1 0.000278 1560.000000 0.002424 0.001674 0.002840 -18916 1 0.000200 1560.000000 0.000620 0.003805 0.005184 -18917 1 0.000237 1560.000000 -0.000162 -0.002441 0.001632 -18918 1 0.000204 1560.000000 -0.000151 -0.001504 0.002610 -18919 1 0.000228 1560.000000 -0.003173 -0.000514 0.006626 -18920 1 0.000240 1560.000000 -0.000643 0.000495 0.007541 -18921 1 0.000210 1560.000000 0.002660 -0.002673 0.001973 -18922 1 0.000200 1560.000000 -0.002982 -0.002382 0.005435 -18923 1 0.000198 1560.000000 -0.000577 -0.000768 0.000104 -18924 1 0.000199 1560.000000 -0.003034 -0.002038 0.009336 -18925 1 0.000260 1560.000000 -0.003150 -0.001316 0.003882 -18926 1 0.000225 1560.000000 0.001145 -0.001454 0.006958 -18927 1 0.000239 1560.000000 -0.001384 -0.003492 0.006685 -18928 1 0.000252 1560.000000 -0.003225 -0.002058 0.004523 -18929 1 0.000248 1560.000000 -0.000687 -0.002104 0.003024 -18930 1 0.000231 1560.000000 0.001116 -0.001739 0.008298 -18931 1 0.000268 1560.000000 -0.003555 -0.000352 0.007130 -18932 1 0.000206 1560.000000 0.002974 0.000338 0.001435 -18933 1 0.000199 1560.000000 0.000582 0.003707 0.001041 -18934 1 0.000239 1560.000000 -0.000600 -0.003098 0.002059 -18935 1 0.000220 1560.000000 -0.000525 0.002265 0.008323 -18936 1 0.000202 1560.000000 0.001054 -0.003086 0.006716 -18937 1 0.000241 1560.000000 0.001971 -0.001975 0.005717 -18938 1 0.000238 1560.000000 0.003346 -0.000694 0.002511 -18939 1 0.000273 1560.000000 0.000828 0.003730 0.004816 -18940 1 0.000236 1560.000000 0.001867 0.002348 0.001721 -18941 1 0.000232 1560.000000 -0.001022 0.003264 0.002114 -18942 1 0.000193 1560.000000 0.001264 -0.002045 0.007855 -18943 1 0.000221 1560.000000 0.000616 0.002933 0.000716 -18944 1 0.000257 1560.000000 -0.003030 0.002384 0.001022 -18945 1 0.000235 1560.000000 0.001926 -0.002741 0.008552 -18946 1 0.000245 1560.000000 -0.001563 0.000147 0.004368 -18947 1 0.000276 1560.000000 0.002183 0.000595 0.002239 -18948 1 0.000194 1560.000000 -0.001386 -0.002655 0.000769 -18949 1 0.000204 1560.000000 -0.002265 -0.000023 0.009711 -18950 1 0.000225 1560.000000 -0.002475 0.000628 0.001304 -18951 1 0.000195 1560.000000 -0.002859 -0.002149 0.008344 -18952 1 0.000195 1560.000000 0.001664 0.003331 0.007512 -18953 1 0.000229 1560.000000 -0.000799 0.003501 0.003801 -18954 1 0.000288 1560.000000 -0.003096 0.001864 0.008927 -18955 1 0.000253 1560.000000 0.002263 -0.002772 0.008178 -18956 1 0.000221 1560.000000 0.001973 -0.001975 0.003197 -18957 1 0.000236 1560.000000 -0.000193 0.003409 0.005553 -18958 1 0.000205 1560.000000 -0.000329 0.002836 0.005513 -18959 1 0.000283 1560.000000 0.001257 -0.002671 0.001849 -18960 1 0.000258 1560.000000 -0.001107 -0.003381 0.009170 -18961 1 0.000284 1560.000000 0.000917 0.003342 0.009783 -18962 1 0.000210 1560.000000 -0.003309 -0.001492 0.009763 -18963 1 0.000194 1560.000000 0.000494 -0.002094 0.006518 -18964 1 0.000222 1560.000000 0.000949 -0.000097 0.003597 -18965 1 0.000212 1560.000000 -0.001100 -0.001083 0.005517 -18966 1 0.000210 1560.000000 -0.000671 0.001918 0.009784 -18967 1 0.000249 1560.000000 -0.002944 -0.001276 0.008426 -18968 1 0.000212 1560.000000 -0.000223 -0.002724 0.004924 -18969 1 0.000287 1560.000000 0.002805 -0.002600 0.008950 -18970 1 0.000240 1560.000000 -0.000873 0.001020 0.004869 -18971 1 0.000279 1560.000000 -0.003479 0.000106 0.007783 -18972 1 0.000282 1560.000000 0.000648 -0.001288 0.004034 -18973 1 0.000213 1560.000000 0.000120 -0.002678 0.008072 -18974 1 0.000233 1560.000000 -0.000899 0.000931 0.009403 -18975 1 0.000219 1560.000000 -0.002637 -0.000586 0.008160 -18976 1 0.000199 1560.000000 0.001661 0.003439 0.005000 -18977 1 0.000261 1560.000000 0.001808 -0.001578 0.000485 -18978 1 0.000222 1560.000000 0.001776 -0.000993 0.002921 -18979 1 0.000206 1560.000000 -0.003044 -0.002291 0.003087 -18980 1 0.000194 1560.000000 0.002332 -0.001190 0.004407 -18981 1 0.000195 1560.000000 0.002153 0.000505 0.005572 -18982 1 0.000200 1560.000000 0.003005 -0.001891 0.009807 -18983 1 0.000229 1560.000000 0.001495 0.000763 0.005647 -18984 1 0.000224 1560.000000 -0.002692 0.001020 0.007746 -18985 1 0.000227 1560.000000 -0.001075 0.003128 0.009469 -18986 1 0.000252 1560.000000 -0.000677 0.002332 0.006846 -18987 1 0.000271 1560.000000 -0.002894 -0.001398 0.009283 -18988 1 0.000247 1560.000000 -0.003252 0.001156 0.000910 -18989 1 0.000225 1560.000000 -0.001911 0.002729 0.007993 -18990 1 0.000200 1560.000000 0.001513 -0.001746 0.006380 -18991 1 0.000208 1560.000000 -0.003600 -0.001320 0.001298 -18992 1 0.000266 1560.000000 -0.003499 0.000758 0.007699 -18993 1 0.000211 1560.000000 0.000142 -0.003845 0.002333 -18994 1 0.000240 1560.000000 0.000476 -0.001481 0.000915 -18995 1 0.000252 1560.000000 -0.000540 -0.002772 0.008993 -18996 1 0.000213 1560.000000 0.001371 0.000254 0.004666 -18997 1 0.000258 1560.000000 -0.002525 0.000080 0.000873 -18998 1 0.000206 1560.000000 0.000700 0.002785 0.006472 -18999 1 0.000249 1560.000000 0.002345 0.000094 0.004688 -19000 1 0.000264 1560.000000 -0.003344 0.000554 0.004338 -19001 1 0.000230 1560.000000 -0.003220 0.001314 0.002179 -19002 1 0.000249 1560.000000 0.003364 0.001778 0.001655 -19003 1 0.000194 1560.000000 -0.001491 0.000943 0.009737 -19004 1 0.000199 1560.000000 0.003435 -0.000041 0.004166 -19005 1 0.000219 1560.000000 -0.000746 -0.002640 0.006296 -19006 1 0.000207 1560.000000 0.003008 0.001358 0.008647 -19007 1 0.000208 1560.000000 -0.000982 0.001355 0.004377 -19008 1 0.000279 1560.000000 -0.003781 -0.000050 0.004817 -19009 1 0.000243 1560.000000 -0.001334 -0.003019 0.004878 -19010 1 0.000214 1560.000000 0.002176 -0.002597 0.006229 -19011 1 0.000209 1560.000000 0.000519 -0.003282 0.002974 -19012 1 0.000215 1560.000000 0.001250 0.000574 0.005617 -19013 1 0.000209 1560.000000 0.003103 -0.000615 0.000289 -19014 1 0.000262 1560.000000 -0.000431 0.001097 0.005052 -19015 1 0.000276 1560.000000 -0.003490 0.001572 0.007203 -19016 1 0.000255 1560.000000 0.002951 -0.001408 0.003204 -19017 1 0.000252 1560.000000 -0.000081 0.003520 0.004742 -19018 1 0.000271 1560.000000 -0.002866 -0.002234 0.002590 -19019 1 0.000203 1560.000000 0.000264 -0.002488 0.001348 -19020 1 0.000217 1560.000000 -0.002652 0.000048 0.000650 -19021 1 0.000247 1560.000000 0.001262 0.001478 0.004885 -19022 1 0.000265 1560.000000 -0.001743 0.001128 0.004316 -19023 1 0.000283 1560.000000 -0.002310 0.000340 0.005772 -19024 1 0.000206 1560.000000 -0.000223 0.001432 0.006681 -19025 1 0.000224 1560.000000 0.000070 -0.002418 0.005292 -19026 1 0.000213 1560.000000 0.003345 -0.001324 0.009247 -19027 1 0.000253 1560.000000 0.001108 0.003145 0.002720 -19028 1 0.000244 1560.000000 -0.001193 -0.001770 0.002245 -19029 1 0.000218 1560.000000 -0.001010 -0.001461 0.000148 -19030 1 0.000203 1560.000000 -0.001111 -0.002691 0.009710 -19031 1 0.000269 1560.000000 0.003077 -0.001097 0.008617 -19032 1 0.000227 1560.000000 0.001074 0.001242 0.006896 -19033 1 0.000229 1560.000000 0.001933 -0.001983 0.000751 -19034 1 0.000240 1560.000000 0.002625 0.002683 0.001193 -19035 1 0.000253 1560.000000 -0.000029 -0.002753 0.006484 -19036 1 0.000196 1560.000000 -0.001185 -0.000842 0.000272 -19037 1 0.000253 1560.000000 0.000006 0.000929 0.000431 -19038 1 0.000201 1560.000000 0.000683 0.002525 0.002438 -19039 1 0.000240 1560.000000 -0.000998 -0.002483 0.005653 -19040 1 0.000202 1560.000000 0.002021 -0.001234 0.001515 -19041 1 0.000222 1560.000000 -0.001142 -0.002499 0.007834 -19042 1 0.000284 1560.000000 -0.000392 0.002226 0.004093 -19043 1 0.000265 1560.000000 -0.000232 0.001338 0.004736 -19044 1 0.000232 1560.000000 -0.001370 -0.000187 0.002184 -19045 1 0.000259 1560.000000 -0.001074 0.003044 0.006652 -19046 1 0.000211 1560.000000 0.001060 0.002770 0.006470 -19047 1 0.000234 1560.000000 0.001401 -0.000393 0.004472 -19048 1 0.000248 1560.000000 0.003565 -0.000696 0.009530 -19049 1 0.000193 1560.000000 -0.000731 -0.000904 0.006766 -19050 1 0.000228 1560.000000 -0.001590 0.002787 0.004275 -19051 1 0.000203 1560.000000 -0.001576 -0.002675 0.003447 -19052 1 0.000240 1560.000000 0.003203 -0.001353 0.007594 -19053 1 0.000193 1560.000000 -0.000882 0.001593 0.007421 -19054 1 0.000258 1560.000000 0.001832 -0.001370 0.004458 -19055 1 0.000240 1560.000000 0.002086 0.001821 0.006109 -19056 1 0.000243 1560.000000 -0.000016 -0.003567 0.000531 -19057 1 0.000209 1560.000000 0.000107 0.000718 0.008877 -19058 1 0.000261 1560.000000 -0.002703 0.002741 0.000153 -19059 1 0.000201 1560.000000 -0.003031 0.001160 0.009785 -19060 1 0.000210 1560.000000 -0.001410 -0.001191 0.003707 -19061 1 0.000224 1560.000000 -0.001002 0.000868 0.000581 -19062 1 0.000200 1560.000000 -0.002757 0.001514 0.006864 -19063 1 0.000285 1560.000000 0.000631 -0.002298 0.002166 -19064 1 0.000193 1560.000000 0.003522 0.001173 0.001150 -19065 1 0.000269 1560.000000 -0.002525 0.001639 0.003938 -19066 1 0.000272 1560.000000 -0.000120 0.003721 0.001922 -19067 1 0.000229 1560.000000 0.000949 -0.001676 0.005304 -19068 1 0.000204 1560.000000 -0.000624 -0.000910 0.005899 -19069 1 0.000235 1560.000000 0.002380 -0.001358 0.000542 -19070 1 0.000218 1560.000000 0.000405 0.000976 0.000874 -19071 1 0.000230 1560.000000 0.001986 0.003270 0.004922 -19072 1 0.000215 1560.000000 0.000703 -0.002059 0.001202 -19073 1 0.000284 1560.000000 0.001917 -0.002484 0.009512 -19074 1 0.000199 1560.000000 -0.002796 0.001018 0.003459 -19075 1 0.000208 1560.000000 0.000779 -0.003125 0.007264 -19076 1 0.000246 1560.000000 0.003012 -0.001343 0.008426 -19077 1 0.000228 1560.000000 0.000993 0.001411 0.003462 -19078 1 0.000201 1560.000000 0.001036 0.002211 0.004449 -19079 1 0.000231 1560.000000 -0.002870 -0.002046 0.008737 -19080 1 0.000193 1560.000000 0.000766 -0.000023 0.009664 -19081 1 0.000288 1560.000000 0.002851 -0.002187 0.004637 -19082 1 0.000251 1560.000000 0.001278 -0.001243 0.005325 -19083 1 0.000288 1560.000000 0.002068 -0.003243 0.002189 -19084 1 0.000247 1560.000000 -0.001532 0.000519 0.004629 -19085 1 0.000249 1560.000000 0.000101 -0.001280 0.006792 -19086 1 0.000221 1560.000000 -0.000468 -0.002192 0.001438 -19087 1 0.000247 1560.000000 -0.001193 0.002414 0.005047 -19088 1 0.000261 1560.000000 0.002734 0.000230 0.002443 -19089 1 0.000228 1560.000000 -0.000457 0.002494 0.001385 -19090 1 0.000278 1560.000000 0.002788 0.000979 0.000200 -19091 1 0.000262 1560.000000 0.001702 0.002972 0.001530 -19092 1 0.000214 1560.000000 0.000388 0.003114 0.008480 -19093 1 0.000201 1560.000000 0.001299 0.000194 0.006034 -19094 1 0.000223 1560.000000 -0.003165 -0.000609 0.008882 -19095 1 0.000282 1560.000000 -0.001806 -0.003298 0.000173 -19096 1 0.000236 1560.000000 -0.000158 0.003337 0.006898 -19097 1 0.000201 1560.000000 -0.002197 -0.001127 0.002633 -19098 1 0.000271 1560.000000 0.001104 -0.003030 0.006026 -19099 1 0.000245 1560.000000 0.001685 -0.001310 0.005870 -19100 1 0.000265 1560.000000 -0.002798 0.002559 0.002731 -19101 1 0.000225 1560.000000 0.001732 -0.001132 0.000593 -19102 1 0.000214 1560.000000 0.002140 0.003152 0.008666 -19103 1 0.000247 1560.000000 0.003144 0.001564 0.008934 -19104 1 0.000251 1560.000000 0.001492 -0.003525 0.008891 -19105 1 0.000253 1560.000000 0.002609 -0.002046 0.008872 -19106 1 0.000230 1560.000000 0.001421 -0.001411 0.003666 -19107 1 0.000220 1560.000000 -0.000925 0.001040 0.007244 -19108 1 0.000211 1560.000000 0.000764 -0.002831 0.003617 -19109 1 0.000246 1560.000000 -0.000981 -0.001690 0.007763 -19110 1 0.000210 1560.000000 0.000325 0.000570 0.004334 -19111 1 0.000272 1560.000000 -0.001717 0.002922 0.000623 -19112 1 0.000280 1560.000000 0.001026 -0.002501 0.001562 -19113 1 0.000194 1560.000000 0.000028 0.000289 0.000123 -19114 1 0.000241 1560.000000 -0.002499 -0.001397 0.007567 -19115 1 0.000213 1560.000000 0.000119 0.000081 0.005559 -19116 1 0.000204 1560.000000 0.000584 -0.000954 0.004328 -19117 1 0.000205 1560.000000 0.002027 0.000541 0.006110 -19118 1 0.000230 1560.000000 -0.001279 -0.000616 0.002183 -19119 1 0.000254 1560.000000 -0.002461 -0.001421 0.005865 -19120 1 0.000197 1560.000000 0.002348 0.003020 0.009110 -19121 1 0.000222 1560.000000 -0.000132 -0.001151 0.006337 -19122 1 0.000193 1560.000000 0.001095 0.000266 0.006915 -19123 1 0.000203 1560.000000 -0.003373 -0.000423 0.004411 -19124 1 0.000225 1560.000000 -0.001621 0.003322 0.002228 -19125 1 0.000253 1560.000000 0.002997 0.000160 0.001274 -19126 1 0.000244 1560.000000 -0.002899 -0.000897 0.006078 -19127 1 0.000193 1560.000000 0.002198 0.000133 0.008258 -19128 1 0.000209 1560.000000 -0.000936 -0.002103 0.000401 -19129 1 0.000283 1560.000000 -0.000867 -0.000184 0.002296 -19130 1 0.000211 1560.000000 0.000465 -0.003798 0.007128 -19131 1 0.000248 1560.000000 -0.002671 0.000818 0.004800 -19132 1 0.000205 1560.000000 -0.000057 -0.001311 0.009603 -19133 1 0.000269 1560.000000 0.002643 0.000244 0.008951 -19134 1 0.000195 1560.000000 -0.002175 -0.000156 0.001575 -19135 1 0.000286 1560.000000 0.001979 0.002751 0.005248 -19136 1 0.000270 1560.000000 -0.003751 0.000273 0.005132 -19137 1 0.000213 1560.000000 -0.000394 0.001379 0.003274 -19138 1 0.000234 1560.000000 -0.001758 -0.000703 0.005076 -19139 1 0.000221 1560.000000 -0.000474 0.001998 0.007148 -19140 1 0.000214 1560.000000 0.002069 -0.001504 0.002857 -19141 1 0.000264 1560.000000 0.000583 -0.003637 0.000810 -19142 1 0.000227 1560.000000 0.002987 -0.001669 0.002254 -19143 1 0.000193 1560.000000 0.001012 -0.000627 0.005599 -19144 1 0.000214 1560.000000 -0.000986 0.002351 0.001672 -19145 1 0.000238 1560.000000 0.003176 0.000345 0.008330 -19146 1 0.000193 1560.000000 0.003776 0.000322 0.005548 -19147 1 0.000225 1560.000000 -0.002365 0.002147 0.000186 -19148 1 0.000206 1560.000000 -0.002468 -0.002241 0.000857 -19149 1 0.000255 1560.000000 0.003443 -0.001717 0.003551 -19150 1 0.000210 1560.000000 -0.002815 0.001073 0.006980 -19151 1 0.000204 1560.000000 0.003348 -0.001349 0.000193 -19152 1 0.000231 1560.000000 0.000601 -0.002955 0.003882 -19153 1 0.000228 1560.000000 -0.001566 -0.002872 0.006200 -19154 1 0.000242 1560.000000 0.002277 -0.000468 0.000913 -19155 1 0.000196 1560.000000 -0.000001 0.001003 0.003679 -19156 1 0.000206 1560.000000 -0.003098 0.000999 0.004713 -19157 1 0.000204 1560.000000 0.002750 -0.001246 0.006164 -19158 1 0.000203 1560.000000 0.001241 -0.001215 0.009557 -19159 1 0.000198 1560.000000 0.002616 0.001697 0.004645 -19160 1 0.000222 1560.000000 -0.002845 0.001161 0.007978 -19161 1 0.000200 1560.000000 0.002952 0.001746 0.006176 -19162 1 0.000205 1560.000000 -0.003307 0.000252 0.002240 -19163 1 0.000221 1560.000000 0.000766 -0.002453 0.003895 -19164 1 0.000233 1560.000000 -0.000272 -0.002300 0.009414 -19165 1 0.000230 1560.000000 0.002102 0.001228 0.004752 -19166 1 0.000219 1560.000000 -0.003111 -0.000791 0.000402 -19167 1 0.000225 1560.000000 -0.002536 0.000281 0.002993 -19168 1 0.000260 1560.000000 -0.001570 -0.000094 0.001755 -19169 1 0.000201 1560.000000 0.001194 0.002294 0.004258 -19170 1 0.000233 1560.000000 0.000207 0.003830 0.002325 -19171 1 0.000195 1560.000000 0.002256 0.000836 0.007100 -19172 1 0.000203 1560.000000 -0.000776 -0.001301 0.000961 -19173 1 0.000213 1560.000000 -0.000764 -0.000195 0.005044 -19174 1 0.000240 1560.000000 -0.002007 0.000243 0.004534 -19175 1 0.000230 1560.000000 -0.002303 -0.001503 0.004881 -19176 1 0.000203 1560.000000 0.002460 0.000030 0.006057 -19177 1 0.000224 1560.000000 -0.003611 -0.000455 0.002528 -19178 1 0.000234 1560.000000 0.000361 0.002894 0.008390 -19179 1 0.000274 1560.000000 0.003154 0.002169 0.007095 -19180 1 0.000252 1560.000000 0.002586 -0.001942 0.000129 -19181 1 0.000278 1560.000000 0.002308 -0.001400 0.003449 -19182 1 0.000214 1560.000000 -0.000353 0.003820 0.004073 -19183 1 0.000207 1560.000000 0.002142 -0.001768 0.006565 -19184 1 0.000196 1560.000000 -0.000488 -0.000007 0.007106 -19185 1 0.000204 1560.000000 -0.002110 -0.001723 0.001763 -19186 1 0.000195 1560.000000 0.000837 0.001733 0.007832 -19187 1 0.000278 1560.000000 -0.002247 0.000813 0.003855 -19188 1 0.000213 1560.000000 -0.000119 -0.003114 0.007296 -19189 1 0.000205 1560.000000 -0.002635 0.002192 0.004254 -19190 1 0.000239 1560.000000 0.000942 -0.003234 0.007969 -19191 1 0.000215 1560.000000 0.000794 -0.002019 0.007633 -19192 1 0.000194 1560.000000 -0.001888 0.001996 0.004638 -19193 1 0.000264 1560.000000 0.000204 0.003108 0.000843 -19194 1 0.000213 1560.000000 0.001291 -0.000960 0.005923 -19195 1 0.000253 1560.000000 0.003762 0.000201 0.009372 -19196 1 0.000275 1560.000000 -0.003659 -0.001094 0.006440 -19197 1 0.000214 1560.000000 0.002125 0.002556 0.002755 -19198 1 0.000200 1560.000000 -0.001468 0.002125 0.009308 -19199 1 0.000232 1560.000000 -0.003340 0.000410 0.009748 -19200 1 0.000222 1560.000000 -0.002548 0.000967 0.000155 -19201 1 0.000284 1560.000000 -0.003400 0.001671 0.009408 -19202 1 0.000193 1560.000000 -0.002303 -0.003038 0.000531 -19203 1 0.000195 1560.000000 -0.000690 -0.000298 0.008794 -19204 1 0.000196 1560.000000 -0.000522 -0.000832 0.006921 -19205 1 0.000196 1560.000000 -0.002416 -0.000939 0.001843 -19206 1 0.000260 1560.000000 0.002759 -0.000675 0.006298 -19207 1 0.000273 1560.000000 -0.001685 0.000334 0.007324 -19208 1 0.000286 1560.000000 -0.003800 -0.000374 0.009174 -19209 1 0.000245 1560.000000 -0.000779 -0.001795 0.003774 -19210 1 0.000238 1560.000000 -0.001445 0.003368 0.007965 -19211 1 0.000248 1560.000000 0.001064 0.002557 0.001201 -19212 1 0.000268 1560.000000 -0.002204 -0.002524 0.006643 -19213 1 0.000285 1560.000000 0.000693 0.002045 0.009096 -19214 1 0.000218 1560.000000 0.003444 -0.000042 0.007884 -19215 1 0.000208 1560.000000 -0.001486 -0.003541 0.006355 -19216 1 0.000214 1560.000000 -0.001827 -0.000354 0.009767 -19217 1 0.000237 1560.000000 0.002493 -0.001111 0.006813 -19218 1 0.000194 1560.000000 0.000594 0.000026 0.007348 -19219 1 0.000267 1560.000000 -0.000298 0.003769 0.005156 -19220 1 0.000204 1560.000000 0.000844 -0.002842 0.009133 -19221 1 0.000220 1560.000000 0.001299 -0.001592 0.008114 -19222 1 0.000239 1560.000000 -0.002322 0.003014 0.003729 -19223 1 0.000208 1560.000000 0.001072 -0.000652 0.003995 -19224 1 0.000260 1560.000000 0.001090 0.002424 0.009579 -19225 1 0.000229 1560.000000 -0.002188 -0.000072 0.003609 -19226 1 0.000254 1560.000000 -0.003724 0.000698 0.006272 -19227 1 0.000220 1560.000000 0.003402 -0.001310 0.008749 -19228 1 0.000214 1560.000000 -0.001459 0.002864 0.001445 -19229 1 0.000193 1560.000000 0.001128 -0.001778 0.006963 -19230 1 0.000244 1560.000000 -0.003373 0.000841 0.007292 -19231 1 0.000200 1560.000000 -0.002847 0.000111 0.006758 -19232 1 0.000282 1560.000000 0.000153 -0.003808 0.004390 -19233 1 0.000255 1560.000000 0.002750 0.002019 0.002975 -19234 1 0.000254 1560.000000 0.001187 -0.002999 0.008517 -19235 1 0.000247 1560.000000 -0.003188 -0.000489 0.002676 -19236 1 0.000283 1560.000000 0.000755 0.002728 0.009056 -19237 1 0.000213 1560.000000 0.001928 -0.001943 0.004348 -19238 1 0.000266 1560.000000 -0.002788 0.000824 0.006126 -19239 1 0.000247 1560.000000 0.003229 0.000018 0.003388 -19240 1 0.000239 1560.000000 0.000490 0.000389 0.001588 -19241 1 0.000206 1560.000000 -0.003019 -0.002368 0.001884 -19242 1 0.000196 1560.000000 -0.000501 -0.003327 0.007918 -19243 1 0.000287 1560.000000 -0.001835 0.002323 0.002511 -19244 1 0.000242 1560.000000 0.003470 0.001560 0.007362 -19245 1 0.000217 1560.000000 -0.001883 -0.003283 0.007379 -19246 1 0.000232 1560.000000 0.000406 -0.002497 0.005361 -19247 1 0.000220 1560.000000 -0.002298 -0.001916 0.001836 -19248 1 0.000250 1560.000000 -0.000237 0.001069 0.008137 -19249 1 0.000274 1560.000000 -0.001267 -0.002898 0.009019 -19250 1 0.000252 1560.000000 0.003224 0.001851 0.006081 -19251 1 0.000196 1560.000000 -0.002422 -0.000142 0.000131 -19252 1 0.000231 1560.000000 -0.000549 -0.002479 0.002332 -19253 1 0.000258 1560.000000 -0.002929 0.002347 0.009701 -19254 1 0.000199 1560.000000 0.002023 -0.000105 0.008299 -19255 1 0.000228 1560.000000 0.001219 -0.001762 0.008921 -19256 1 0.000199 1560.000000 -0.001698 -0.001696 0.006448 -19257 1 0.000220 1560.000000 -0.003672 -0.001156 0.003166 -19258 1 0.000211 1560.000000 -0.001006 0.002597 0.001526 -19259 1 0.000216 1560.000000 -0.003702 0.001018 0.006530 -19260 1 0.000226 1560.000000 0.002150 -0.001092 0.000649 -19261 1 0.000209 1560.000000 0.003622 0.001048 0.007965 -19262 1 0.000237 1560.000000 -0.000879 0.003733 0.007658 -19263 1 0.000260 1560.000000 -0.003395 0.000424 0.004994 -19264 1 0.000250 1560.000000 -0.002514 -0.001135 0.007671 -19265 1 0.000285 1560.000000 0.003557 -0.001075 0.009824 -19266 1 0.000202 1560.000000 -0.002293 0.001130 0.009272 -19267 1 0.000213 1560.000000 0.002374 -0.001469 0.001117 -19268 1 0.000203 1560.000000 0.003380 0.000340 0.003615 -19269 1 0.000265 1560.000000 0.001545 0.001560 0.003204 -19270 1 0.000210 1560.000000 -0.003299 -0.001897 0.007386 -19271 1 0.000196 1560.000000 0.001017 0.003656 0.004419 -19272 1 0.000219 1560.000000 0.003459 -0.000112 0.000838 -19273 1 0.000192 1560.000000 0.001453 0.000021 0.006486 -19274 1 0.000215 1560.000000 0.000188 -0.000936 0.001737 -19275 1 0.000259 1560.000000 -0.001720 -0.003060 0.003436 -19276 1 0.000195 1560.000000 -0.000133 -0.002284 0.008733 -19277 1 0.000250 1560.000000 -0.002483 -0.002584 0.002303 -19278 1 0.000223 1560.000000 0.000518 0.001932 0.006372 -19279 1 0.000271 1560.000000 0.001421 -0.001907 0.000162 -19280 1 0.000195 1560.000000 0.002391 -0.001368 0.003072 -19281 1 0.000243 1560.000000 0.003800 0.000270 0.007823 -19282 1 0.000198 1560.000000 -0.000375 -0.000169 0.009542 -19283 1 0.000218 1560.000000 0.000243 0.001308 0.003654 -19284 1 0.000208 1560.000000 0.001417 -0.002236 0.006964 -19285 1 0.000260 1560.000000 0.002337 0.000454 0.006227 -19286 1 0.000212 1560.000000 -0.002143 -0.000390 0.005095 -19287 1 0.000229 1560.000000 -0.001231 0.001377 0.001381 -19288 1 0.000205 1560.000000 -0.003399 -0.001097 0.002739 -19289 1 0.000214 1560.000000 0.001055 0.000893 0.009729 -19290 1 0.000192 1560.000000 -0.001166 -0.002863 0.006067 -19291 1 0.000273 1560.000000 -0.003576 0.000420 0.008351 -19292 1 0.000233 1560.000000 0.000159 0.000492 0.001176 -19293 1 0.000206 1560.000000 -0.000059 0.002001 0.008053 -19294 1 0.000210 1560.000000 -0.002970 0.000434 0.007514 -19295 1 0.000237 1560.000000 -0.002910 -0.001481 0.001387 -19296 1 0.000285 1560.000000 -0.003769 0.000608 0.005042 -19297 1 0.000229 1560.000000 0.000985 0.000909 0.009106 -19298 1 0.000209 1560.000000 0.000976 0.002874 0.009113 -19299 1 0.000195 1560.000000 0.001345 0.003358 0.009020 -19300 1 0.000248 1560.000000 0.001815 0.000626 0.008435 -19301 1 0.000214 1560.000000 0.001563 -0.001249 0.001040 -19302 1 0.000237 1560.000000 0.002959 -0.001936 0.007886 -19303 1 0.000213 1560.000000 -0.003837 -0.000180 0.001909 -19304 1 0.000273 1560.000000 0.003230 0.002106 0.008423 -19305 1 0.000215 1560.000000 0.001508 0.001051 0.009684 -19306 1 0.000215 1560.000000 -0.003803 0.000582 0.007193 -19307 1 0.000214 1560.000000 -0.000020 -0.002298 0.000229 -19308 1 0.000261 1560.000000 -0.002771 -0.000446 0.008575 -19309 1 0.000201 1560.000000 -0.001873 0.002727 0.004050 -19310 1 0.000250 1560.000000 0.003810 0.000523 0.008018 -19311 1 0.000262 1560.000000 -0.001665 0.001630 0.006170 -19312 1 0.000246 1560.000000 -0.001444 0.003559 0.008499 -19313 1 0.000196 1560.000000 -0.000308 0.000914 0.003800 -19314 1 0.000281 1560.000000 -0.000819 0.003019 0.005575 -19315 1 0.000257 1560.000000 0.001386 0.000156 0.005518 -19316 1 0.000194 1560.000000 -0.002240 0.001579 0.006520 -19317 1 0.000209 1560.000000 0.001236 0.002138 0.000753 -19318 1 0.000266 1560.000000 0.001212 0.002178 0.003443 -19319 1 0.000235 1560.000000 -0.002726 0.000345 0.001048 -19320 1 0.000241 1560.000000 0.001666 -0.002493 0.001447 -19321 1 0.000247 1560.000000 0.001798 0.001507 0.003118 -19322 1 0.000261 1560.000000 -0.000827 -0.001925 0.001267 -19323 1 0.000201 1560.000000 -0.002719 0.000974 0.003116 -19324 1 0.000209 1560.000000 0.002514 0.002132 0.000590 -19325 1 0.000200 1560.000000 -0.000400 -0.000822 0.001871 -19326 1 0.000205 1560.000000 -0.002659 -0.002096 0.002418 -19327 1 0.000239 1560.000000 0.003235 -0.001633 0.007204 -19328 1 0.000239 1560.000000 -0.001204 0.001809 0.000133 -19329 1 0.000202 1560.000000 0.000220 0.000972 0.008783 -19330 1 0.000222 1560.000000 -0.003090 0.002097 0.009185 -19331 1 0.000242 1560.000000 0.001595 -0.000112 0.004728 -19332 1 0.000259 1560.000000 0.000630 0.002149 0.009472 -19333 1 0.000194 1560.000000 -0.001715 0.003114 0.007925 -19334 1 0.000204 1560.000000 0.000484 -0.001171 0.001884 -19335 1 0.000288 1560.000000 0.000568 0.003766 0.009826 -19336 1 0.000275 1560.000000 -0.000718 -0.001613 0.001417 -19337 1 0.000203 1560.000000 0.002503 0.000726 0.008996 -19338 1 0.000244 1560.000000 0.002685 -0.000279 0.003937 -19339 1 0.000281 1560.000000 0.002570 0.001766 0.001349 -19340 1 0.000194 1560.000000 0.001752 0.003084 0.008251 -19341 1 0.000198 1560.000000 0.002219 -0.002763 0.006884 -19342 1 0.000282 1560.000000 0.001029 -0.003698 0.001476 -19343 1 0.000269 1560.000000 -0.000879 0.000360 0.003257 -19344 1 0.000229 1560.000000 0.001553 0.002448 0.001461 -19345 1 0.000256 1560.000000 0.000212 0.001535 0.009617 -19346 1 0.000227 1560.000000 0.002150 -0.000420 0.007513 -19347 1 0.000198 1560.000000 -0.003777 -0.000360 0.007731 -19348 1 0.000205 1560.000000 0.000078 -0.001470 0.007629 -19349 1 0.000241 1560.000000 0.002755 0.001355 0.000739 -19350 1 0.000259 1560.000000 0.001759 -0.000001 0.007654 -19351 1 0.000213 1560.000000 0.001540 0.000586 0.003064 -19352 1 0.000229 1560.000000 -0.001528 0.002384 0.001559 -19353 1 0.000199 1560.000000 0.000219 -0.000131 0.002765 -19354 1 0.000212 1560.000000 0.000000 0.003212 0.007886 -19355 1 0.000218 1560.000000 -0.000358 -0.000406 0.003951 -19356 1 0.000245 1560.000000 0.001941 -0.000413 0.008240 -19357 1 0.000208 1560.000000 0.003149 0.001309 0.002256 -19358 1 0.000240 1560.000000 0.003160 0.001175 0.003931 -19359 1 0.000198 1560.000000 0.000110 0.002633 0.007831 -19360 1 0.000253 1560.000000 0.002463 -0.002005 0.003448 -19361 1 0.000265 1560.000000 0.001731 0.001257 0.009139 -19362 1 0.000197 1560.000000 -0.002658 -0.000514 0.008358 -19363 1 0.000243 1560.000000 -0.002406 -0.002674 0.008556 -19364 1 0.000212 1560.000000 0.003160 0.000481 0.000802 -19365 1 0.000223 1560.000000 -0.000346 -0.000428 0.009816 -19366 1 0.000285 1560.000000 0.003819 0.000528 0.009259 -19367 1 0.000271 1560.000000 -0.001033 -0.002687 0.004451 -19368 1 0.000252 1560.000000 0.000805 -0.002658 0.008529 -19369 1 0.000206 1560.000000 -0.002708 0.000609 0.007551 -19370 1 0.000272 1560.000000 -0.002305 0.000712 0.005684 -19371 1 0.000253 1560.000000 -0.002126 0.000182 0.005231 -19372 1 0.000201 1560.000000 -0.002242 0.002647 0.005102 -19373 1 0.000226 1560.000000 -0.000247 -0.003629 0.003611 -19374 1 0.000232 1560.000000 -0.000276 0.002610 0.002138 -19375 1 0.000229 1560.000000 -0.003392 -0.000399 0.007634 -19376 1 0.000210 1560.000000 -0.003444 0.001705 0.006201 -19377 1 0.000206 1560.000000 -0.002870 -0.000813 0.002760 -19378 1 0.000223 1560.000000 0.002733 0.001613 0.001791 -19379 1 0.000244 1560.000000 -0.002431 0.001427 0.002916 -19380 1 0.000203 1560.000000 -0.002014 0.000459 0.003104 -19381 1 0.000196 1560.000000 -0.000049 -0.001333 0.001549 -19382 1 0.000258 1560.000000 0.002199 0.002000 0.001217 -19383 1 0.000237 1560.000000 -0.000803 -0.000573 0.007767 -19384 1 0.000239 1560.000000 0.003413 -0.000780 0.001726 -19385 1 0.000195 1560.000000 0.002651 0.001138 0.003960 -19386 1 0.000212 1560.000000 0.002406 0.002169 0.006267 -19387 1 0.000259 1560.000000 -0.001671 -0.002284 0.007407 -19388 1 0.000263 1560.000000 0.002287 0.003090 0.009436 -19389 1 0.000228 1560.000000 -0.002157 -0.002775 0.008002 -19390 1 0.000231 1560.000000 -0.001111 -0.002004 0.005844 -19391 1 0.000255 1560.000000 -0.003489 -0.000968 0.003462 -19392 1 0.000242 1560.000000 -0.001230 -0.000403 0.002081 -19393 1 0.000239 1560.000000 0.000049 -0.001426 0.005017 -19394 1 0.000195 1560.000000 -0.000827 -0.001995 0.001704 -19395 1 0.000220 1560.000000 -0.001164 0.001377 0.004844 -19396 1 0.000196 1560.000000 0.003706 0.000503 0.000844 -19397 1 0.000239 1560.000000 -0.001733 -0.001658 0.005236 -19398 1 0.000266 1560.000000 0.000363 -0.002853 0.009793 -19399 1 0.000231 1560.000000 0.001576 -0.001097 0.008087 -19400 1 0.000278 1560.000000 -0.003830 0.000070 0.008867 -19401 1 0.000230 1560.000000 -0.000069 0.002902 0.004638 -19402 1 0.000239 1560.000000 0.001025 0.000794 0.008691 -19403 1 0.000227 1560.000000 0.003625 -0.001150 0.005005 -19404 1 0.000218 1560.000000 0.001858 0.002078 0.003541 -19405 1 0.000285 1560.000000 0.002562 0.001221 0.009258 -19406 1 0.000224 1560.000000 0.001801 0.002694 0.000889 -19407 1 0.000200 1560.000000 -0.000148 -0.001285 0.007015 -19408 1 0.000245 1560.000000 0.000978 -0.003717 0.004227 -19409 1 0.000232 1560.000000 0.002350 0.002422 0.003419 -19410 1 0.000192 1560.000000 -0.000574 0.001779 0.002028 -19411 1 0.000197 1560.000000 -0.001688 -0.000160 0.002719 -19412 1 0.000199 1560.000000 0.001132 -0.000414 0.006336 -19413 1 0.000229 1560.000000 0.000878 0.000218 0.002947 -19414 1 0.000210 1560.000000 0.001628 0.000222 0.007154 -19415 1 0.000283 1560.000000 0.000589 0.003243 0.003389 -19416 1 0.000200 1560.000000 -0.002126 -0.002597 0.008407 -19417 1 0.000280 1560.000000 -0.000973 0.003697 0.003719 -19418 1 0.000230 1560.000000 -0.000254 -0.001265 0.007949 -19419 1 0.000272 1560.000000 0.001368 0.002080 0.007436 -19420 1 0.000205 1560.000000 0.000360 0.003383 0.008844 -19421 1 0.000241 1560.000000 0.000783 0.001389 0.002809 -19422 1 0.000197 1560.000000 0.003447 0.000128 0.000190 -19423 1 0.000226 1560.000000 -0.000700 -0.003227 0.008127 -19424 1 0.000241 1560.000000 0.001302 -0.000490 0.005607 -19425 1 0.000247 1560.000000 -0.001390 -0.003379 0.001053 -19426 1 0.000223 1560.000000 0.000299 -0.001639 0.001162 -19427 1 0.000197 1560.000000 -0.003748 0.000826 0.002901 -19428 1 0.000251 1560.000000 -0.000046 -0.002948 0.007441 -19429 1 0.000243 1560.000000 0.000976 0.002821 0.004425 -19430 1 0.000212 1560.000000 -0.000244 0.000908 0.008967 -19431 1 0.000248 1560.000000 0.003230 -0.000703 0.005464 -19432 1 0.000205 1560.000000 -0.001713 0.002307 0.004279 -19433 1 0.000196 1560.000000 -0.002971 -0.000640 0.009033 -19434 1 0.000280 1560.000000 0.001865 -0.003313 0.000519 -19435 1 0.000223 1560.000000 -0.003720 0.000134 0.002590 -19436 1 0.000200 1560.000000 -0.002007 0.000260 0.008597 -19437 1 0.000226 1560.000000 -0.002327 -0.001557 0.002375 -19438 1 0.000253 1560.000000 -0.003844 0.000291 0.002960 -19439 1 0.000204 1560.000000 0.000197 -0.001244 0.004740 -19440 1 0.000276 1560.000000 -0.001767 -0.000211 0.003845 -19441 1 0.000225 1560.000000 0.001188 0.003205 0.003753 -19442 1 0.000279 1560.000000 0.002246 -0.000909 0.008125 -19443 1 0.000279 1560.000000 -0.001822 -0.001704 0.009849 -19444 1 0.000224 1560.000000 -0.002271 0.001062 0.008528 -19445 1 0.000272 1560.000000 0.002866 -0.000204 0.008777 -19446 1 0.000238 1560.000000 0.001180 0.003649 0.000270 -19447 1 0.000250 1560.000000 -0.000014 -0.003104 0.000150 -19448 1 0.000227 1560.000000 0.000103 -0.001851 0.006847 -19449 1 0.000207 1560.000000 0.001969 0.000059 0.003494 -19450 1 0.000201 1560.000000 -0.000500 0.001628 0.004641 -19451 1 0.000245 1560.000000 0.002833 -0.001538 0.003791 -19452 1 0.000243 1560.000000 0.000099 -0.003445 0.008321 -19453 1 0.000209 1560.000000 -0.002187 -0.000246 0.002278 -19454 1 0.000235 1560.000000 -0.002966 -0.000121 0.003904 -19455 1 0.000219 1560.000000 -0.000597 -0.002851 0.004154 -19456 1 0.000205 1560.000000 -0.001199 0.002514 0.005606 -19457 1 0.000275 1560.000000 -0.002050 -0.002542 0.002617 -19458 1 0.000207 1560.000000 0.002745 0.002336 0.003962 -19459 1 0.000226 1560.000000 0.001301 -0.001647 0.001470 -19460 1 0.000228 1560.000000 0.000624 -0.002298 0.004384 -19461 1 0.000196 1560.000000 0.002490 -0.002918 0.000128 -19462 1 0.000208 1560.000000 0.002986 0.000936 0.008235 -19463 1 0.000202 1560.000000 -0.000606 -0.001003 0.006212 -19464 1 0.000241 1560.000000 0.000601 0.000034 0.006152 -19465 1 0.000272 1560.000000 -0.002257 -0.001768 0.009781 -19466 1 0.000215 1560.000000 -0.002187 -0.000923 0.001972 -19467 1 0.000240 1560.000000 -0.000262 -0.000805 0.003070 -19468 1 0.000207 1560.000000 -0.002874 0.001736 0.009293 -19469 1 0.000203 1560.000000 0.001696 0.001683 0.005274 -19470 1 0.000251 1560.000000 0.002451 -0.001413 0.007921 -19471 1 0.000269 1560.000000 -0.001918 0.003301 0.003541 -19472 1 0.000194 1560.000000 0.003286 0.000161 0.008203 -19473 1 0.000245 1560.000000 -0.000292 0.003160 0.006125 -19474 1 0.000275 1560.000000 -0.003420 -0.000552 0.000158 -19475 1 0.000252 1560.000000 -0.000968 -0.000737 0.000926 -19476 1 0.000210 1560.000000 -0.002328 -0.000281 0.000492 -19477 1 0.000221 1560.000000 0.000203 -0.001293 0.002303 -19478 1 0.000229 1560.000000 -0.000990 0.001061 0.003744 -19479 1 0.000216 1560.000000 0.003829 0.000000 0.007576 -19480 1 0.000201 1560.000000 -0.003251 -0.000935 0.008532 -19481 1 0.000210 1560.000000 -0.000310 -0.002171 0.006666 -19482 1 0.000217 1560.000000 0.001659 0.001097 0.006369 -19483 1 0.000270 1560.000000 0.001708 0.000981 0.005244 -19484 1 0.000220 1560.000000 -0.000739 -0.003759 0.007432 -19485 1 0.000238 1560.000000 0.002114 0.000590 0.000978 -19486 1 0.000209 1560.000000 -0.002028 -0.002283 0.004175 -19487 1 0.000208 1560.000000 0.001201 -0.003251 0.002634 -19488 1 0.000216 1560.000000 -0.003144 -0.001663 0.007526 -19489 1 0.000222 1560.000000 -0.001387 0.000618 0.002339 -19490 1 0.000262 1560.000000 0.003103 -0.002207 0.006867 -19491 1 0.000200 1560.000000 0.001658 -0.000908 0.002601 -19492 1 0.000238 1560.000000 -0.001005 0.001825 0.001815 -19493 1 0.000221 1560.000000 0.001304 -0.000311 0.009760 -19494 1 0.000237 1560.000000 -0.001140 0.003661 0.000893 -19495 1 0.000217 1560.000000 -0.003666 -0.001013 0.008809 -19496 1 0.000277 1560.000000 0.001819 0.000559 0.002119 -19497 1 0.000200 1560.000000 0.003541 0.000751 0.008872 -19498 1 0.000195 1560.000000 -0.001699 -0.003252 0.006029 -19499 1 0.000205 1560.000000 -0.002175 0.001377 0.001253 -19500 1 0.000239 1560.000000 0.000627 0.000761 0.001633 -19501 1 0.000203 1560.000000 0.001377 -0.003228 0.004083 -19502 1 0.000288 1560.000000 -0.001085 0.003697 0.009764 -19503 1 0.000235 1560.000000 -0.003004 -0.000234 0.008674 -19504 1 0.000256 1560.000000 0.002436 -0.002175 0.009352 -19505 1 0.000269 1560.000000 -0.003213 0.002108 0.003454 -19506 1 0.000228 1560.000000 0.000365 0.000805 0.001564 -19507 1 0.000247 1560.000000 -0.002857 -0.001750 0.005567 -19508 1 0.000203 1560.000000 0.002459 -0.002134 0.000358 -19509 1 0.000278 1560.000000 0.001262 -0.003300 0.004428 -19510 1 0.000204 1560.000000 -0.001498 0.001037 0.003377 -19511 1 0.000200 1560.000000 -0.001250 -0.001704 0.007443 -19512 1 0.000274 1560.000000 -0.001629 -0.003246 0.005488 -19513 1 0.000201 1560.000000 -0.003367 0.001801 0.000401 -19514 1 0.000262 1560.000000 -0.000486 -0.002155 0.009831 -19515 1 0.000240 1560.000000 0.002256 -0.000995 0.003104 -19516 1 0.000198 1560.000000 0.003452 -0.001020 0.008847 -19517 1 0.000222 1560.000000 -0.002255 0.000431 0.005222 -19518 1 0.000209 1560.000000 -0.000174 0.000630 0.007549 -19519 1 0.000227 1560.000000 0.000401 0.000832 0.005398 -19520 1 0.000263 1560.000000 -0.000693 -0.002209 0.006736 -19521 1 0.000245 1560.000000 0.000864 0.003720 0.002099 -19522 1 0.000227 1560.000000 -0.000396 0.000418 0.006226 -19523 1 0.000245 1560.000000 -0.002720 -0.000225 0.007178 -19524 1 0.000224 1560.000000 0.000123 -0.003641 0.002039 -19525 1 0.000217 1560.000000 -0.000137 0.002196 0.004530 -19526 1 0.000269 1560.000000 0.001476 0.002977 0.004360 -19527 1 0.000205 1560.000000 -0.000403 -0.000537 0.001855 -19528 1 0.000205 1560.000000 -0.001763 -0.002656 0.002001 -19529 1 0.000195 1560.000000 0.001369 0.002668 0.000920 -19530 1 0.000283 1560.000000 -0.003547 0.001482 0.001583 -19531 1 0.000228 1560.000000 0.001346 0.000851 0.003379 -19532 1 0.000287 1560.000000 -0.003587 -0.001330 0.007484 -19533 1 0.000200 1560.000000 -0.001974 0.000032 0.002459 -19534 1 0.000206 1560.000000 0.002311 0.000077 0.004267 -19535 1 0.000229 1560.000000 -0.003765 -0.000651 0.004050 -19536 1 0.000218 1560.000000 0.002503 -0.000732 0.009490 -19537 1 0.000207 1560.000000 0.001380 0.001929 0.004107 -19538 1 0.000197 1560.000000 -0.001389 -0.002550 0.002307 -19539 1 0.000231 1560.000000 0.000891 -0.001467 0.004128 -19540 1 0.000219 1560.000000 0.001414 -0.003105 0.004918 -19541 1 0.000221 1560.000000 0.000259 -0.002275 0.006805 -19542 1 0.000266 1560.000000 0.002445 0.000086 0.001443 -19543 1 0.000250 1560.000000 -0.001207 0.000426 0.004071 -19544 1 0.000222 1560.000000 0.000611 -0.000703 0.001504 -19545 1 0.000197 1560.000000 -0.001358 0.002998 0.000420 -19546 1 0.000238 1560.000000 0.001638 0.002277 0.002970 -19547 1 0.000200 1560.000000 0.002733 0.000007 0.000950 -19548 1 0.000195 1560.000000 -0.002835 -0.002219 0.007039 -19549 1 0.000219 1560.000000 0.000380 -0.003814 0.004707 -19550 1 0.000258 1560.000000 0.003727 0.000961 0.006437 -19551 1 0.000207 1560.000000 0.002774 -0.001905 0.005797 -19552 1 0.000219 1560.000000 0.001003 -0.003285 0.005710 -19553 1 0.000271 1560.000000 0.001581 -0.002154 0.002848 -19554 1 0.000209 1560.000000 -0.001717 0.002592 0.000747 -19555 1 0.000270 1560.000000 0.003324 0.001928 0.005211 -19556 1 0.000261 1560.000000 0.002567 0.002066 0.007163 -19557 1 0.000233 1560.000000 -0.001977 -0.002400 0.000170 -19558 1 0.000282 1560.000000 -0.002302 0.003071 0.004390 -19559 1 0.000283 1560.000000 0.002305 -0.003087 0.005409 -19560 1 0.000237 1560.000000 0.002425 0.002752 0.000429 -19561 1 0.000211 1560.000000 -0.000226 0.000713 0.003729 -19562 1 0.000202 1560.000000 -0.002137 -0.001532 0.001014 -19563 1 0.000226 1560.000000 0.000550 -0.001415 0.002146 -19564 1 0.000199 1560.000000 -0.003348 0.001627 0.000986 -19565 1 0.000240 1560.000000 0.002601 0.000140 0.005080 -19566 1 0.000247 1560.000000 -0.003121 0.000805 0.006739 -19567 1 0.000194 1560.000000 0.001805 0.001421 0.007684 -19568 1 0.000201 1560.000000 -0.001889 -0.002891 0.004588 -19569 1 0.000213 1560.000000 0.001744 -0.003388 0.007557 -19570 1 0.000221 1560.000000 -0.002198 0.000857 0.004638 -19571 1 0.000206 1560.000000 0.002425 0.000240 0.002083 -19572 1 0.000214 1560.000000 0.001851 -0.002986 0.004612 -19573 1 0.000216 1560.000000 -0.002601 0.000446 0.000566 -19574 1 0.000205 1560.000000 -0.001287 -0.003387 0.006080 -19575 1 0.000232 1560.000000 -0.003005 -0.001122 0.000670 -19576 1 0.000260 1560.000000 0.002361 -0.002452 0.000692 -19577 1 0.000239 1560.000000 -0.001528 -0.002187 0.000578 -19578 1 0.000263 1560.000000 0.000179 -0.003803 0.005508 -19579 1 0.000258 1560.000000 -0.003003 -0.000279 0.009397 -19580 1 0.000204 1560.000000 -0.003312 -0.000083 0.000297 -19581 1 0.000210 1560.000000 -0.001224 0.003275 0.003916 -19582 1 0.000272 1560.000000 0.002379 -0.000130 0.009007 -19583 1 0.000200 1560.000000 0.000711 -0.001749 0.003887 -19584 1 0.000238 1560.000000 0.002020 0.001381 0.009286 -19585 1 0.000224 1560.000000 -0.001880 0.002623 0.003383 -19586 1 0.000236 1560.000000 0.000283 -0.000978 0.004580 -19587 1 0.000253 1560.000000 0.002301 -0.003034 0.002588 -19588 1 0.000194 1560.000000 -0.000572 -0.003106 0.004187 -19589 1 0.000217 1560.000000 -0.002196 0.000921 0.001049 -19590 1 0.000256 1560.000000 -0.000314 0.002170 0.007985 -19591 1 0.000247 1560.000000 -0.002255 0.000745 0.003321 -19592 1 0.000254 1560.000000 -0.001535 0.002838 0.004673 -19593 1 0.000219 1560.000000 -0.003109 0.001502 0.005540 -19594 1 0.000205 1560.000000 -0.002694 0.002605 0.009047 -19595 1 0.000280 1560.000000 -0.000637 -0.002499 0.008042 -19596 1 0.000197 1560.000000 0.002549 0.000761 0.008043 -19597 1 0.000207 1560.000000 -0.003667 -0.000200 0.005383 -19598 1 0.000213 1560.000000 -0.001380 0.003442 0.002901 -19599 1 0.000195 1560.000000 -0.000759 0.001673 0.006091 -19600 1 0.000221 1560.000000 -0.001296 0.001171 0.003264 -19601 1 0.000251 1560.000000 0.002154 -0.002437 0.001699 -19602 1 0.000220 1560.000000 -0.000831 0.003314 0.006488 -19603 1 0.000272 1560.000000 0.002908 0.001861 0.002793 -19604 1 0.000231 1560.000000 0.000898 0.003038 0.008471 -19605 1 0.000270 1560.000000 -0.001235 -0.003040 0.003206 -19606 1 0.000199 1560.000000 0.001440 0.002181 0.003865 -19607 1 0.000257 1560.000000 0.001700 -0.000500 0.000375 -19608 1 0.000205 1560.000000 0.000663 -0.002280 0.003355 -19609 1 0.000277 1560.000000 0.002997 -0.002312 0.002277 -19610 1 0.000224 1560.000000 0.002569 0.002507 0.003738 -19611 1 0.000220 1560.000000 0.000667 -0.003177 0.004489 -19612 1 0.000197 1560.000000 -0.001555 0.000384 0.001479 -19613 1 0.000204 1560.000000 0.000629 -0.002804 0.004464 -19614 1 0.000211 1560.000000 0.001924 -0.000206 0.001470 -19615 1 0.000279 1560.000000 -0.000702 0.000382 0.007993 -19616 1 0.000198 1560.000000 0.001397 -0.002990 0.000466 -19617 1 0.000242 1560.000000 -0.000316 -0.003332 0.007384 -19618 1 0.000276 1560.000000 0.000235 -0.003368 0.007263 -19619 1 0.000196 1560.000000 -0.001056 0.000732 0.001557 -19620 1 0.000274 1560.000000 -0.002615 -0.001319 0.009841 -19621 1 0.000214 1560.000000 -0.001414 0.000227 0.002731 -19622 1 0.000192 1560.000000 0.001315 0.001507 0.002387 -19623 1 0.000243 1560.000000 -0.003708 0.001010 0.009769 -19624 1 0.000196 1560.000000 -0.000246 -0.001932 0.001493 -19625 1 0.000243 1560.000000 0.000804 -0.000412 0.002151 -19626 1 0.000236 1560.000000 0.000937 0.001003 0.004942 -19627 1 0.000271 1560.000000 0.002759 0.000366 0.005519 -19628 1 0.000269 1560.000000 0.000493 0.003485 0.006937 -19629 1 0.000279 1560.000000 0.002844 -0.001830 0.006270 -19630 1 0.000195 1560.000000 0.000263 -0.003693 0.003712 -19631 1 0.000270 1560.000000 -0.002179 -0.001290 0.008691 -19632 1 0.000248 1560.000000 0.002005 0.000944 0.002402 -19633 1 0.000197 1560.000000 -0.000730 -0.002905 0.002214 -19634 1 0.000212 1560.000000 0.000138 0.002083 0.001200 -19635 1 0.000233 1560.000000 -0.000677 0.002390 0.009805 -19636 1 0.000193 1560.000000 -0.000025 -0.003839 0.009608 -19637 1 0.000203 1560.000000 -0.000660 -0.002954 0.002655 -19638 1 0.000223 1560.000000 0.001129 0.003661 0.003586 -19639 1 0.000247 1560.000000 -0.003561 0.000539 0.002510 -19640 1 0.000278 1560.000000 -0.000228 -0.003486 0.009794 -19641 1 0.000210 1560.000000 -0.003207 0.000487 0.009277 -19642 1 0.000217 1560.000000 0.000676 -0.001468 0.005428 -19643 1 0.000197 1560.000000 0.000494 -0.001238 0.005790 -19644 1 0.000201 1560.000000 -0.001535 -0.003102 0.002619 -19645 1 0.000245 1560.000000 -0.000985 -0.001052 0.001892 -19646 1 0.000193 1560.000000 -0.000274 0.000493 0.001722 -19647 1 0.000230 1560.000000 0.000451 0.000342 0.000816 -19648 1 0.000212 1560.000000 0.000899 0.002762 0.004188 -19649 1 0.000211 1560.000000 0.000128 -0.003727 0.000184 -19650 1 0.000209 1560.000000 0.000149 -0.002149 0.008167 -19651 1 0.000276 1560.000000 -0.003622 0.001305 0.005941 -19652 1 0.000270 1560.000000 0.003260 -0.001929 0.005140 -19653 1 0.000251 1560.000000 0.001765 0.002992 0.009459 -19654 1 0.000195 1560.000000 -0.000925 -0.003410 0.004644 -19655 1 0.000257 1560.000000 0.003431 -0.000979 0.007542 -19656 1 0.000286 1560.000000 0.003702 -0.001073 0.002415 -19657 1 0.000208 1560.000000 0.000786 -0.003444 0.006467 -19658 1 0.000242 1560.000000 0.001520 -0.002130 0.000889 -19659 1 0.000192 1560.000000 -0.002944 0.001465 0.000784 -19660 1 0.000211 1560.000000 -0.003055 -0.002169 0.003683 -19661 1 0.000195 1560.000000 -0.001297 -0.002261 0.005484 -19662 1 0.000266 1560.000000 -0.003497 0.000944 0.000355 -19663 1 0.000276 1560.000000 -0.003452 0.001678 0.005858 -19664 1 0.000271 1560.000000 -0.003019 0.002319 0.007580 -19665 1 0.000268 1560.000000 0.001884 0.003314 0.007985 -19666 1 0.000278 1560.000000 -0.003149 0.002222 0.001432 -19667 1 0.000272 1560.000000 -0.002924 -0.002069 0.000199 -19668 1 0.000227 1560.000000 -0.002583 -0.000950 0.004965 -19669 1 0.000196 1560.000000 0.000431 0.000303 0.005816 -19670 1 0.000210 1560.000000 -0.003081 -0.001682 0.006237 -19671 1 0.000255 1560.000000 -0.002378 -0.000207 0.008129 -19672 1 0.000250 1560.000000 -0.002224 0.002640 0.000130 -19673 1 0.000195 1560.000000 -0.000443 0.002830 0.008017 -19674 1 0.000204 1560.000000 0.001853 -0.003334 0.008990 -19675 1 0.000249 1560.000000 0.003061 -0.000914 0.007489 -19676 1 0.000193 1560.000000 -0.000500 0.001247 0.002240 -19677 1 0.000251 1560.000000 0.000237 -0.001920 0.009823 -19678 1 0.000278 1560.000000 -0.002943 -0.000518 0.001599 -19679 1 0.000214 1560.000000 -0.002655 0.001145 0.002137 -19680 1 0.000233 1560.000000 -0.002210 0.000915 0.001777 -19681 1 0.000283 1560.000000 0.000212 -0.003796 0.009496 -19682 1 0.000237 1560.000000 -0.001740 0.001305 0.007323 -19683 1 0.000269 1560.000000 -0.003400 0.001767 0.005534 -19684 1 0.000231 1560.000000 -0.001598 -0.000864 0.006779 -19685 1 0.000284 1560.000000 0.000477 -0.001909 0.004289 -19686 1 0.000246 1560.000000 0.000917 0.002074 0.006535 -19687 1 0.000277 1560.000000 0.003449 -0.000916 0.000575 -19688 1 0.000227 1560.000000 0.000244 -0.002010 0.007733 -19689 1 0.000203 1560.000000 0.000902 -0.000312 0.007394 -19690 1 0.000200 1560.000000 0.000838 -0.001412 0.003768 -19691 1 0.000221 1560.000000 -0.001596 -0.002971 0.001894 -19692 1 0.000269 1560.000000 -0.001561 -0.002402 0.001195 -19693 1 0.000242 1560.000000 -0.002346 -0.000659 0.006380 -19694 1 0.000211 1560.000000 0.003585 0.000677 0.009546 -19695 1 0.000231 1560.000000 -0.000428 0.003783 0.007750 -19696 1 0.000221 1560.000000 0.000272 -0.003473 0.004931 -19697 1 0.000218 1560.000000 0.002981 0.001503 0.005807 -19698 1 0.000240 1560.000000 0.002959 0.000316 0.007494 -19699 1 0.000225 1560.000000 0.003674 0.000775 0.002652 -19700 1 0.000246 1560.000000 0.000880 -0.002728 0.007985 -19701 1 0.000201 1560.000000 0.002426 -0.000032 0.000145 -19702 1 0.000268 1560.000000 -0.001131 -0.002308 0.003141 -19703 1 0.000271 1560.000000 0.002844 -0.001017 0.008208 -19704 1 0.000263 1560.000000 0.001311 0.002682 0.006926 -19705 1 0.000214 1560.000000 0.000211 -0.000552 0.009290 -19706 1 0.000248 1560.000000 -0.002181 0.002029 0.003810 -19707 1 0.000261 1560.000000 0.003486 -0.001530 0.000535 -19708 1 0.000216 1560.000000 0.000610 -0.002452 0.009546 -19709 1 0.000262 1560.000000 -0.003547 -0.000698 0.002127 -19710 1 0.000218 1560.000000 -0.001036 0.002712 0.008588 -19711 1 0.000245 1560.000000 -0.001077 -0.002334 0.000244 -19712 1 0.000197 1560.000000 -0.001791 -0.001228 0.005413 -19713 1 0.000248 1560.000000 -0.002869 0.001866 0.006936 -19714 1 0.000237 1560.000000 0.000735 0.001161 0.000146 -19715 1 0.000262 1560.000000 -0.002197 0.001522 0.004394 -19716 1 0.000213 1560.000000 -0.000674 0.002211 0.003410 -19717 1 0.000199 1560.000000 0.000835 -0.001033 0.001377 -19718 1 0.000230 1560.000000 -0.001912 -0.001190 0.001441 -19719 1 0.000205 1560.000000 -0.002057 -0.000555 0.001258 -19720 1 0.000226 1560.000000 -0.001536 0.001530 0.009359 -19721 1 0.000204 1560.000000 -0.003337 -0.001345 0.000129 -19722 1 0.000230 1560.000000 0.001455 -0.002425 0.004799 -19723 1 0.000218 1560.000000 -0.003744 0.000760 0.003223 -19724 1 0.000260 1560.000000 0.003456 0.000718 0.005866 -19725 1 0.000238 1560.000000 -0.002707 -0.002622 0.003946 -19726 1 0.000240 1560.000000 -0.000875 0.002727 0.004351 -19727 1 0.000258 1560.000000 -0.001532 0.003440 0.005139 -19728 1 0.000213 1560.000000 -0.000301 -0.001386 0.006601 -19729 1 0.000239 1560.000000 0.000000 0.002705 0.005448 -19730 1 0.000244 1560.000000 -0.002338 0.002689 0.004828 -19731 1 0.000224 1560.000000 -0.001029 -0.001848 0.004746 -19732 1 0.000238 1560.000000 0.002167 0.000795 0.007735 -19733 1 0.000200 1560.000000 0.000397 -0.000407 0.005995 -19734 1 0.000207 1560.000000 -0.002584 0.002252 0.003942 -19735 1 0.000256 1560.000000 0.001597 0.000923 0.000642 -19736 1 0.000194 1560.000000 -0.000618 -0.002727 0.000607 -19737 1 0.000267 1560.000000 -0.001585 0.003471 0.008296 -19738 1 0.000274 1560.000000 -0.002648 -0.002332 0.003577 -19739 1 0.000199 1560.000000 -0.001028 -0.002211 0.002555 -19740 1 0.000263 1560.000000 -0.001768 0.002281 0.002792 -19741 1 0.000222 1560.000000 0.002085 0.000188 0.005150 -19742 1 0.000196 1560.000000 0.000642 0.000756 0.001382 -19743 1 0.000240 1560.000000 0.001798 0.001604 0.001180 -19744 1 0.000263 1560.000000 -0.002772 0.001314 0.005183 -19745 1 0.000225 1560.000000 0.003081 -0.000371 0.001508 -19746 1 0.000217 1560.000000 0.001275 0.003282 0.009634 -19747 1 0.000201 1560.000000 0.000065 0.000119 0.000935 -19748 1 0.000194 1560.000000 0.001698 -0.000202 0.005207 -19749 1 0.000236 1560.000000 0.000101 -0.001821 0.001400 -19750 1 0.000272 1560.000000 0.001700 -0.002356 0.007801 -19751 1 0.000219 1560.000000 -0.002793 -0.001120 0.002692 -19752 1 0.000201 1560.000000 0.001657 -0.002647 0.003124 -19753 1 0.000259 1560.000000 0.002633 0.002354 0.001033 -19754 1 0.000236 1560.000000 0.002233 0.002668 0.000600 -19755 1 0.000280 1560.000000 0.000744 0.002121 0.005541 -19756 1 0.000202 1560.000000 -0.002753 -0.002678 0.004479 -19757 1 0.000203 1560.000000 -0.000447 0.000596 0.001448 -19758 1 0.000203 1560.000000 0.002073 0.002824 0.003880 -19759 1 0.000258 1560.000000 0.002479 -0.001655 0.000595 -19760 1 0.000249 1560.000000 0.002364 0.000369 0.002914 -19761 1 0.000264 1560.000000 0.001506 -0.001624 0.002477 -19762 1 0.000240 1560.000000 0.001932 0.002402 0.004535 -19763 1 0.000262 1560.000000 0.003691 0.000537 0.006238 -19764 1 0.000220 1560.000000 -0.000634 0.000749 0.006791 -19765 1 0.000268 1560.000000 -0.002313 -0.001427 0.004270 -19766 1 0.000244 1560.000000 0.000543 0.000662 0.001995 -19767 1 0.000215 1560.000000 0.000980 0.000464 0.008646 -19768 1 0.000230 1560.000000 -0.000055 -0.003813 0.002507 -19769 1 0.000276 1560.000000 -0.000268 0.000877 0.000671 -19770 1 0.000193 1560.000000 -0.001897 0.003334 0.000117 -19771 1 0.000262 1560.000000 -0.001710 -0.003451 0.002574 -19772 1 0.000246 1560.000000 0.003492 0.000017 0.001567 -19773 1 0.000194 1560.000000 -0.000541 0.003587 0.002827 -19774 1 0.000243 1560.000000 0.000993 -0.001361 0.007910 -19775 1 0.000225 1560.000000 -0.001998 0.000616 0.000904 -19776 1 0.000193 1560.000000 -0.001426 0.001808 0.001380 -19777 1 0.000209 1560.000000 0.000308 -0.001803 0.003423 -19778 1 0.000237 1560.000000 0.002108 0.002238 0.002971 -19779 1 0.000203 1560.000000 0.000318 -0.002835 0.007238 -19780 1 0.000252 1560.000000 0.000161 0.003746 0.005315 -19781 1 0.000270 1560.000000 0.001800 0.000228 0.000509 -19782 1 0.000260 1560.000000 0.001428 -0.003359 0.008255 -19783 1 0.000274 1560.000000 -0.001341 -0.002660 0.000149 -19784 1 0.000238 1560.000000 0.003444 -0.001127 0.001393 -19785 1 0.000261 1560.000000 0.001621 0.002660 0.005654 -19786 1 0.000254 1560.000000 -0.001405 0.001661 0.004561 -19787 1 0.000193 1560.000000 0.000087 0.001581 0.001722 -19788 1 0.000208 1560.000000 0.002036 0.000016 0.000116 -19789 1 0.000227 1560.000000 0.002848 -0.001920 0.007377 -19790 1 0.000200 1560.000000 0.001227 0.001595 0.007545 -19791 1 0.000252 1560.000000 -0.002521 -0.002907 0.004599 -19792 1 0.000276 1560.000000 -0.002099 -0.002937 0.005322 -19793 1 0.000209 1560.000000 0.002477 -0.001036 0.009787 -19794 1 0.000252 1560.000000 -0.001676 0.002100 0.006713 -19795 1 0.000237 1560.000000 -0.001327 -0.000294 0.002684 -19796 1 0.000240 1560.000000 0.002815 -0.000296 0.009013 -19797 1 0.000207 1560.000000 0.000929 -0.002138 0.006042 -19798 1 0.000233 1560.000000 0.000924 -0.000109 0.004590 -19799 1 0.000222 1560.000000 -0.003766 -0.000645 0.009083 -19800 1 0.000231 1560.000000 0.001227 -0.000356 0.000855 -19801 1 0.000274 1560.000000 0.003009 0.002398 0.008193 -19802 1 0.000205 1560.000000 0.001242 -0.003153 0.007862 -19803 1 0.000197 1560.000000 -0.000994 -0.000638 0.009349 -19804 1 0.000210 1560.000000 -0.001691 0.001129 0.002508 -19805 1 0.000232 1560.000000 0.002781 -0.001293 0.009780 -19806 1 0.000287 1560.000000 -0.000940 0.002231 0.008501 -19807 1 0.000218 1560.000000 -0.001155 0.001508 0.002122 -19808 1 0.000225 1560.000000 0.000763 0.002762 0.009486 -19809 1 0.000201 1560.000000 0.000009 -0.000053 0.000105 -19810 1 0.000236 1560.000000 0.001936 -0.002056 0.005113 -19811 1 0.000279 1560.000000 0.000248 -0.002418 0.006168 -19812 1 0.000270 1560.000000 -0.003555 0.000849 0.009163 -19813 1 0.000225 1560.000000 0.002795 0.002146 0.002362 -19814 1 0.000236 1560.000000 0.001843 -0.000945 0.009807 -19815 1 0.000277 1560.000000 -0.002440 -0.002890 0.009489 -19816 1 0.000266 1560.000000 -0.003812 -0.000413 0.006080 -19817 1 0.000221 1560.000000 0.001485 0.000509 0.007025 -19818 1 0.000202 1560.000000 0.000131 0.000609 0.006390 -19819 1 0.000225 1560.000000 -0.003348 0.000758 0.005300 -19820 1 0.000284 1560.000000 0.001767 0.000957 0.008259 -19821 1 0.000241 1560.000000 -0.002046 0.000037 0.006388 -19822 1 0.000261 1560.000000 -0.002180 0.002349 0.005166 -19823 1 0.000234 1560.000000 -0.001502 -0.003046 0.007437 -19824 1 0.000230 1560.000000 -0.003722 0.000898 0.008304 -19825 1 0.000226 1560.000000 0.000044 -0.000630 0.002863 -19826 1 0.000217 1560.000000 0.002597 0.001760 0.003101 -19827 1 0.000214 1560.000000 -0.002721 0.001364 0.001538 -19828 1 0.000203 1560.000000 0.002187 0.000501 0.008456 -19829 1 0.000195 1560.000000 -0.002455 0.001340 0.008322 -19830 1 0.000207 1560.000000 -0.000372 -0.000538 0.002504 -19831 1 0.000214 1560.000000 0.002913 -0.000619 0.003780 -19832 1 0.000221 1560.000000 -0.000094 0.003842 0.007756 -19833 1 0.000259 1560.000000 0.001908 -0.000666 0.000717 -19834 1 0.000209 1560.000000 -0.002513 0.000468 0.008139 -19835 1 0.000227 1560.000000 0.000051 -0.002301 0.007306 -19836 1 0.000231 1560.000000 0.000921 0.001558 0.005006 -19837 1 0.000200 1560.000000 -0.000348 -0.001185 0.009613 -19838 1 0.000266 1560.000000 -0.002276 -0.003097 0.004220 -19839 1 0.000258 1560.000000 0.002051 0.000099 0.007673 -19840 1 0.000281 1560.000000 -0.001832 0.000160 0.004914 -19841 1 0.000262 1560.000000 0.000359 -0.002289 0.002966 -19842 1 0.000212 1560.000000 -0.003179 0.001263 0.001932 -19843 1 0.000199 1560.000000 -0.002120 -0.002842 0.004074 -19844 1 0.000256 1560.000000 -0.001740 0.002552 0.003662 -19845 1 0.000193 1560.000000 0.000965 0.002119 0.000611 -19846 1 0.000267 1560.000000 -0.003238 -0.001469 0.001295 -19847 1 0.000201 1560.000000 0.000459 0.002858 0.008164 -19848 1 0.000245 1560.000000 -0.001078 0.003245 0.003476 -19849 1 0.000267 1560.000000 0.000129 0.003118 0.003736 -19850 1 0.000212 1560.000000 0.001331 0.001678 0.007153 -19851 1 0.000204 1560.000000 -0.001559 0.003518 0.005852 -19852 1 0.000201 1560.000000 -0.002266 0.000548 0.007871 -19853 1 0.000263 1560.000000 0.001847 -0.002994 0.005103 -19854 1 0.000217 1560.000000 -0.002631 -0.000769 0.001013 -19855 1 0.000262 1560.000000 -0.000953 0.003716 0.007085 -19856 1 0.000266 1560.000000 0.000368 0.002188 0.007568 -19857 1 0.000278 1560.000000 0.000856 -0.003394 0.007214 -19858 1 0.000223 1560.000000 -0.003084 -0.001764 0.001024 -19859 1 0.000249 1560.000000 0.000306 0.002475 0.003698 -19860 1 0.000255 1560.000000 0.003577 0.001421 0.009192 -19861 1 0.000212 1560.000000 0.000762 -0.002327 0.006008 -19862 1 0.000211 1560.000000 0.001389 -0.000569 0.003430 -19863 1 0.000256 1560.000000 0.001763 0.001475 0.008409 -19864 1 0.000252 1560.000000 0.000068 0.003522 0.002778 -19865 1 0.000235 1560.000000 0.002333 0.001416 0.006597 -19866 1 0.000260 1560.000000 0.000477 0.000903 0.003732 -19867 1 0.000265 1560.000000 -0.003470 -0.001237 0.004527 -19868 1 0.000202 1560.000000 0.000248 0.003032 0.008062 -19869 1 0.000228 1560.000000 -0.000355 -0.003719 0.009813 -19870 1 0.000262 1560.000000 0.001305 -0.002528 0.001263 -19871 1 0.000202 1560.000000 -0.001497 0.002137 0.006361 -19872 1 0.000199 1560.000000 0.001276 0.001167 0.005151 -19873 1 0.000283 1560.000000 0.002432 -0.002360 0.001251 -19874 1 0.000235 1560.000000 -0.001186 -0.002115 0.003657 -19875 1 0.000207 1560.000000 -0.003598 -0.001306 0.002310 -19876 1 0.000234 1560.000000 0.001433 0.000572 0.005103 -19877 1 0.000214 1560.000000 0.003109 -0.001663 0.003644 -19878 1 0.000212 1560.000000 0.002451 0.001334 0.008956 -19879 1 0.000228 1560.000000 0.003358 0.001892 0.004306 -19880 1 0.000283 1560.000000 0.001955 -0.003317 0.002822 -19881 1 0.000268 1560.000000 0.001801 0.002668 0.000141 -19882 1 0.000227 1560.000000 -0.001714 -0.001474 0.003364 -19883 1 0.000256 1560.000000 0.002800 0.002008 0.004547 -19884 1 0.000203 1560.000000 0.002055 0.002817 0.004351 -19885 1 0.000203 1560.000000 0.000774 0.000678 0.003527 -19886 1 0.000231 1560.000000 0.003102 -0.000806 0.003761 -19887 1 0.000219 1560.000000 -0.003288 0.000534 0.001300 -19888 1 0.000230 1560.000000 -0.001880 0.000189 0.005221 -19889 1 0.000239 1560.000000 -0.001069 0.003072 0.004067 -19890 1 0.000263 1560.000000 0.001011 -0.002359 0.008554 -19891 1 0.000234 1560.000000 0.001311 -0.000576 0.008131 -19892 1 0.000269 1560.000000 0.000493 0.003014 0.009831 -19893 1 0.000277 1560.000000 -0.000175 0.003401 0.004380 -19894 1 0.000218 1560.000000 -0.001773 0.002981 0.004790 -19895 1 0.000265 1560.000000 0.001280 -0.001593 0.004065 -19896 1 0.000203 1560.000000 -0.000657 -0.001780 0.003404 -19897 1 0.000267 1560.000000 0.001486 0.002818 0.008011 -19898 1 0.000194 1560.000000 0.002294 -0.002620 0.006404 -19899 1 0.000277 1560.000000 0.000693 -0.003448 0.000507 -19900 1 0.000256 1560.000000 0.001558 0.002635 0.006536 -19901 1 0.000220 1560.000000 -0.000129 -0.003419 0.004075 -19902 1 0.000213 1560.000000 0.000023 0.003202 0.008543 -19903 1 0.000285 1560.000000 -0.002539 0.002544 0.003400 -19904 1 0.000270 1560.000000 -0.000615 -0.001670 0.001913 -19905 1 0.000215 1560.000000 -0.000196 -0.001848 0.008866 -19906 1 0.000194 1560.000000 -0.001573 -0.001931 0.005858 -19907 1 0.000287 1560.000000 0.001826 -0.000944 0.000988 -19908 1 0.000215 1560.000000 -0.001178 -0.002268 0.001799 -19909 1 0.000192 1560.000000 -0.000542 0.001476 0.008003 -19910 1 0.000196 1560.000000 0.001782 -0.000300 0.000216 -19911 1 0.000235 1560.000000 -0.000422 -0.000149 0.007324 -19912 1 0.000213 1560.000000 -0.001505 -0.001229 0.002803 -19913 1 0.000214 1560.000000 -0.001881 -0.002535 0.005837 -19914 1 0.000209 1560.000000 -0.000194 -0.000957 0.004538 -19915 1 0.000196 1560.000000 0.000877 0.000388 0.003723 -19916 1 0.000215 1560.000000 -0.000762 -0.001214 0.001397 -19917 1 0.000248 1560.000000 -0.001226 0.001842 0.009600 -19918 1 0.000281 1560.000000 0.003226 0.002031 0.002732 -19919 1 0.000256 1560.000000 -0.003042 -0.001805 0.009470 -19920 1 0.000212 1560.000000 -0.003245 -0.001670 0.006907 -19921 1 0.000225 1560.000000 0.000487 -0.001905 0.007535 -19922 1 0.000278 1560.000000 -0.001848 0.001598 0.009574 -19923 1 0.000288 1560.000000 -0.001485 -0.002399 0.007973 -19924 1 0.000216 1560.000000 0.001232 -0.002443 0.000415 -19925 1 0.000198 1560.000000 -0.003117 0.001250 0.009208 -19926 1 0.000264 1560.000000 -0.000575 -0.001821 0.005444 -19927 1 0.000270 1560.000000 0.001688 0.002553 0.007853 -19928 1 0.000225 1560.000000 0.000693 -0.000524 0.003969 -19929 1 0.000229 1560.000000 -0.002572 0.000256 0.003634 -19930 1 0.000236 1560.000000 -0.001192 -0.001354 0.008475 -19931 1 0.000277 1560.000000 -0.001318 0.003361 0.009592 -19932 1 0.000273 1560.000000 0.002254 0.000847 0.006608 -19933 1 0.000253 1560.000000 -0.003229 -0.001493 0.000548 -19934 1 0.000221 1560.000000 0.002321 0.001015 0.000164 -19935 1 0.000209 1560.000000 0.001845 -0.001675 0.009434 -19936 1 0.000258 1560.000000 -0.001460 -0.000778 0.008982 -19937 1 0.000195 1560.000000 -0.000105 0.000456 0.000441 -19938 1 0.000199 1560.000000 -0.000410 0.002059 0.007657 -19939 1 0.000204 1560.000000 -0.002126 -0.001814 0.001987 -19940 1 0.000258 1560.000000 -0.000047 -0.000555 0.000962 -19941 1 0.000227 1560.000000 0.001002 0.001685 0.008393 -19942 1 0.000228 1560.000000 0.002008 -0.001421 0.001786 -19943 1 0.000271 1560.000000 0.001714 -0.002089 0.002291 -19944 1 0.000205 1560.000000 -0.000968 0.002884 0.000611 -19945 1 0.000204 1560.000000 -0.001227 -0.002210 0.005301 -19946 1 0.000221 1560.000000 0.002629 -0.001472 0.009817 -19947 1 0.000287 1560.000000 0.003698 -0.001076 0.004690 -19948 1 0.000201 1560.000000 0.000283 -0.002481 0.001119 -19949 1 0.000238 1560.000000 0.002664 -0.002754 0.000929 -19950 1 0.000203 1560.000000 0.001186 0.003634 0.001679 -19951 1 0.000258 1560.000000 0.001354 0.000712 0.003762 -19952 1 0.000236 1560.000000 -0.003424 -0.001632 0.005202 -19953 1 0.000196 1560.000000 -0.002017 0.002288 0.008486 -19954 1 0.000258 1560.000000 0.000699 -0.002127 0.009174 -19955 1 0.000280 1560.000000 -0.003516 0.001573 0.002196 -19956 1 0.000252 1560.000000 0.000559 -0.002283 0.008425 -19957 1 0.000248 1560.000000 0.001080 -0.001452 0.000342 -19958 1 0.000200 1560.000000 -0.001178 -0.000749 0.007211 -19959 1 0.000252 1560.000000 0.001848 0.000370 0.003364 -19960 1 0.000202 1560.000000 -0.001756 0.001309 0.005660 -19961 1 0.000287 1560.000000 0.002276 0.001964 0.009240 -19962 1 0.000270 1560.000000 -0.002722 0.002377 0.000138 -19963 1 0.000201 1560.000000 0.000273 0.001734 0.002117 -19964 1 0.000247 1560.000000 -0.001234 0.002693 0.007387 -19965 1 0.000216 1560.000000 -0.000574 -0.001814 0.003056 -19966 1 0.000214 1560.000000 0.001082 -0.000118 0.007543 -19967 1 0.000198 1560.000000 0.000872 -0.000828 0.000617 -19968 1 0.000239 1560.000000 0.002587 0.000932 0.006981 -19969 1 0.000193 1560.000000 0.001119 0.003664 0.006192 -19970 1 0.000208 1560.000000 -0.002833 0.002046 0.003041 -19971 1 0.000208 1560.000000 -0.000632 -0.002640 0.004118 -19972 1 0.000288 1560.000000 -0.001971 -0.000101 0.009826 -19973 1 0.000213 1560.000000 -0.000835 -0.001877 0.000953 -19974 1 0.000192 1560.000000 0.000357 -0.000454 0.001912 -19975 1 0.000218 1560.000000 0.003063 -0.001638 0.008629 -19976 1 0.000273 1560.000000 -0.002426 -0.001254 0.002722 -19977 1 0.000280 1560.000000 -0.002609 0.001609 0.005802 -19978 1 0.000225 1560.000000 0.000432 -0.000884 0.004952 -19979 1 0.000222 1560.000000 -0.002711 0.001824 0.001354 -19980 1 0.000219 1560.000000 0.001300 -0.001689 0.001094 -19981 1 0.000196 1560.000000 0.002649 0.002044 0.008054 -19982 1 0.000278 1560.000000 0.000433 0.003322 0.008212 -19983 1 0.000216 1560.000000 -0.001584 -0.001766 0.002120 -19984 1 0.000204 1560.000000 0.001143 0.000976 0.001686 -19985 1 0.000208 1560.000000 -0.002481 0.001943 0.005111 -19986 1 0.000270 1560.000000 -0.002097 0.002391 0.003665 -19987 1 0.000213 1560.000000 0.002486 -0.001057 0.001452 -19988 1 0.000258 1560.000000 -0.003282 -0.001986 0.001270 -19989 1 0.000231 1560.000000 0.002804 -0.000974 0.004409 -19990 1 0.000193 1560.000000 0.000048 -0.001120 0.006233 -19991 1 0.000240 1560.000000 0.000898 0.002289 0.006843 -19992 1 0.000231 1560.000000 0.001333 0.002892 0.005815 -19993 1 0.000201 1560.000000 -0.000500 0.000185 0.006474 -19994 1 0.000253 1560.000000 -0.002348 0.000513 0.001093 -19995 1 0.000204 1560.000000 -0.001873 -0.000625 0.007402 -19996 1 0.000221 1560.000000 0.003591 -0.000732 0.002128 -19997 1 0.000241 1560.000000 0.002089 0.003237 0.000305 -19998 1 0.000219 1560.000000 -0.002840 0.000644 0.009180 -19999 1 0.000200 1560.000000 -0.003677 -0.000670 0.006216 -20000 1 0.000201 1560.000000 0.002765 0.002443 0.001843 From aecbc2112371ceac9546d043265163160f85b505 Mon Sep 17 00:00:00 2001 From: William Zunker Date: Sun, 22 Dec 2024 18:04:33 -0500 Subject: [PATCH 23/74] Modified tableting sim parameters to reduce runtime --- examples/granular/in.avicelTableting200 | 10 +++++----- 1 file changed, 5 insertions(+), 5 deletions(-) diff --git a/examples/granular/in.avicelTableting200 b/examples/granular/in.avicelTableting200 index 8fe3251d78..863436bade 100644 --- a/examples/granular/in.avicelTableting200 +++ b/examples/granular/in.avicelTableting200 @@ -6,8 +6,8 @@ comm_modify vel yes units si newton off neighbor 1.0e-3 bin -neigh_modify every 10 delay 2000 check no -timestep 1.35e-7 +neigh_modify every 10 delay 60 check no +timestep 4e-6 #processors 2 2 1 ######################### SIMULATION BOUNDING BOX, INTEGRATION, AND, GRAVITY ########################### @@ -29,10 +29,10 @@ variable dieHeight equal 1e-2 pair_style granular # mdr = E, nu, Y, gamma, psi_b, CoR # linear_history = k_t, x_gamma,t, mu_s -variable YoungsModulus equal 5e9 -variable YieldStress equal 1.9e8 +variable YoungsModulus equal 5e6 +variable YieldStress equal 1.9e5 variable PoissonsRatio equal 0.4 -variable SurfaceEnergy equal 2000 +variable SurfaceEnergy equal 2 variable SurfaceEnergyWall equal 0.0 variable CoR equal 0.5 variable psi_b equal 0.5 From a9ce245527cce91d853d7c58d13b3cd9a6431478 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Tue, 24 Dec 2024 10:33:13 -0700 Subject: [PATCH 24/74] Converting history indices to an enum --- src/GRANULAR/fix_granular_mdr.cpp | 59 ++++++++----------- src/GRANULAR/fix_granular_mdr.h | 32 ++++++++++ src/GRANULAR/gran_sub_mod_normal.cpp | 88 ++++++++++------------------ 3 files changed, 89 insertions(+), 90 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index ab99083344..e79869aeaa 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -40,6 +40,7 @@ using namespace LAMMPS_NS; using namespace Granular_NS; +using namespace Granular_MDR_NS; using namespace FixConst; using MathConst::MY_PI; @@ -547,10 +548,10 @@ void FixGranularMDR::mean_surf_disp() NeighList * list = pair->list; const int size_history = pair->get_size_history(); - int i,j,k,ii,jj,inum,jnum,itype,jtype; - int *ilist,*jlist,*numneigh,**firstneigh; - int *touch,**firsttouch; - double *history,*allhistory,**firsthistory; + int i, j, k, ii, jj, inum, jnum, itype, jtype; + int *ilist, *jlist, *numneigh, **firstneigh; + int *touch, **firsttouch; + double *history, *allhistory, **firsthistory; bool touchflag = false; class GranularModel* model; @@ -612,22 +613,14 @@ void FixGranularMDR::mean_surf_disp() const double delta = model->radsum - sqrt(model->rsq); - const int delta_offset_0 = 0; // apparent overlap - const int delta_offset_1 = 1; - const int Ac_offset_0 = 18; // contact area - const int Ac_offset_1 = 19; - const int deltamax_offset_ = 23; - const int deltap_offset_0 = 24; - const int deltap_offset_1 = 25; - - double deltamax = history[deltamax_offset_]; - double deltap0 = history[deltap_offset_0]; - double deltap1 = history[deltap_offset_1]; + double deltamax = history[DELTA_MAX]; + double deltap0 = history[DELTAP_0]; + double deltap1 = history[DELTAP_1]; if (delta > deltamax) deltamax = delta; - double delta0old = history[delta_offset_0]; - double delta1old = history[delta_offset_1]; + double delta0old = history[DELTA_0]; + double delta1old = history[DELTA_1]; int i0; int i1; @@ -644,37 +637,37 @@ void FixGranularMDR::mean_surf_disp() double delta_geo0; double delta_geo1; - double deltaOpt1 = deltamax*(deltamax - 2.0*R1)/(2.0*(deltamax - R0 - R1)); - double deltaOpt2 = deltamax*(deltamax - 2.0*R0)/(2.0*(deltamax - R0 - R1)); - (R0 < R1) ? delta_geo0 = MAX(deltaOpt1,deltaOpt2) : delta_geo0 = MIN(deltaOpt1,deltaOpt2); - (R0 < R1) ? delta_geo1 = MIN(deltaOpt1,deltaOpt2) : delta_geo1 = MAX(deltaOpt1,deltaOpt2); + double deltaOpt1 = deltamax * (deltamax - 2.0 * R1) / (2.0 * (deltamax - R0 - R1)); + double deltaOpt2 = deltamax * (deltamax - 2.0 * R0) / (2.0 * (deltamax - R0 - R1)); + (R0 < R1) ? delta_geo0 = MAX(deltaOpt1, deltaOpt2) : delta_geo0 = MIN(deltaOpt1, deltaOpt2); + (R0 < R1) ? delta_geo1 = MIN(deltaOpt1, deltaOpt2) : delta_geo1 = MAX(deltaOpt1, deltaOpt2); double overlap_limit = 0.75; - if (delta_geo0/R0 > overlap_limit) { - delta_geo0 = R0*overlap_limit; + if (delta_geo0 / R0 > overlap_limit) { + delta_geo0 = R0 * overlap_limit; delta_geo1 = deltamax - delta_geo0; - } else if (delta_geo1/R1 > overlap_limit) { - delta_geo1 = R1*overlap_limit; + } else if (delta_geo1 / R1 > overlap_limit) { + delta_geo1 = R1 * overlap_limit; delta_geo0 = deltamax - delta_geo1; } double deltap = deltap0 + deltap1; - double delta0 = delta_geo0 + (deltap0 - delta_geo0)/(deltap - deltamax)*(delta-deltamax); - double delta1 = delta_geo1 + (deltap1 - delta_geo1)/(deltap - deltamax)*(delta-deltamax); + double delta0 = delta_geo0 + (deltap0 - delta_geo0) / (deltap - deltamax) * (delta - deltamax); + double delta1 = delta_geo1 + (deltap1 - delta_geo1) / (deltap - deltamax) * (delta - deltamax); double ddel0 = delta0 - delta0old; double ddel1 = delta1 - delta1old; if (Acon0[i0] != 0.0) { - const double Ac_offset0 = history[Ac_offset_0]; - ddelta_bar[i0] += Ac_offset0/Acon0[i0]*ddel0; + const double Ac_offset0 = history[AC_0]; + ddelta_bar[i0] += Ac_offset0 / Acon0[i0] * ddel0; } if (Acon0[i1] != 0.0) { - const double Ac_offset1 = history[Ac_offset_1]; - ddelta_bar[i1] += Ac_offset1/Acon0[i1]*ddel1; + const double Ac_offset1 = history[AC_1]; + ddelta_bar[i1] += Ac_offset1 / Acon0[i1] * ddel1; } } } @@ -698,7 +691,7 @@ void FixGranularMDR::update_fix_gran_wall(Fix* fix_in) model->history_update = history_update; int regiondynamic = region->dynamic_check(); - if (!regiondynamic) vwall[0] = vwall[1] = vwall[2] = 00; + if (!regiondynamic) vwall[0] = vwall[1] = vwall[2] = 0; double **x = atom->x; double *radius = atom->radius; @@ -762,7 +755,7 @@ void FixGranularMDR::update_fix_gran_wall(Fix* fix_in) const double delta_offset0 = fix->history_many[i][fix->c2r[ic]][0]; const double ddelta = delta - delta_offset0; const double Ac_offset0 = fix->history_many[i][fix->c2r[ic]][18]; - ddelta_bar[i] += wij*Ac_offset0/Acon0[i]*ddelta; + ddelta_bar[i] += wij * Ac_offset0 / Acon0[i] * ddelta; } } } diff --git a/src/GRANULAR/fix_granular_mdr.h b/src/GRANULAR/fix_granular_mdr.h index 7dbc500499..caa90621c3 100644 --- a/src/GRANULAR/fix_granular_mdr.h +++ b/src/GRANULAR/fix_granular_mdr.h @@ -23,6 +23,38 @@ FixStyle(GRANULAR/MDR,FixGranularMDR); #include "fix.h" namespace LAMMPS_NS { +namespace Granular_MDR_NS { + + enum HistoryIndex { + DELTA_0 = 0, // apparent overlap + DELTA_1, + DELTAO_0, // displacement + DELTAO_1, + DELTA_MDR_0, // MDR apparent overlap + DELTA_MDR_1, + DELTA_BULK_0, // bulk displacement + DELTA_BULK_1, + DELTAMAX_MDR_0, // maximum MDR apparent overlap + DELTAMAX_MDR_1, + YFLAG_0, // yield flag + YFLAG_1, + DELTAY_0, // yield displacement + DELTAY_1, + CA_0, // contact area intercept + CA_1, + AADH_0, // adhesive contact radius + AADH_1, + AC_0, // contact area + AC_1, + EPS_BAR_0, // volume-averaged infinitesimal sor + EPS_BAR_1, + PENALTY, // contact penalty + DELTA_MAX, + DELTAP_0, + DELTAP_1 + }; + +} // namespace Granular_MDR_NS class FixGranularMDR : public Fix { public: diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 927afe637a..ac7ff1ffcd 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -16,6 +16,7 @@ #include "atom.h" #include "error.h" #include "citeme.h" +#include "fix_granular_mdr.h" #include "granular_model.h" #include "math_const.h" #include "modify.h" @@ -494,6 +495,7 @@ void GranSubModNormalMDR::init() double GranSubModNormalMDR::calculate_forces() { + using namespace Granular_MDR_NS; // To understand the structure of the overall code it is important to consider // the following: // @@ -545,41 +547,13 @@ double GranSubModNormalMDR::calculate_forces() int i1 = 0; double delta = gm->delta; // apparent overlap - // initialize indexing in history array of different constact history variables - const int delta_offset_0 = 0; // apparent overlap - const int delta_offset_1 = 1; - const int deltao_offset_0 = 2; // displacement - const int deltao_offset_1 = 3; - const int delta_MDR_offset_0 = 4; // MDR apparent overlap - const int delta_MDR_offset_1 = 5; - const int delta_BULK_offset_0 = 6; // bulk displacement - const int delta_BULK_offset_1 = 7; - const int deltamax_MDR_offset_0 = 8; // maximum MDR apparent overlap - const int deltamax_MDR_offset_1 = 9; - const int Yflag_offset_0 = 10; // yield flag - const int Yflag_offset_1 = 11; - const int deltaY_offset_0 = 12; // yield displacement - const int deltaY_offset_1 = 13; - const int cA_offset_0 = 14; // contact area intercept - const int cA_offset_1 = 15; - const int aAdh_offset_0 = 16; // adhesive contact radius - const int aAdh_offset_1 = 17; - const int Ac_offset_0 = 18; // contact area - const int Ac_offset_1 = 19; - const int eps_bar_offset_0 = 20; // volume-averaged infinitesimal strain tensor - const int eps_bar_offset_1 = 21; - const int penalty_offset_ = 22; // contact penalty - const int deltamax_offset_ = 23; - const int deltap_offset_0 = 24; - const int deltap_offset_1 = 25; - double * history = & gm->history[history_index]; // load in all history variables // Rigid flat placement scheme - double * deltamax_offset = & history[deltamax_offset_]; + double * deltamax_offset = & history[DELTA_MAX]; double deltamax = *deltamax_offset; - double * deltap_offset0 = & history[deltap_offset_0]; - double * deltap_offset1 = & history[deltap_offset_1]; + double * deltap_offset0 = & history[DELTAP_0]; + double * deltap_offset1 = & history[DELTAP_1]; double deltap0 = *deltap_offset0; double deltap1 = *deltap_offset1; @@ -627,18 +601,18 @@ double GranSubModNormalMDR::calculate_forces() delta = delta_geo + (deltap0 - delta_geo)/(deltap - deltamax)*(gm->delta-deltamax); } - delta_offset = & history[delta_offset_0]; - deltao_offset = & history[deltao_offset_0]; - delta_MDR_offset = & history[delta_MDR_offset_0]; - delta_BULK_offset = & history[delta_BULK_offset_0]; - deltamax_MDR_offset = & history[deltamax_MDR_offset_0]; - Yflag_offset = & history[Yflag_offset_0]; - deltaY_offset = & history[deltaY_offset_0]; - cA_offset = & history[cA_offset_0]; - aAdh_offset = & history[aAdh_offset_0]; - Ac_offset = & history[Ac_offset_0]; - eps_bar_offset = & history[eps_bar_offset_0]; - deltap_offset = & history[deltap_offset_0]; + delta_offset = & history[DELTA_0]; + deltao_offset = & history[DELTAO_0]; + delta_MDR_offset = & history[DELTA_MDR_0]; + delta_BULK_offset = & history[DELTA_BULK_0]; + deltamax_MDR_offset = & history[DELTAMAX_MDR_0]; + Yflag_offset = & history[YFLAG_0]; + deltaY_offset = & history[DELTAY_0]; + cA_offset = & history[CA_0]; + aAdh_offset = & history[AADH_0]; + Ac_offset = & history[AC_0]; + eps_bar_offset = & history[EPS_BAR_0]; + deltap_offset = & history[DELTAP_0]; } else { if (gm->contact_type != PAIR) break; // contact with particle-wall requires only one evaluation if (itag_true < jtag_true) { @@ -668,18 +642,18 @@ double GranSubModNormalMDR::calculate_forces() double deltap = deltap0 + deltap1; delta = delta_geo + (deltap1 - delta_geo)/(deltap - deltamax)*(gm->delta-deltamax); - delta_offset = & history[delta_offset_1]; - deltao_offset = & history[deltao_offset_1]; - delta_MDR_offset = & history[delta_MDR_offset_1]; - delta_BULK_offset = & history[delta_BULK_offset_1]; - deltamax_MDR_offset = & history[deltamax_MDR_offset_1]; - Yflag_offset = & history[Yflag_offset_1]; - deltaY_offset = & history[deltaY_offset_1]; - cA_offset = & history[cA_offset_1]; - aAdh_offset = & history[aAdh_offset_1]; - Ac_offset = & history[Ac_offset_1]; - eps_bar_offset = & history[eps_bar_offset_1]; - deltap_offset = & history[deltap_offset_1]; + delta_offset = & history[DELTA_1]; + deltao_offset = & history[DELTAO_1]; + delta_MDR_offset = & history[DELTA_MDR_1]; + delta_BULK_offset = & history[DELTA_BULK_1]; + deltamax_MDR_offset = & history[DELTAMAX_MDR_1]; + Yflag_offset = & history[YFLAG_1]; + deltaY_offset = & history[DELTAY_1]; + cA_offset = & history[CA_1]; + aAdh_offset = & history[AADH_1]; + Ac_offset = & history[AC_1]; + eps_bar_offset = & history[EPS_BAR_1]; + deltap_offset = & history[DELTAP_1]; } // temporary i and j indices @@ -834,7 +808,7 @@ double GranSubModNormalMDR::calculate_forces() adhesive_length[i] += aAdh; // contact penalty scheme - penalty_offset = & history[penalty_offset_]; + penalty_offset = & history[PENALTY]; double pij = *penalty_offset; const double wij = std::max(1.0-pij,0.0); @@ -886,7 +860,7 @@ double GranSubModNormalMDR::calculate_forces() gm->radi = radi_true; gm->radj = radj_true; - double * penalty_offset = & history[penalty_offset_]; + double * penalty_offset = & history[PENALTY]; const double pij = *penalty_offset; const double wij = std::max(1.0-pij,0.0); *penalty_offset = 0.0; From f9b00fb0b49d2d86b96e44cce0f9866395458bc1 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Thu, 26 Dec 2024 10:55:42 -0700 Subject: [PATCH 25/74] Removing seeminly unnecessary steps in gran wall update --- src/GRANULAR/fix_granular_mdr.cpp | 42 ++++++--------------------- src/GRANULAR/fix_wall_gran.h | 3 +- src/GRANULAR/fix_wall_gran_region.cpp | 8 ++--- 3 files changed, 15 insertions(+), 38 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index e79869aeaa..2563fb1fd8 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -155,8 +155,8 @@ void FixGranularMDR::pre_force(int) calculate_contact_penalty(); mean_surf_disp(); + // QUESTION: What about fix wall/gran? auto fix_list = modify->get_fix_by_style("wall/gran/region"); - for (int w = 0; w < fix_list.size(); w++) { update_fix_gran_wall(fix_list[w]); } @@ -304,6 +304,8 @@ void FixGranularMDR::end_of_step() void FixGranularMDR::set_arrays(int i) { + // QUESTION: which of these must be initialized to zero? + // maybe just index_history_setup_flag? // atom->dvector[index_Ro][i] = 0.0; // atom->dvector[index_Vgeo][i] = 0.0; // atom->dvector[index_Velas][i] = 0.0; @@ -367,7 +369,7 @@ void FixGranularMDR::radius_update() } /* ---------------------------------------------------------------------- - ... + QUESTION: is there a physical description for this loop? ------------------------------------------------------------------------- */ void FixGranularMDR::calculate_contact_penalty() @@ -456,6 +458,8 @@ void FixGranularMDR::calculate_contact_penalty() history_ik = &allhistory[size_history * kk]; double * pik = &history_ik[22]; // penalty for contact i and k + // QUESTION: is this comment accurate? + // Find pair of atoms with the smallest overlap, atoms a & b, 3rd atom c is central // if a & b are both local: // calculate ab penalty and add to the one history entry @@ -540,7 +544,7 @@ void FixGranularMDR::calculate_contact_penalty() /* ---------------------------------------------------------------------- - ... + QUESTION: is there a physical description for this loop? ------------------------------------------------------------------------- */ void FixGranularMDR::mean_surf_disp() @@ -685,13 +689,6 @@ void FixGranularMDR::update_fix_gran_wall(Fix* fix_in) const int size_history = model->size_history; int i, m, nc, iwall; - double vwall[3]; - bool touchflag = false; - int history_update = 1; - model->history_update = history_update; - - int regiondynamic = region->dynamic_check(); - if (!regiondynamic) vwall[0] = vwall[1] = vwall[2] = 0; double **x = atom->x; double *radius = atom->radius; @@ -701,14 +698,8 @@ void FixGranularMDR::update_fix_gran_wall(Fix* fix_in) double *Acon0 = atom->dvector[index_Acon0]; double *ddelta_bar = atom->dvector[index_ddelta_bar]; - if (regiondynamic) { + if (region->dynamic_check()) region->prematch(); - region->set_velocity(); - } - - if (fix->peratom_flag) fix->clear_stored_contacts(); - - model->radj = 0.0; for (i = 0; i < nlocal; i++) { if (!(mask[i] & groupbit)) continue; @@ -732,26 +723,11 @@ void FixGranularMDR::update_fix_gran_wall(Fix* fix_in) } else fix->update_contacts(i, nc); - // process current contacts for (int ic = 0; ic < nc; ic++) { - - // Reset model and copy initial geometric data - model->dx[0] = region->contact[ic].delx; - model->dx[1] = region->contact[ic].dely; - model->dx[2] = region->contact[ic].delz; - model->radi = radius[i]; - model->radj = region->contact[ic].radius; - model->r = region->contact[ic].r; - - if (model->beyond_contact) model->touch = fix->history_many[i][fix->c2r[ic]][0]; - - touchflag = model->check_contact(); - const double wij = 1.0; - if (Acon0[i] != 0.0) { - const double delta = model->radsum - model->r; + const double delta = radius[i] - region->contact[ic].r; const double delta_offset0 = fix->history_many[i][fix->c2r[ic]][0]; const double ddelta = delta - delta_offset0; const double Ac_offset0 = fix->history_many[i][fix->c2r[ic]][18]; diff --git a/src/GRANULAR/fix_wall_gran.h b/src/GRANULAR/fix_wall_gran.h index 85f3869ca9..e1e8c38ffe 100644 --- a/src/GRANULAR/fix_wall_gran.h +++ b/src/GRANULAR/fix_wall_gran.h @@ -52,7 +52,6 @@ class FixWallGran : public Fix { // for granular model choices class Granular_NS::GranularModel *model; - void clear_stored_contacts(); protected: int wallstyle, wiggle, wshear, axis; @@ -86,6 +85,8 @@ class FixWallGran : public Fix { // store particle interactions int store; + + void clear_stored_contacts(); }; } // namespace LAMMPS_NS diff --git a/src/GRANULAR/fix_wall_gran_region.cpp b/src/GRANULAR/fix_wall_gran_region.cpp index c0c7dd1dcb..4a59c1aea2 100644 --- a/src/GRANULAR/fix_wall_gran_region.cpp +++ b/src/GRANULAR/fix_wall_gran_region.cpp @@ -195,10 +195,10 @@ void FixWallGranRegion::post_force(int /*vflag*/) if (nc > tmax) error->one(FLERR, "Too many wallgran/region contacts for one particle"); // shear history maintenance - // update ncontact,walls,shear2many for particle I - // to reflect new and persistent shear historyvalues - // also set c2r[] = indices into region->contact[]for each of N contacts - // process zero or one contact here, otherwiseinvoke update_contacts() + // update ncontact, walls, shear2many for particle I + // to reflect new and persistent shear history values + // also set c2r[] = indices into region->contact[] for each of N contacts + // process zero or one contact here, otherwise invoke update_contacts() if (use_history) { if (nc == 0) { From c7d58a4eef6c684dafb07691ff3bde9e71ced888 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Thu, 26 Dec 2024 18:57:05 -0700 Subject: [PATCH 26/74] whitespace --- src/GRANULAR/gran_sub_mod_normal.cpp | 172 +++++++++++++-------------- 1 file changed, 86 insertions(+), 86 deletions(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index ac7ff1ffcd..adefabb62c 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -591,14 +591,14 @@ double GranSubModNormalMDR::calculate_forces() (gm->radi < gm->radj) ? delta_geo = MAX(delta_geoOpt1, delta_geoOpt2) : delta_geo = MIN(delta_geoOpt1, delta_geoOpt2); (gm->radi > gm->radj) ? delta_geo_alt = MAX(delta_geoOpt1, delta_geoOpt2) : delta_geo_alt = MIN(delta_geoOpt1, delta_geoOpt2); - if (delta_geo/gm->radi > overlap_limit) { - delta_geo = gm->radi*overlap_limit; - } else if (delta_geo_alt/gm->radj > overlap_limit) { - delta_geo = deltamax - gm->radj*overlap_limit; + if (delta_geo / gm->radi > overlap_limit) { + delta_geo = gm->radi * overlap_limit; + } else if (delta_geo_alt / gm->radj > overlap_limit) { + delta_geo = deltamax - gm->radj * overlap_limit; } double deltap = deltap0 + deltap1; - delta = delta_geo + (deltap0 - delta_geo)/(deltap - deltamax)*(gm->delta-deltamax); + delta = delta_geo + (deltap0 - delta_geo) / (deltap - deltamax) * (gm->delta - deltamax); } delta_offset = & history[DELTA_0]; @@ -628,19 +628,19 @@ double GranSubModNormalMDR::calculate_forces() } double delta_geo, delta_geo_alt; - double delta_geoOpt1 = deltamax*(deltamax - 2.0*R1)/(2.0*(deltamax - R0 - R1)); - double delta_geoOpt2 = deltamax*(deltamax - 2.0*R0)/(2.0*(deltamax - R0 - R1)); - (gm->radi < gm->radj) ? delta_geo = MAX(delta_geoOpt1,delta_geoOpt2) : delta_geo = MIN(delta_geoOpt1,delta_geoOpt2); + double delta_geoOpt1 = deltamax * (deltamax - 2.0 * R1) / (2.0 * (deltamax - R0 - R1)); + double delta_geoOpt2 = deltamax*(deltamax - 2.0 * R0) / (2.0 * (deltamax - R0 - R1)); + (gm->radi < gm->radj) ? delta_geo = MAX(delta_geoOpt1,delta_geoOpt2) : delta_geo = MIN(delta_geoOpt1, delta_geoOpt2); (gm->radi > gm->radj) ? delta_geo_alt = MAX(delta_geoOpt1,delta_geoOpt2) : delta_geo_alt = MIN(delta_geoOpt1,delta_geoOpt2); - if (delta_geo/gm->radi > overlap_limit) { - delta_geo = gm->radi*overlap_limit; - } else if (delta_geo_alt/gm->radj > overlap_limit) { - delta_geo = deltamax - gm->radj*overlap_limit; + if (delta_geo / gm->radi > overlap_limit) { + delta_geo = gm->radi * overlap_limit; + } else if (delta_geo_alt / gm->radj > overlap_limit) { + delta_geo = deltamax - gm->radj * overlap_limit; } double deltap = deltap0 + deltap1; - delta = delta_geo + (deltap1 - delta_geo)/(deltap - deltamax)*(gm->delta-deltamax); + delta = delta_geo + (deltap1 - delta_geo) / (deltap - deltamax) * (gm->delta - deltamax); delta_offset = & history[DELTA_1]; deltao_offset = & history[DELTAO_1]; @@ -674,7 +674,7 @@ double GranSubModNormalMDR::calculate_forces() double ddelta_MDR, ddelta_BULK; if ( psi[i] < psi_b ) { // if true, bulk response has triggered, split displacement increment between the MDR and BULK components - ddelta_MDR = std::min(ddelta-ddelta_bar[i], delta-*delta_MDR_offset); + ddelta_MDR = MIN(ddelta - ddelta_bar[i], delta - *delta_MDR_offset); ddelta_BULK = ddelta_bar[i]; } else { // if false, no bulk response, full displacement increment goes to the MDR component ddelta_BULK = 0.0; @@ -682,19 +682,19 @@ double GranSubModNormalMDR::calculate_forces() } const double delta_MDR = *delta_MDR_offset + ddelta_MDR; // MDR displacement *delta_MDR_offset = delta_MDR; // Update old MDR displacement - const double delta_BULK = std::max(0.0,*delta_BULK_offset+ddelta_BULK); // bulk displacement + const double delta_BULK = std::max(0.0, *delta_BULK_offset + ddelta_BULK); // bulk displacement *delta_BULK_offset = delta_BULK; // update old bulk displacement if (delta_MDR > *deltamax_MDR_offset) *deltamax_MDR_offset = delta_MDR; const double deltamax_MDR = *deltamax_MDR_offset; - const double pY = Y*(1.75*exp(-4.4*deltamax_MDR/R) + 1.0); // Set value of average pressure along yield surface + const double pY = Y * (1.75 * exp(-4.4*deltamax_MDR / R) + 1.0); // Set value of average pressure along yield surface if ( *Yflag_offset == 0.0 && delta_MDR >= deltamax_MDR ) { - const double phertz = 4*Eeff*sqrt(delta_MDR)/(3*MY_PI*sqrt(R)); + const double phertz = 4 * Eeff * sqrt(delta_MDR) / (3 * MY_PI * sqrt(R)); if ( phertz > pY ) { *Yflag_offset = 1.0; *deltaY_offset = delta_MDR; - *cA_offset = MY_PI*(pow(*deltaY_offset,2.0) - *deltaY_offset*R); + *cA_offset = MY_PI * (pow(*deltaY_offset, 2.0) - *deltaY_offset * R); } } @@ -708,19 +708,19 @@ double GranSubModNormalMDR::calculate_forces() const double cA = *cA_offset; // contact area intercept if ( *Yflag_offset == 0.0 ) { // elastic contact - A = 4.0*R; - B = 2.0*R; + A = 4.0 * R; + B = 2.0 * R; deltae1D = delta_MDR; - amax = sqrt(deltamax_MDR*R); + amax = sqrt(deltamax_MDR * R); } else { // plastic contact - amax = sqrt((2.0*deltamax_MDR*R - pow(deltamax_MDR,2.0)) + cA/MY_PI); - A = 4.0*pY/Eeff*amax; - B = 2.0*amax; - const double deltae1Dmax = A/2.0; // maximum transformed elastic displacement - const double Fmax = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltae1Dmax/A) - (1.0 - 2.0*deltae1Dmax/A)*sqrt(4.0*deltae1Dmax/A - 4.0*pow(deltae1Dmax,2.0)/pow(A,2.0))); // force caused by full submersion of elliptical indenter to depth of A/2 + amax = sqrt((2.0 * deltamax_MDR * R - pow(deltamax_MDR, 2.0)) + cA / MY_PI); + A = 4.0 * pY / Eeff * amax; + B = 2.0 * amax; + const double deltae1Dmax = A / 2.0; // maximum transformed elastic displacement + const double Fmax = Eeff * (A * B / 4.0) * (acos(1.0 - 2.0 * deltae1Dmax / A) - (1.0 - 2.0 * deltae1Dmax / A) * sqrt(4.0 * deltae1Dmax / A - 4.0 * pow(deltae1Dmax, 2.0) / pow(A, 2.0))); // force caused by full submersion of elliptical indenter to depth of A/2 const double zR = R - (deltamax_MDR - deltae1Dmax); // depth of particle center - deltaR = (Fmax*(2*pow(amax,2.0)*(-1 + nu) - (-1 + 2*nu)*zR*(-zR + sqrt(pow(amax,2.0) + pow(zR,2.0)))))/((MY_PI*pow(amax,2.0))*2*G*sqrt(pow(amax,2.0) + pow(zR,2.0))); - deltae1D = (delta_MDR - deltamax_MDR + deltae1Dmax + deltaR)/(1 + deltaR/deltae1Dmax); // transformed elastic displacement + deltaR = (Fmax * (2 * pow(amax, 2.0) * (-1 + nu) - (-1 + 2 * nu) * zR * (-zR + sqrt(pow(amax, 2.0) + pow(zR, 2.0)))))/((MY_PI * pow(amax, 2.0)) * 2 * G * sqrt(pow(amax, 2.0) + pow(zR, 2.0))); + deltae1D = (delta_MDR - deltamax_MDR + deltae1Dmax + deltaR) / (1 + deltaR / deltae1Dmax); // transformed elastic displacement // added for rigid flat placement *deltap_offset = deltamax_MDR - (deltae1Dmax + deltaR); @@ -728,34 +728,34 @@ double GranSubModNormalMDR::calculate_forces() double a_na; double a_fac = 0.99; - (deltae1D >= 0.0) ? a_na = B*sqrt(A - deltae1D)*sqrt(deltae1D)/A : a_na = 0.0; + (deltae1D >= 0.0) ? a_na = B * sqrt(A - deltae1D) * sqrt(deltae1D) / A : a_na = 0.0; double aAdh = *aAdh_offset; - if (aAdh > a_fac*amax) aAdh = a_fac*amax; + if (aAdh > a_fac * amax) aAdh = a_fac * amax; if ( gamma > 0.0 ) { // adhesive contact double g_aAdh; if (delta_MDR == deltamax_MDR || a_na >= aAdh ) { // case 1: no tensile springs, purely compressive contact - (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltae1D/A) - (1.0 - 2.0*deltae1D/A)*sqrt(4.0*deltae1D/A - 4.0*pow(deltae1D,2.0)/pow(A,2.0))); - if ( std::isnan(F_MDR) ) { + (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff * (A * B / 4.0) * (acos(1.0 - 2.0 * deltae1D / A) - (1.0 - 2.0 * deltae1D / A) * sqrt(4.0 * deltae1D / A - 4.0 * pow(deltae1D, 2.0) / pow(A, 2.0))); + if (std::isnan(F_MDR)) { error->one(FLERR, "F_MDR is NaN, case 1: no tensile springs"); } - *aAdh_offset = a_fac*a_na; + *aAdh_offset = a_fac * a_na; } else { - const double lmax = sqrt(2.0*MY_PI*aAdh*gamma/Eeff); - g_aAdh = A/2 - A/B*sqrt(pow(B,2.0)/4 - pow(aAdh,2.0)); - const double acrit = (-((pow(B,2)*gamma*MY_PI)/(pow(A,2)*Eeff)) + (pow(2,THIRD)*pow(B,4)*pow(gamma,2)*pow(MY_PI,FIVETHIRDS))/ - (pow(A,2)*pow(Eeff,2)*pow((27*pow(A,4)*pow(B,4)*gamma)/Eeff - (2*pow(B,6)*pow(gamma,3)*pow(MY_PI,2))/pow(Eeff,3) + (3*sqrt(3)*sqrt(27*pow(A,8)*pow(B,8)*pow(Eeff,2)*pow(gamma,2) - - 4*pow(A,4)*pow(B,10)*pow(gamma,4)*pow(MY_PI,2)))/pow(Eeff,2),THIRD)) + (pow(MY_PI/2.,THIRD)*pow((27*pow(A,4)*pow(B,4)*gamma)/Eeff - - (2*pow(B,6)*pow(gamma,3)*pow(MY_PI,2))/pow(Eeff,3) + (3*sqrt(3)*sqrt(27*pow(A,8)*pow(B,8)*pow(Eeff,2)*pow(gamma,2) - 4*pow(A,4)*pow(B,10)*pow(gamma,4)*pow(MY_PI,2)))/ - pow(Eeff,2),THIRD))/pow(A,2))/6; + const double lmax = sqrt(2.0 * MY_PI * aAdh * gamma / Eeff); + g_aAdh = A / 2 - A / B * sqrt(pow(B, 2.0) / 4 - pow(aAdh, 2.0)); + const double acrit = (-((pow(B, 2) * gamma * MY_PI) / (pow(A, 2) * Eeff)) + (pow(2, THIRD) * pow(B, 4) * pow(gamma, 2) * pow(MY_PI, FIVETHIRDS)) / + (pow(A, 2) * pow(Eeff, 2) * pow((27 * pow(A, 4) * pow(B, 4) * gamma) / Eeff - (2 * pow(B, 6) * pow(gamma, 3) * pow(MY_PI, 2)) / pow(Eeff, 3) + (3 * sqrt(3) * sqrt(27 * pow(A, 8) * pow(B, 8) * pow(Eeff, 2) * pow(gamma, 2) - + 4 * pow(A, 4) * pow(B, 10) * pow(gamma, 4) * pow(MY_PI, 2))) / pow(Eeff, 2), THIRD)) + (pow(MY_PI / 2., THIRD) * pow((27 * pow(A, 4) * pow(B, 4) * gamma) / Eeff - + (2 * pow(B, 6) * pow(gamma, 3) * pow(MY_PI, 2)) / pow(Eeff, 3) + (3 * sqrt(3) * sqrt(27 * pow(A, 8) * pow(B, 8) * pow(Eeff, 2) * pow(gamma, 2) - 4 * pow(A, 4) * pow(B, 10) * pow(gamma, 4) * pow(MY_PI, 2))) / + pow(Eeff, 2), THIRD)) / pow(A, 2)) / 6; if ( (deltae1D + lmax - g_aAdh) >= 0.0) { // case 2: tensile springs, but not exceeding critical length --> deltae + lmax - g(aAdhes) >= 0 const double deltaeAdh = g_aAdh; - const double F_na = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltaeAdh/A) - (1.0 - 2.0*deltaeAdh/A)*sqrt(4.0*deltaeAdh/A - 4.0*pow(deltaeAdh,2.0)/pow(A,2.0))); - const double F_Adhes = 2.0*Eeff*(deltae1D - deltaeAdh)*aAdh; + const double F_na = Eeff * (A * B / 4.0) * (acos(1.0 - 2.0 * deltaeAdh / A) - (1.0 - 2.0 * deltaeAdh / A) * sqrt(4.0 * deltaeAdh / A - 4.0 * pow(deltaeAdh, 2.0) / pow(A, 2.0))); + const double F_Adhes = 2.0 * Eeff * (deltae1D - deltaeAdh) * aAdh; F_MDR = F_na + F_Adhes; - if ( std::isnan(F_MDR) ) error->one(FLERR, "F_MDR is NaN, case 2: tensile springs, but not exceeding critical length"); + if (std::isnan(F_MDR)) error->one(FLERR, "F_MDR is NaN, case 2: tensile springs, but not exceeding critical length"); } else { // case 3: tensile springs exceed critical length --> deltae + lmax - g(aAdhes) = 0 if ( aAdh < acrit ) { aAdh = 0.0; @@ -770,36 +770,36 @@ double GranSubModNormalMDR::calculate_forces() double fa2; double dfda; for (int lv1 = 0; lv1 < maxIterations; ++lv1) { - fa = deltae1D + sqrt(2.0*MY_PI*aAdh_tmp*gamma/Eeff) - ( A/2 - A/B*sqrt(pow(B,2.0)/4 - pow(aAdh_tmp,2.0)) ); + fa = deltae1D + sqrt(2.0 * MY_PI * aAdh_tmp * gamma / Eeff) - (A / 2 - A / B * sqrt(pow(B, 2.0) / 4 - pow(aAdh_tmp, 2.0))); if (abs(fa) < error1) { break; } - dfda = -((aAdh_tmp*A)/(B*sqrt(-pow(aAdh_tmp,2.0) + pow(B,2.0)/4.0))) + (gamma*sqrt(MY_PI/2.0))/(Eeff*sqrt((aAdh_tmp*gamma)/Eeff)); - aAdh_tmp = aAdh_tmp - fa/dfda; - fa2 = deltae1D + sqrt(2.0*MY_PI*aAdh_tmp*gamma/Eeff) - (A/2 - A/B*sqrt(pow(B,2.0)/4 - pow(aAdh_tmp,2.0))); - if (abs(fa-fa2) < error2) { + dfda = -((aAdh_tmp * A) / (B * sqrt(-pow(aAdh_tmp, 2.0) + pow(B, 2.0) / 4.0))) + (gamma * sqrt(MY_PI / 2.0)) / (Eeff * sqrt((aAdh_tmp * gamma) / Eeff)); + aAdh_tmp = aAdh_tmp - fa / dfda; + fa2 = deltae1D + sqrt(2.0 * MY_PI * aAdh_tmp * gamma / Eeff) - (A / 2 - A / B * sqrt(pow(B, 2.0) / 4 - pow(aAdh_tmp, 2.0))); + if (abs(fa - fa2) < error2) { break; } - if (lv1 == maxIterations-1){ + if (lv1 == maxIterations - 1){ aAdh_tmp = 0.0; } } aAdh = aAdh_tmp; - g_aAdh = A/2.0 - A/B*sqrt(pow(B,2.0)/4.0 - pow(aAdh,2.0)); + g_aAdh = A / 2.0 - A / B * sqrt(pow(B, 2.0) / 4.0 - pow(aAdh, 2.0)); const double deltaeAdh = g_aAdh; - const double F_na = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltaeAdh/A) - (1.0 - 2.0*deltaeAdh/A)*sqrt(4.0*deltaeAdh/A - 4.0*pow(deltaeAdh,2.0)/pow(A,2.0))); - const double F_Adhes = 2.0*Eeff*(deltae1D - deltaeAdh)*aAdh; + const double F_na = Eeff * (A * B / 4.0) * (acos(1.0 - 2.0 * deltaeAdh / A) - (1.0 - 2.0 * deltaeAdh / A) * sqrt(4.0 * deltaeAdh / A - 4.0 * pow(deltaeAdh, 2.0) / pow(A, 2.0))); + const double F_Adhes = 2.0 * Eeff * (deltae1D - deltaeAdh) * aAdh; F_MDR = F_na + F_Adhes; - if ( std::isnan(F_MDR) ) error->one(FLERR, "F_MDR is NaN, case 3: tensile springs exceed critical length"); + if (std::isnan(F_MDR)) error->one(FLERR, "F_MDR is NaN, case 3: tensile springs exceed critical length"); } *aAdh_offset = aAdh; } } } else { // non-adhesive contact *aAdh_offset = a_na; - (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff*(A*B/4.0)*(acos(1.0 - 2.0*deltae1D/A) - (1.0 - 2.0*deltae1D/A)*sqrt(4.0*deltae1D/A - 4.0*pow(deltae1D,2.0)/pow(A,2.0))); - if ( std::isnan(F_MDR) ) { + (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff * (A * B / 4.0) * (acos(1.0 - 2.0 * deltae1D / A) - (1.0 - 2.0 * deltae1D / A) * sqrt(4.0 * deltae1D / A - 4.0 * pow(deltae1D, 2.0) / pow(A, 2.0))); + if (std::isnan(F_MDR)) { error->one(FLERR, "F_MDR is NaN, non-adhesive case"); } } @@ -810,49 +810,49 @@ double GranSubModNormalMDR::calculate_forces() // contact penalty scheme penalty_offset = & history[PENALTY]; double pij = *penalty_offset; - const double wij = std::max(1.0-pij,0.0); + const double wij = MAX(1.0 - pij, 0.0); // area related calculations double Ac; - (*Yflag_offset == 0.0) ? Ac = MY_PI*delta*R : Ac = MY_PI*((2.0*delta*R - pow(delta,2.0)) + cA/MY_PI); + (*Yflag_offset == 0.0) ? Ac = MY_PI * delta * R : Ac = MY_PI * ((2.0 * delta * R - pow(delta, 2.0)) + cA / MY_PI); if (Ac < 0.0 ) Ac = 0.0; - Atot_sum[i] += wij*(Ac - 2.0*MY_PI*R*(deltamax_MDR + delta_BULK)); - Acon1[i] += wij*Ac; + Atot_sum[i] += wij * (Ac - 2.0 * MY_PI * R * (deltamax_MDR + delta_BULK)); + Acon1[i] += wij * Ac; // bulk force calculation double F_BULK; - (delta_BULK <= 0.0) ? F_BULK = 0.0 : F_BULK = (1.0/Vgeo[i])*Acon0[i]*delta_BULK*kappa*Ac; + (delta_BULK <= 0.0) ? F_BULK = 0.0 : F_BULK = (1.0 / Vgeo[i]) * Acon0[i] * delta_BULK * kappa * Ac; // total force calculation (contactSide == 0) ? F0 = F_MDR + F_BULK : F1 = F_MDR + F_BULK; // mean surface dipslacement calculation - *Ac_offset = wij*Ac; + *Ac_offset = wij * Ac; // radius update scheme quantity calculation - Vcaps[i] += (MY_PI/3.0)*pow(delta,2.0)*(3.0*R - delta); + Vcaps[i] += (MY_PI / 3.0) * pow(delta, 2.0) * (3.0 * R - delta); - const double Fntmp = wij*(F_MDR + F_BULK); - const double fx = Fntmp*gm->nx[0]; - const double fy = Fntmp*gm->nx[1]; - const double fz = Fntmp*gm->nx[2]; - const double bx = -(Ro - deltao)*gm->nx[0]; - const double by = -(Ro - deltao)*gm->nx[1]; - const double bz = -(Ro - deltao)*gm->nx[2]; - const double eps_bar_contact = (1.0/(3*kappa*Velas[i]))*(fx*bx + fy*by + fz*bz); + const double Fntmp = wij * (F_MDR + F_BULK); + const double fx = Fntmp * gm->nx[0]; + const double fy = Fntmp * gm->nx[1]; + const double fz = Fntmp * gm->nx[2]; + const double bx = -(Ro - deltao) * gm->nx[0]; + const double by = -(Ro - deltao) * gm->nx[1]; + const double bz = -(Ro - deltao) * gm->nx[2]; + const double eps_bar_contact = (1.0 / (3 * kappa * Velas[i])) * (fx * bx + fy * by + fz * bz); eps_bar[i] += eps_bar_contact; double desp_bar_contact = eps_bar_contact - *eps_bar_offset; if(delta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0){ - const double Vo = (4.0/3.0)*MY_PI*pow(Ro,3.0); - dRnumerator[i] += -Vo*(eps_bar_contact - *eps_bar_offset) - wij*MY_PI*ddeltao*( 2.0*deltao*Ro - pow(deltao,2.0) + pow(R,2.0) - pow(Ro,2.0) ); - dRdenominator[i] += wij*2.0*MY_PI*R*(deltao + R - Ro); + const double Vo = (4.0 / 3.0) * MY_PI * pow(Ro, 3.0); + dRnumerator[i] += -Vo * (eps_bar_contact - *eps_bar_offset) - wij * MY_PI * ddeltao * (2.0 * deltao * Ro - pow(deltao, 2.0) + pow(R, 2.0) - pow(Ro, 2.0)); + dRdenominator[i] += wij * 2.0 * MY_PI * R * (deltao + R - Ro); } *eps_bar_offset = eps_bar_contact; - sigmaxx[i] += (1.0/Velas[i])*(fx*bx); - sigmayy[i] += (1.0/Velas[i])*(fy*by); - sigmazz[i] += (1.0/Velas[i])*(fz*bz); + sigmaxx[i] += (1.0 / Velas[i]) * (fx * bx); + sigmayy[i] += (1.0 / Velas[i]) * (fy * by); + sigmazz[i] += (1.0 / Velas[i]) * (fz * bz); } gm->i = i_true; @@ -862,14 +862,14 @@ double GranSubModNormalMDR::calculate_forces() double * penalty_offset = & history[PENALTY]; const double pij = *penalty_offset; - const double wij = std::max(1.0-pij,0.0); + const double wij = MAX(1.0 - pij, 0.0); *penalty_offset = 0.0; // assign final force if (gm->contact_type != PAIR) { - F = wij*F0; + F = wij * F0; } else { - F = wij*(F0 + F1)/2.0; + F = wij * (F0 + F1) / 2.0; } // calculate damping force @@ -877,18 +877,18 @@ double GranSubModNormalMDR::calculate_forces() double Eeff; double Reff; if (gm->contact_type == PAIR) { - Eeff = E/(2.0*(1.0-pow(nu,2.0))); - Reff = pow((1/gm->radi + 1/gm->radj),-1); + Eeff = E / (2.0 * (1.0 - pow(nu, 2.0))); + Reff = pow((1 / gm->radi + 1 / gm->radj), -1); } else { - Eeff = E/(1.0-pow(nu,2.0)); + Eeff = E / (1.0 - pow(nu, 2.0)); Reff = gm->radi; } const double kn = Eeff*Reff; - const double beta = -log(CoR)/sqrt(pow(log(CoR),2.0) + MY_PI*MY_PI); - const double damp_prefactor = beta*sqrt(gm->meff*kn); - const double F_DAMP = -damp_prefactor*(gm->vnnr); + const double beta = -log(CoR) / sqrt(pow(log(CoR), 2.0) + MY_PI * MY_PI); + const double damp_prefactor = beta * sqrt(gm->meff * kn); + const double F_DAMP = -damp_prefactor * (gm->vnnr); - F += wij*F_DAMP; + F += wij * F_DAMP; } return F; From 86e0b7e1d14c6e5bf3906091bbc5f9bf186c9909 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Fri, 27 Dec 2024 12:58:58 -0700 Subject: [PATCH 27/74] Consolidating history access in gran sub mod --- src/GRANULAR/gran_sub_mod_normal.cpp | 86 ++++++++++++---------------- 1 file changed, 37 insertions(+), 49 deletions(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index adefabb62c..ef1d07f3f4 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -543,8 +543,6 @@ double GranSubModNormalMDR::calculate_forces() double F1 = 0.0; // force on contact side 1 double R0 = 0.0; double R1 = 0.0; - int i0 = 0; - int i1 = 0; double delta = gm->delta; // apparent overlap double * history = & gm->history[history_index]; // load in all history variables @@ -582,54 +580,44 @@ double GranSubModNormalMDR::calculate_forces() } R0 = gm->radi; R1 = gm->radj; - i0 = gm->i; - i1 = gm->j; double delta_geo, delta_geo_alt; double delta_geoOpt1 = deltamax * (deltamax - 2.0 * R1) / (2.0 * (deltamax - R0 - R1)); double delta_geoOpt2 = deltamax * (deltamax - 2.0 * R0) / (2.0 * (deltamax - R0 - R1)); - (gm->radi < gm->radj) ? delta_geo = MAX(delta_geoOpt1, delta_geoOpt2) : delta_geo = MIN(delta_geoOpt1, delta_geoOpt2); - (gm->radi > gm->radj) ? delta_geo_alt = MAX(delta_geoOpt1, delta_geoOpt2) : delta_geo_alt = MIN(delta_geoOpt1, delta_geoOpt2); + (R0 < gm->radj) ? delta_geo = MAX(delta_geoOpt1, delta_geoOpt2) : delta_geo = MIN(delta_geoOpt1, delta_geoOpt2); + (R0 > gm->radj) ? delta_geo_alt = MAX(delta_geoOpt1, delta_geoOpt2) : delta_geo_alt = MIN(delta_geoOpt1, delta_geoOpt2); - if (delta_geo / gm->radi > overlap_limit) { - delta_geo = gm->radi * overlap_limit; + if (delta_geo / R0 > overlap_limit) { + delta_geo = R0 * overlap_limit; } else if (delta_geo_alt / gm->radj > overlap_limit) { delta_geo = deltamax - gm->radj * overlap_limit; } double deltap = deltap0 + deltap1; delta = delta_geo + (deltap0 - delta_geo) / (deltap - deltamax) * (gm->delta - deltamax); - } - delta_offset = & history[DELTA_0]; - deltao_offset = & history[DELTAO_0]; - delta_MDR_offset = & history[DELTA_MDR_0]; - delta_BULK_offset = & history[DELTA_BULK_0]; - deltamax_MDR_offset = & history[DELTAMAX_MDR_0]; - Yflag_offset = & history[YFLAG_0]; - deltaY_offset = & history[DELTAY_0]; - cA_offset = & history[CA_0]; - aAdh_offset = & history[AADH_0]; - Ac_offset = & history[AC_0]; - eps_bar_offset = & history[EPS_BAR_0]; - deltap_offset = & history[DELTAP_0]; } else { if (gm->contact_type != PAIR) break; // contact with particle-wall requires only one evaluation if (itag_true < jtag_true) { - gm->i = i_true; - gm->j = j_true; - gm->radi = radi_true; - gm->radj = radj_true; - } else { - gm->i = j_true; - gm->j = i_true; - gm->radi = radj_true; - gm->radj = radi_true; + gm->i = i_true; + gm->j = j_true; + gm->radi = radi_true; + gm->radj = radj_true; + } else { + gm->i = j_true; + gm->j = i_true; + gm->radi = radj_true; + gm->radj = radi_true; } + // QUESTION: R0/R1 here are never defined so they default to zero + // did you mean to define: + // R0 = gm->radi; + // R1 = gm->radj; + // here to mirror above? double delta_geo, delta_geo_alt; double delta_geoOpt1 = deltamax * (deltamax - 2.0 * R1) / (2.0 * (deltamax - R0 - R1)); - double delta_geoOpt2 = deltamax*(deltamax - 2.0 * R0) / (2.0 * (deltamax - R0 - R1)); + double delta_geoOpt2 = deltamax * (deltamax - 2.0 * R0) / (2.0 * (deltamax - R0 - R1)); (gm->radi < gm->radj) ? delta_geo = MAX(delta_geoOpt1,delta_geoOpt2) : delta_geo = MIN(delta_geoOpt1, delta_geoOpt2); (gm->radi > gm->radj) ? delta_geo_alt = MAX(delta_geoOpt1,delta_geoOpt2) : delta_geo_alt = MIN(delta_geoOpt1,delta_geoOpt2); @@ -641,21 +629,21 @@ double GranSubModNormalMDR::calculate_forces() double deltap = deltap0 + deltap1; delta = delta_geo + (deltap1 - delta_geo) / (deltap - deltamax) * (gm->delta - deltamax); - - delta_offset = & history[DELTA_1]; - deltao_offset = & history[DELTAO_1]; - delta_MDR_offset = & history[DELTA_MDR_1]; - delta_BULK_offset = & history[DELTA_BULK_1]; - deltamax_MDR_offset = & history[DELTAMAX_MDR_1]; - Yflag_offset = & history[YFLAG_1]; - deltaY_offset = & history[DELTAY_1]; - cA_offset = & history[CA_1]; - aAdh_offset = & history[AADH_1]; - Ac_offset = & history[AC_1]; - eps_bar_offset = & history[EPS_BAR_1]; - deltap_offset = & history[DELTAP_1]; } + delta_offset = & history[DELTA_0 + contactSide]; + deltao_offset = & history[DELTAO_0 + contactSide]; + delta_MDR_offset = & history[DELTA_MDR_0 + contactSide]; + delta_BULK_offset = & history[DELTA_BULK_0 + contactSide]; + deltamax_MDR_offset = & history[DELTAMAX_MDR_0 + contactSide]; + Yflag_offset = & history[YFLAG_0 + contactSide]; + deltaY_offset = & history[DELTAY_0 + contactSide]; + cA_offset = & history[CA_0 + contactSide]; + aAdh_offset = & history[AADH_0 + contactSide]; + Ac_offset = & history[AC_0 + contactSide]; + eps_bar_offset = & history[EPS_BAR_0 + contactSide]; + deltap_offset = & history[DELTAP_0 + contactSide]; + // temporary i and j indices const int i = gm->i; const int j = gm->j; @@ -673,7 +661,7 @@ double GranSubModNormalMDR::calculate_forces() *deltao_offset = deltao; double ddelta_MDR, ddelta_BULK; - if ( psi[i] < psi_b ) { // if true, bulk response has triggered, split displacement increment between the MDR and BULK components + if (psi[i] < psi_b) { // if true, bulk response has triggered, split displacement increment between the MDR and BULK components ddelta_MDR = MIN(ddelta - ddelta_bar[i], delta - *delta_MDR_offset); ddelta_BULK = ddelta_bar[i]; } else { // if false, no bulk response, full displacement increment goes to the MDR component @@ -688,8 +676,8 @@ double GranSubModNormalMDR::calculate_forces() if (delta_MDR > *deltamax_MDR_offset) *deltamax_MDR_offset = delta_MDR; const double deltamax_MDR = *deltamax_MDR_offset; - const double pY = Y * (1.75 * exp(-4.4*deltamax_MDR / R) + 1.0); // Set value of average pressure along yield surface - if ( *Yflag_offset == 0.0 && delta_MDR >= deltamax_MDR ) { + const double pY = Y * (1.75 * exp(-4.4 * deltamax_MDR / R) + 1.0); // Set value of average pressure along yield surface + if (*Yflag_offset == 0.0 && delta_MDR >= deltamax_MDR) { const double phertz = 4 * Eeff * sqrt(delta_MDR) / (3 * MY_PI * sqrt(R)); if ( phertz > pY ) { *Yflag_offset = 1.0; @@ -738,7 +726,7 @@ double GranSubModNormalMDR::calculate_forces() if (delta_MDR == deltamax_MDR || a_na >= aAdh ) { // case 1: no tensile springs, purely compressive contact (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff * (A * B / 4.0) * (acos(1.0 - 2.0 * deltae1D / A) - (1.0 - 2.0 * deltae1D / A) * sqrt(4.0 * deltae1D / A - 4.0 * pow(deltae1D, 2.0) / pow(A, 2.0))); if (std::isnan(F_MDR)) { - error->one(FLERR, "F_MDR is NaN, case 1: no tensile springs"); + error->one(FLERR, "F_MDR is NaN, case 1: no tensile springs"); } *aAdh_offset = a_fac * a_na; } else { @@ -883,7 +871,7 @@ double GranSubModNormalMDR::calculate_forces() Eeff = E / (1.0 - pow(nu, 2.0)); Reff = gm->radi; } - const double kn = Eeff*Reff; + const double kn = Eeff * Reff; const double beta = -log(CoR) / sqrt(pow(log(CoR), 2.0) + MY_PI * MY_PI); const double damp_prefactor = beta * sqrt(gm->meff * kn); const double F_DAMP = -damp_prefactor * (gm->vnnr); From 255e50cfc37be4589d0e52632c870e687ae05344 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Sat, 28 Dec 2024 11:14:05 -0700 Subject: [PATCH 28/74] Style changes to gransubmod --- src/GRANULAR/gran_sub_mod_normal.cpp | 81 +++++++++++++++------------- 1 file changed, 45 insertions(+), 36 deletions(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index ef1d07f3f4..1079f2b0e3 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -37,6 +37,9 @@ static constexpr double INVROOT6 = 0.40824829046386307274; // 1/sqrt(6) static constexpr double FOURTHIRDS = (4.0 / 3.0); // 4/3 static constexpr double FIVETHIRDS = (5.0 / 3.0); // 5/3 static constexpr double JKRPREFIX = 1.2277228507842888; // cbrt(3*PI**2/16) +static constexpr int MDR_MAX_IT = 100; // Newton-Raphson for MDR +static constexpr double MDR_EPSILON1 = 1e-10; // Newton-Raphson for MDR +static constexpr double MDR_EPSILON2 = 1e-16; // Newton-Raphson for MDR static const char cite_mdr[] = "MDR contact model command: \n\n" @@ -614,7 +617,7 @@ double GranSubModNormalMDR::calculate_forces() // did you mean to define: // R0 = gm->radi; // R1 = gm->radj; - // here to mirror above? + // here to mirror above? After confirming, these two conditions can be easily collapsed to remove duplication and clarify differences (also replace gm->radi/radj with R0/R1) double delta_geo, delta_geo_alt; double delta_geoOpt1 = deltamax * (deltamax - 2.0 * R1) / (2.0 * (deltamax - R0 - R1)); double delta_geoOpt2 = deltamax * (deltamax - 2.0 * R0) / (2.0 * (deltamax - R0 - R1)); @@ -670,7 +673,7 @@ double GranSubModNormalMDR::calculate_forces() } const double delta_MDR = *delta_MDR_offset + ddelta_MDR; // MDR displacement *delta_MDR_offset = delta_MDR; // Update old MDR displacement - const double delta_BULK = std::max(0.0, *delta_BULK_offset + ddelta_BULK); // bulk displacement + const double delta_BULK = MAX(0.0, *delta_BULK_offset + ddelta_BULK); // bulk displacement *delta_BULK_offset = delta_BULK; // update old bulk displacement if (delta_MDR > *deltamax_MDR_offset) *deltamax_MDR_offset = delta_MDR; @@ -682,32 +685,36 @@ double GranSubModNormalMDR::calculate_forces() if ( phertz > pY ) { *Yflag_offset = 1.0; *deltaY_offset = delta_MDR; - *cA_offset = MY_PI * (pow(*deltaY_offset, 2.0) - *deltaY_offset * R); + *cA_offset = MY_PI * (pow(*deltaY_offset, 2) - *deltaY_offset * R); } } // MDR force calculation double F_MDR; - double A; // height of elliptical indenter + double A, Ainv; // height of elliptical indenter double B; // width of elliptical indenter double deltae1D; // transformed elastic displacement double deltaR; // displacement correction - double amax; // maximum experienced contact radius + double amax, amaxsq; // maximum experienced contact radius const double cA = *cA_offset; // contact area intercept if ( *Yflag_offset == 0.0 ) { // elastic contact A = 4.0 * R; + Ainv = 1.0 / A; B = 2.0 * R; deltae1D = delta_MDR; amax = sqrt(deltamax_MDR * R); } else { // plastic contact - amax = sqrt((2.0 * deltamax_MDR * R - pow(deltamax_MDR, 2.0)) + cA / MY_PI); + amax = sqrt((2.0 * deltamax_MDR * R - pow(deltamax_MDR, 2)) + cA / MY_PI); + amaxsq = amax * amax; // TODO later, breaks BFB A = 4.0 * pY / Eeff * amax; + Ainv = 1.0 / A; // TODO later, breaks BFB B = 2.0 * amax; - const double deltae1Dmax = A / 2.0; // maximum transformed elastic displacement - const double Fmax = Eeff * (A * B / 4.0) * (acos(1.0 - 2.0 * deltae1Dmax / A) - (1.0 - 2.0 * deltae1Dmax / A) * sqrt(4.0 * deltae1Dmax / A - 4.0 * pow(deltae1Dmax, 2.0) / pow(A, 2.0))); // force caused by full submersion of elliptical indenter to depth of A/2 + const double deltae1Dmax = A * 0.5; // maximum transformed elastic displacement + const double Fmax = Eeff * (A * B * 0.25) * acos(1.0 - 2.0 * deltae1Dmax / A) - (1.0 - 2.0 * deltae1Dmax / A) * sqrt(4.0 * deltae1Dmax / A - 4.0 * pow(deltae1Dmax, 2) / pow(A, 2)); // force caused by full submersion of elliptical indenter to depth of A/2 const double zR = R - (deltamax_MDR - deltae1Dmax); // depth of particle center - deltaR = (Fmax * (2 * pow(amax, 2.0) * (-1 + nu) - (-1 + 2 * nu) * zR * (-zR + sqrt(pow(amax, 2.0) + pow(zR, 2.0)))))/((MY_PI * pow(amax, 2.0)) * 2 * G * sqrt(pow(amax, 2.0) + pow(zR, 2.0))); + deltaR = (Fmax * (2 * pow(amax, 2) * (-1 + nu) - (-1 + 2 * nu) * zR * (-zR + sqrt(pow(amax, 2) + pow(zR, 2))))); + deltaR /= (MY_PI * pow(amax, 2) * 2 * G * sqrt(pow(amax, 2) + pow(zR, 2))); deltae1D = (delta_MDR - deltamax_MDR + deltae1Dmax + deltaR) / (1 + deltaR / deltae1Dmax); // transformed elastic displacement // added for rigid flat placement @@ -721,26 +728,31 @@ double GranSubModNormalMDR::calculate_forces() if (aAdh > a_fac * amax) aAdh = a_fac * amax; if ( gamma > 0.0 ) { // adhesive contact - double g_aAdh; + double g_aAdh; if (delta_MDR == deltamax_MDR || a_na >= aAdh ) { // case 1: no tensile springs, purely compressive contact - (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff * (A * B / 4.0) * (acos(1.0 - 2.0 * deltae1D / A) - (1.0 - 2.0 * deltae1D / A) * sqrt(4.0 * deltae1D / A - 4.0 * pow(deltae1D, 2.0) / pow(A, 2.0))); + if (deltae1D <= 0.0) { + F_MDR = 0.0; + } else { + F_MDR = Eeff * (A * B * 0.25); + F_MDR *= acos(1.0 - 2.0 * deltae1D / A) - (1.0 - 2.0 * deltae1D / A) * sqrt(4.0 * deltae1D / A - 4.0 * pow(deltae1D, 2) / pow(A, 2)); + } if (std::isnan(F_MDR)) { error->one(FLERR, "F_MDR is NaN, case 1: no tensile springs"); } *aAdh_offset = a_fac * a_na; } else { const double lmax = sqrt(2.0 * MY_PI * aAdh * gamma / Eeff); - g_aAdh = A / 2 - A / B * sqrt(pow(B, 2.0) / 4 - pow(aAdh, 2.0)); + g_aAdh = A * 0.5 - A / B * sqrt(pow(B, 2.0) * 0.25 - pow(aAdh, 2)); const double acrit = (-((pow(B, 2) * gamma * MY_PI) / (pow(A, 2) * Eeff)) + (pow(2, THIRD) * pow(B, 4) * pow(gamma, 2) * pow(MY_PI, FIVETHIRDS)) / (pow(A, 2) * pow(Eeff, 2) * pow((27 * pow(A, 4) * pow(B, 4) * gamma) / Eeff - (2 * pow(B, 6) * pow(gamma, 3) * pow(MY_PI, 2)) / pow(Eeff, 3) + (3 * sqrt(3) * sqrt(27 * pow(A, 8) * pow(B, 8) * pow(Eeff, 2) * pow(gamma, 2) - - 4 * pow(A, 4) * pow(B, 10) * pow(gamma, 4) * pow(MY_PI, 2))) / pow(Eeff, 2), THIRD)) + (pow(MY_PI / 2., THIRD) * pow((27 * pow(A, 4) * pow(B, 4) * gamma) / Eeff - + 4 * pow(A, 4) * pow(B, 10) * pow(gamma, 4) * pow(MY_PI, 2))) / pow(Eeff, 2), THIRD)) + (pow(MY_PI * 0.5, THIRD) * pow((27 * pow(A, 4) * pow(B, 4) * gamma) / Eeff - (2 * pow(B, 6) * pow(gamma, 3) * pow(MY_PI, 2)) / pow(Eeff, 3) + (3 * sqrt(3) * sqrt(27 * pow(A, 8) * pow(B, 8) * pow(Eeff, 2) * pow(gamma, 2) - 4 * pow(A, 4) * pow(B, 10) * pow(gamma, 4) * pow(MY_PI, 2))) / pow(Eeff, 2), THIRD)) / pow(A, 2)) / 6; if ( (deltae1D + lmax - g_aAdh) >= 0.0) { // case 2: tensile springs, but not exceeding critical length --> deltae + lmax - g(aAdhes) >= 0 const double deltaeAdh = g_aAdh; - const double F_na = Eeff * (A * B / 4.0) * (acos(1.0 - 2.0 * deltaeAdh / A) - (1.0 - 2.0 * deltaeAdh / A) * sqrt(4.0 * deltaeAdh / A - 4.0 * pow(deltaeAdh, 2.0) / pow(A, 2.0))); + const double F_na = Eeff * (A * B * 0.25) * (acos(1.0 - 2.0 * deltaeAdh / A) - (1.0 - 2.0 * deltaeAdh / A) * sqrt(4.0 * deltaeAdh / A - 4.0 * pow(deltaeAdh, 2) / pow(A, 2))); const double F_Adhes = 2.0 * Eeff * (deltae1D - deltaeAdh) * aAdh; F_MDR = F_na + F_Adhes; if (std::isnan(F_MDR)) error->one(FLERR, "F_MDR is NaN, case 2: tensile springs, but not exceeding critical length"); @@ -750,33 +762,30 @@ double GranSubModNormalMDR::calculate_forces() F_MDR = 0.0; } else { // newton-raphson to find aAdh - const double maxIterations = 100; - const double error1 = 1e-10; - const double error2 = 1e-16; double aAdh_tmp = aAdh; double fa; double fa2; double dfda; - for (int lv1 = 0; lv1 < maxIterations; ++lv1) { - fa = deltae1D + sqrt(2.0 * MY_PI * aAdh_tmp * gamma / Eeff) - (A / 2 - A / B * sqrt(pow(B, 2.0) / 4 - pow(aAdh_tmp, 2.0))); - if (abs(fa) < error1) { + for (int lv1 = 0; lv1 < MDR_MAX_IT; ++lv1) { + fa = deltae1D + sqrt(2.0 * MY_PI * aAdh_tmp * gamma / Eeff) - (A * 0.5 - A / B * sqrt(pow(B, 2) * 0.25 - pow(aAdh_tmp, 2))); + if (abs(fa) < MDR_EPSILON1) { break; } - dfda = -((aAdh_tmp * A) / (B * sqrt(-pow(aAdh_tmp, 2.0) + pow(B, 2.0) / 4.0))) + (gamma * sqrt(MY_PI / 2.0)) / (Eeff * sqrt((aAdh_tmp * gamma) / Eeff)); + dfda = -((aAdh_tmp * A) / (B * sqrt(-pow(aAdh_tmp, 2) + pow(B, 2) * 0.25))) + (gamma * sqrt(MY_PI * 0.5)) / (Eeff * sqrt((aAdh_tmp * gamma) / Eeff)); aAdh_tmp = aAdh_tmp - fa / dfda; - fa2 = deltae1D + sqrt(2.0 * MY_PI * aAdh_tmp * gamma / Eeff) - (A / 2 - A / B * sqrt(pow(B, 2.0) / 4 - pow(aAdh_tmp, 2.0))); - if (abs(fa - fa2) < error2) { + fa2 = deltae1D + sqrt(2.0 * MY_PI * aAdh_tmp * gamma / Eeff) - (A * 0.5 - A / B * sqrt(pow(B, 2) * 0.25 - pow(aAdh_tmp, 2))); + if (abs(fa - fa2) < MDR_EPSILON2) { break; } - if (lv1 == maxIterations - 1){ + if (lv1 == MDR_MAX_IT - 1){ aAdh_tmp = 0.0; } } aAdh = aAdh_tmp; - g_aAdh = A / 2.0 - A / B * sqrt(pow(B, 2.0) / 4.0 - pow(aAdh, 2.0)); + g_aAdh = A * 0.5 - A / B * sqrt(pow(B, 2) * 0.25 - pow(aAdh, 2)); const double deltaeAdh = g_aAdh; - const double F_na = Eeff * (A * B / 4.0) * (acos(1.0 - 2.0 * deltaeAdh / A) - (1.0 - 2.0 * deltaeAdh / A) * sqrt(4.0 * deltaeAdh / A - 4.0 * pow(deltaeAdh, 2.0) / pow(A, 2.0))); + const double F_na = Eeff * (A * B * 0.25) * (acos(1.0 - 2.0 * deltaeAdh / A) - (1.0 - 2.0 * deltaeAdh / A) * sqrt(4.0 * deltaeAdh / A - 4.0 * pow(deltaeAdh, 2) / pow(A, 2))); const double F_Adhes = 2.0 * Eeff * (deltae1D - deltaeAdh) * aAdh; F_MDR = F_na + F_Adhes; if (std::isnan(F_MDR)) error->one(FLERR, "F_MDR is NaN, case 3: tensile springs exceed critical length"); @@ -786,7 +795,7 @@ double GranSubModNormalMDR::calculate_forces() } } else { // non-adhesive contact *aAdh_offset = a_na; - (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff * (A * B / 4.0) * (acos(1.0 - 2.0 * deltae1D / A) - (1.0 - 2.0 * deltae1D / A) * sqrt(4.0 * deltae1D / A - 4.0 * pow(deltae1D, 2.0) / pow(A, 2.0))); + (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff * (A * B * 0.25) * (acos(1.0 - 2.0 * deltae1D / A) - (1.0 - 2.0 * deltae1D / A) * sqrt(4.0 * deltae1D / A - 4.0 * pow(deltae1D, 2) / pow(A, 2))); if (std::isnan(F_MDR)) { error->one(FLERR, "F_MDR is NaN, non-adhesive case"); } @@ -802,7 +811,7 @@ double GranSubModNormalMDR::calculate_forces() // area related calculations double Ac; - (*Yflag_offset == 0.0) ? Ac = MY_PI * delta * R : Ac = MY_PI * ((2.0 * delta * R - pow(delta, 2.0)) + cA / MY_PI); + (*Yflag_offset == 0.0) ? Ac = MY_PI * delta * R : Ac = MY_PI * ((2.0 * delta * R - pow(delta, 2)) + cA / MY_PI); if (Ac < 0.0 ) Ac = 0.0; Atot_sum[i] += wij * (Ac - 2.0 * MY_PI * R * (deltamax_MDR + delta_BULK)); Acon1[i] += wij * Ac; @@ -818,7 +827,7 @@ double GranSubModNormalMDR::calculate_forces() *Ac_offset = wij * Ac; // radius update scheme quantity calculation - Vcaps[i] += (MY_PI / 3.0) * pow(delta, 2.0) * (3.0 * R - delta); + Vcaps[i] += (MY_PI * THIRD) * pow(delta, 2) * (3.0 * R - delta); const double Fntmp = wij * (F_MDR + F_BULK); const double fx = Fntmp * gm->nx[0]; @@ -832,8 +841,8 @@ double GranSubModNormalMDR::calculate_forces() double desp_bar_contact = eps_bar_contact - *eps_bar_offset; if(delta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0){ - const double Vo = (4.0 / 3.0) * MY_PI * pow(Ro, 3.0); - dRnumerator[i] += -Vo * (eps_bar_contact - *eps_bar_offset) - wij * MY_PI * ddeltao * (2.0 * deltao * Ro - pow(deltao, 2.0) + pow(R, 2.0) - pow(Ro, 2.0)); + const double Vo = (4.0 * THIRD) * MY_PI * pow(Ro, 3); + dRnumerator[i] += -Vo * (eps_bar_contact - *eps_bar_offset) - wij * MY_PI * ddeltao * (2.0 * deltao * Ro - pow(deltao, 2) + pow(R, 2) - pow(Ro, 2)); dRdenominator[i] += wij * 2.0 * MY_PI * R * (deltao + R - Ro); } *eps_bar_offset = eps_bar_contact; @@ -857,7 +866,7 @@ double GranSubModNormalMDR::calculate_forces() if (gm->contact_type != PAIR) { F = wij * F0; } else { - F = wij * (F0 + F1) / 2.0; + F = wij * (F0 + F1) * 0.5; } // calculate damping force @@ -865,16 +874,16 @@ double GranSubModNormalMDR::calculate_forces() double Eeff; double Reff; if (gm->contact_type == PAIR) { - Eeff = E / (2.0 * (1.0 - pow(nu, 2.0))); + Eeff = E / (2.0 * (1.0 - pow(nu, 2))); Reff = pow((1 / gm->radi + 1 / gm->radj), -1); } else { - Eeff = E / (1.0 - pow(nu, 2.0)); + Eeff = E / (1.0 - pow(nu, 2)); Reff = gm->radi; } const double kn = Eeff * Reff; - const double beta = -log(CoR) / sqrt(pow(log(CoR), 2.0) + MY_PI * MY_PI); + const double beta = -log(CoR) / sqrt(pow(log(CoR), 2) + MY_PI * MY_PI); const double damp_prefactor = beta * sqrt(gm->meff * kn); - const double F_DAMP = -damp_prefactor * (gm->vnnr); + const double F_DAMP = -damp_prefactor * gm->vnnr; F += wij * F_DAMP; } From 31963900da28cc3397493412918c273b4f7e0bfb Mon Sep 17 00:00:00 2001 From: William Zunker Date: Thu, 2 Jan 2025 16:45:05 -0500 Subject: [PATCH 29/74] Providing answers to commented questions --- src/GRANULAR/fix_granular_mdr.cpp | 32 ++++++++++++++++++++++++---- src/GRANULAR/gran_sub_mod_normal.cpp | 8 +++++++ 2 files changed, 36 insertions(+), 4 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index 2563fb1fd8..106987fc02 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -131,6 +131,11 @@ void FixGranularMDR::setup_pre_force(int /*vflag*/) // QUESTION: can psi_b be different in different models? + // ANSWER: psi_b is a required argument when defining the mdr contact model (i.e. coeffs[4]). + // It is a unique parameter to only the mdr model. + // It is allowed to vary as a parameter meaning it can be different for each simulation. + // Like the other coeffs for the MDR model no sensible mixing rule exists at the moment + // meaning only one material type can be considered. psi_b_coeff = norm_model->psi_b; pre_force(0); @@ -156,6 +161,7 @@ void FixGranularMDR::pre_force(int) mean_surf_disp(); // QUESTION: What about fix wall/gran? + // Answer: We never considered interaction between the mdr contact model and fix wall/gran auto fix_list = modify->get_fix_by_style("wall/gran/region"); for (int w = 0; w < fix_list.size(); w++) { update_fix_gran_wall(fix_list[w]); @@ -283,6 +289,10 @@ void FixGranularMDR::end_of_step() } // QUESTION: does it make more sense to initialize these in pre_force? + // ANSWER: The resetting/intialization of these values could likely also be done in pre_force. + // I only placed them here since they should only be reset after all MDR calcs are done + // for a particular particle in a given step. However, if the resetting is done + // prior to any MDR calcs in the next step it should effectivily be the same. Velas[i] = Vo * (1.0 + eps_bar[i]); Vcaps[i] = 0.0; eps_bar[i] = 0.0; @@ -306,6 +316,13 @@ void FixGranularMDR::set_arrays(int i) { // QUESTION: which of these must be initialized to zero? // maybe just index_history_setup_flag? + // ANSWER: I would agree with how you have it right now. All of the variables being initialized + // to zero here should be zero when the atom is created. However, is it ever possible for + // calculate_forces() to be called without calling pre_force()? If the answer is no, then + // we might be able to move the initializations/resetting of Velas[i] through ddelta_bar[i] + // from end_of_step to pre_force. Then I think we could get rid of all the set arrays except + // for history_setup_flag. Vo will have to be redefined in pre_force to allow Velas[i] to be set. + // atom->dvector[index_Ro][i] = 0.0; // atom->dvector[index_Vgeo][i] = 0.0; // atom->dvector[index_Velas][i] = 0.0; @@ -370,6 +387,8 @@ void FixGranularMDR::radius_update() /* ---------------------------------------------------------------------- QUESTION: is there a physical description for this loop? + ANSWER: Screen for non-physical contacts occuring through obstructing particles. + Assign non-zero penalties to these contacts to adjust force evaluation. ------------------------------------------------------------------------- */ void FixGranularMDR::calculate_contact_penalty() @@ -426,6 +445,7 @@ void FixGranularMDR::calculate_contact_penalty() k &= NEIGHMASK; // QUESTION: why not start loop at jj+1? + // ANSWER: Good point, I can't think of any reason not to. if (kk == jj) continue; const double delx_ik = x[k][0] - xtmp; const double dely_ik = x[k][1] - ytmp; @@ -459,15 +479,16 @@ void FixGranularMDR::calculate_contact_penalty() double * pik = &history_ik[22]; // penalty for contact i and k // QUESTION: is this comment accurate? + // ANSWER: Yes, looks accurate // Find pair of atoms with the smallest overlap, atoms a & b, 3rd atom c is central // if a & b are both local: - // calculate ab penalty and add to the one history entry - // if a is local & b is ghost: + // calculate ab penalty and add to the pab[0] history entry + // if a is local & b is ghost or vice versa: // each processor has a-b in nlist and independently calculates + adds penalty // if a & b are both ghosts: // skip calculation since it's performed on other proc - // This process requires newon off, or nlist may not include ab, ac, & bc + // This process requires newton off, or nlist may not include ab, ac, & bc const double r_max = MAX(r_ij, MAX(r_ik, r_jk)); if (r_ij == r_max) { // the central particle is k @@ -531,8 +552,10 @@ void FixGranularMDR::calculate_contact_penalty() } // QUESTION: is this ever supposed to happen? + // ANSWER: No, it means the neighbor lists are either (i) not being built frequently enough + // or (ii) the size of the neighbor list is too small. An error should be given. if (pjk == nullptr) - error->one(FLERR, "MDR could not find atom pair in neighbor list"); + error->one(FLERR, "Contact between a pair of particles was detected, however it is not reflected in the neighbor lists. To solve this issue either build the neighbor lists more frequently or increase their size (e.g. increase the skin distance)."); pjk[0] += 1.0 / (1.0 + std::exp(-50.0 * (alpha / MY_PI - 0.5))); } @@ -545,6 +568,7 @@ void FixGranularMDR::calculate_contact_penalty() /* ---------------------------------------------------------------------- QUESTION: is there a physical description for this loop? + ANSWER: Calculate mean surface displacement increment for each particle ------------------------------------------------------------------------- */ void FixGranularMDR::mean_surf_disp() diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 1079f2b0e3..e65747f374 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -618,6 +618,14 @@ double GranSubModNormalMDR::calculate_forces() // R0 = gm->radi; // R1 = gm->radj; // here to mirror above? After confirming, these two conditions can be easily collapsed to remove duplication and clarify differences (also replace gm->radi/radj with R0/R1) + // ANSWER: If I am not mistaken R0 & R1 will always be set to non-zero values from the case above where contactSide = 0: + // R0 = gm->radi; + // R1 = gm->radj; + // Then their values will carry over into this else statement for the case of contactSide = 1. I don't want their values to change after they are set above, + // hence why I didn't redine them. + // + // However, this is written in a bit of a strange way now that I am reviewing it, I will give it some more thought. + double delta_geo, delta_geo_alt; double delta_geoOpt1 = deltamax * (deltamax - 2.0 * R1) / (2.0 * (deltamax - R0 - R1)); double delta_geoOpt2 = deltamax * (deltamax - 2.0 * R0) / (2.0 * (deltamax - R0 - R1)); From 629cb9d0d3251c99616422b13ccdff88310b2f61 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Fri, 3 Jan 2025 10:34:48 -0700 Subject: [PATCH 30/74] Small updates and answers for MD --- src/GRANULAR/fix_granular_mdr.cpp | 65 ++++++++++++---------------- src/GRANULAR/gran_sub_mod_normal.cpp | 30 +++++++------ 2 files changed, 44 insertions(+), 51 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index 106987fc02..a2ef4f31b2 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -46,7 +46,7 @@ using MathConst::MY_PI; static constexpr double EPSILON = 1e-16; -enum {MEAN_SURF_DISP, RADIUS_UPDATE}; +enum {COMM_RADIUS_UPDATE, COMM_DDELTA_BAR}; /* ---------------------------------------------------------------------- */ @@ -131,11 +131,15 @@ void FixGranularMDR::setup_pre_force(int /*vflag*/) // QUESTION: can psi_b be different in different models? - // ANSWER: psi_b is a required argument when defining the mdr contact model (i.e. coeffs[4]). + // ANSWER: psi_b is a required argument when defining the mdr contact model (i.e. coeffs[4]). // It is a unique parameter to only the mdr model. // It is allowed to vary as a parameter meaning it can be different for each simulation. // Like the other coeffs for the MDR model no sensible mixing rule exists at the moment - // meaning only one material type can be considered. + // meaning only one material type can be considered. + // ANSWER2: So users cannot define 2 MDR models with different moduli? + // Should an error be invoked if two MDR models are therefore defined? + // Should there be an error if a user uses a non-MDR model with an MDR model? + psi_b_coeff = norm_model->psi_b; pre_force(0); @@ -154,20 +158,25 @@ void FixGranularMDR::pre_force(int) { radius_update(); - comm_stage = RADIUS_UPDATE; + comm_stage = COMM_RADIUS_UPDATE; comm->forward_comm(this, 20); calculate_contact_penalty(); mean_surf_disp(); // QUESTION: What about fix wall/gran? - // Answer: We never considered interaction between the mdr contact model and fix wall/gran - auto fix_list = modify->get_fix_by_style("wall/gran/region"); - for (int w = 0; w < fix_list.size(); w++) { - update_fix_gran_wall(fix_list[w]); + // Answer: We never considered interaction between the mdr contact model and fix wall/gran + // ANSWER2: Ideally this would be added, but at least temporarily I added an + // error. This incompatibility should be noted in the docs + + auto fix_list = modify->get_fix_by_style("wall/gran"); + for (int i = 0; i < fix_list.size(); i++) { + if (!utils::strmatch(fix_list[i]->style, "wall/gran/region")) + error->all(FLERR, "MDR model currently only supports fix wall/gran/region, not fix wall/gran"); + update_fix_gran_wall(fix_list[i]); } - comm_stage = MEAN_SURF_DISP; + comm_stage = COMM_DDELTA_BAR; comm->forward_comm(this, 1); } @@ -177,7 +186,7 @@ int FixGranularMDR::pack_forward_comm(int n, int *list, double *buf, int /*pbc_f { double **dvector = atom->dvector; int m = 0; - if (comm_stage == RADIUS_UPDATE) { + if (comm_stage == COMM_RADIUS_UPDATE) { for (int i = 0; i < n; i++) { int j = list[i]; buf[m++] = dvector[index_Ro][j]; // 1 @@ -218,7 +227,7 @@ void FixGranularMDR::unpack_forward_comm(int n, int first, double *buf) int m = 0; int last = first + n; - if (comm_stage == RADIUS_UPDATE) { + if (comm_stage == COMM_RADIUS_UPDATE) { for (int i = first; i < last; i++) { dvector[index_Ro][i] = buf[m++]; // 1 dvector[index_Vgeo][i] = buf[m++]; // 2 @@ -288,11 +297,6 @@ void FixGranularMDR::end_of_step() if ((radius[i] + dR) < (1.5 * Ro[i])) radius[i] += dR; } - // QUESTION: does it make more sense to initialize these in pre_force? - // ANSWER: The resetting/intialization of these values could likely also be done in pre_force. - // I only placed them here since they should only be reset after all MDR calcs are done - // for a particular particle in a given step. However, if the resetting is done - // prior to any MDR calcs in the next step it should effectivily be the same. Velas[i] = Vo * (1.0 + eps_bar[i]); Vcaps[i] = 0.0; eps_bar[i] = 0.0; @@ -303,8 +307,6 @@ void FixGranularMDR::end_of_step() Atot_sum[i] = 0.0; ddelta_bar[i] = 0.0; } - comm_stage = RADIUS_UPDATE; - comm->forward_comm(this, 20); } @@ -316,9 +318,9 @@ void FixGranularMDR::set_arrays(int i) { // QUESTION: which of these must be initialized to zero? // maybe just index_history_setup_flag? - // ANSWER: I would agree with how you have it right now. All of the variables being initialized - // to zero here should be zero when the atom is created. However, is it ever possible for - // calculate_forces() to be called without calling pre_force()? If the answer is no, then + // ANSWER: I would agree with how you have it right now. All of the variables being initialized + // to zero here should be zero when the atom is created. However, is it ever possible for + // calculate_forces() to be called without calling pre_force()? If the answer is no, then // we might be able to move the initializations/resetting of Velas[i] through ddelta_bar[i] // from end_of_step to pre_force. Then I think we could get rid of all the set arrays except // for history_setup_flag. Vo will have to be redefined in pre_force to allow Velas[i] to be set. @@ -386,9 +388,8 @@ void FixGranularMDR::radius_update() } /* ---------------------------------------------------------------------- - QUESTION: is there a physical description for this loop? - ANSWER: Screen for non-physical contacts occuring through obstructing particles. - Assign non-zero penalties to these contacts to adjust force evaluation. + Screen for non-physical contacts occuring through obstructing particles. + Assign non-zero penalties to these contacts to adjust force evaluation. ------------------------------------------------------------------------- */ void FixGranularMDR::calculate_contact_penalty() @@ -440,13 +441,10 @@ void FixGranularMDR::calculate_contact_penalty() const double radsum_ij = radi + radj; const double deltan_ij = radsum_ij - r_ij; if (deltan_ij < 0.0) continue; - for (int kk = jj; kk < jnum; kk++) { + for (int kk = jj + 1; kk < jnum; kk++) { k = jlist[kk]; k &= NEIGHMASK; - // QUESTION: why not start loop at jj+1? - // ANSWER: Good point, I can't think of any reason not to. - if (kk == jj) continue; const double delx_ik = x[k][0] - xtmp; const double dely_ik = x[k][1] - ytmp; const double delz_ik = x[k][2] - ztmp; @@ -478,9 +476,6 @@ void FixGranularMDR::calculate_contact_penalty() history_ik = &allhistory[size_history * kk]; double * pik = &history_ik[22]; // penalty for contact i and k - // QUESTION: is this comment accurate? - // ANSWER: Yes, looks accurate - // Find pair of atoms with the smallest overlap, atoms a & b, 3rd atom c is central // if a & b are both local: // calculate ab penalty and add to the pab[0] history entry @@ -551,11 +546,8 @@ void FixGranularMDR::calculate_contact_penalty() } } - // QUESTION: is this ever supposed to happen? - // ANSWER: No, it means the neighbor lists are either (i) not being built frequently enough - // or (ii) the size of the neighbor list is too small. An error should be given. if (pjk == nullptr) - error->one(FLERR, "Contact between a pair of particles was detected, however it is not reflected in the neighbor lists. To solve this issue either build the neighbor lists more frequently or increase their size (e.g. increase the skin distance)."); + error->one(FLERR, "Contact between a pair of particles was detected by the MDR model, however it is not reflected in the neighbor lists. To solve this issue either build the neighbor lists more frequently or increase their size (e.g. increase the skin distance)."); pjk[0] += 1.0 / (1.0 + std::exp(-50.0 * (alpha / MY_PI - 0.5))); } @@ -567,8 +559,7 @@ void FixGranularMDR::calculate_contact_penalty() /* ---------------------------------------------------------------------- - QUESTION: is there a physical description for this loop? - ANSWER: Calculate mean surface displacement increment for each particle + Calculate mean surface displacement increment for each particle ------------------------------------------------------------------------- */ void FixGranularMDR::mean_surf_disp() diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index e65747f374..ef77e138b1 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -40,6 +40,7 @@ static constexpr double JKRPREFIX = 1.2277228507842888; // cbrt(3*PI**2/ static constexpr int MDR_MAX_IT = 100; // Newton-Raphson for MDR static constexpr double MDR_EPSILON1 = 1e-10; // Newton-Raphson for MDR static constexpr double MDR_EPSILON2 = 1e-16; // Newton-Raphson for MDR +static constexpr double MDR_OVERLAP_LIMIT = 0.75; // Maximum contact overlap for MDR static const char cite_mdr[] = "MDR contact model command: \n\n" @@ -561,7 +562,6 @@ double GranSubModNormalMDR::calculate_forces() if (gm->delta >= *deltamax_offset) *deltamax_offset = gm->delta; deltamax = *deltamax_offset; - double overlap_limit = 0.75; for (int contactSide = 0; contactSide < 2; contactSide++) { double *delta_offset, *deltao_offset, *delta_MDR_offset, *delta_BULK_offset; @@ -587,13 +587,13 @@ double GranSubModNormalMDR::calculate_forces() double delta_geo, delta_geo_alt; double delta_geoOpt1 = deltamax * (deltamax - 2.0 * R1) / (2.0 * (deltamax - R0 - R1)); double delta_geoOpt2 = deltamax * (deltamax - 2.0 * R0) / (2.0 * (deltamax - R0 - R1)); - (R0 < gm->radj) ? delta_geo = MAX(delta_geoOpt1, delta_geoOpt2) : delta_geo = MIN(delta_geoOpt1, delta_geoOpt2); - (R0 > gm->radj) ? delta_geo_alt = MAX(delta_geoOpt1, delta_geoOpt2) : delta_geo_alt = MIN(delta_geoOpt1, delta_geoOpt2); + (R0 < R1) ? delta_geo = MAX(delta_geoOpt1, delta_geoOpt2) : delta_geo = MIN(delta_geoOpt1, delta_geoOpt2); + (R0 > R1) ? delta_geo_alt = MAX(delta_geoOpt1, delta_geoOpt2) : delta_geo_alt = MIN(delta_geoOpt1, delta_geoOpt2); - if (delta_geo / R0 > overlap_limit) { - delta_geo = R0 * overlap_limit; - } else if (delta_geo_alt / gm->radj > overlap_limit) { - delta_geo = deltamax - gm->radj * overlap_limit; + if (delta_geo / R0 > MDR_OVERLAP_LIMIT) { + delta_geo = R0 * MDR_OVERLAP_LIMIT; + } else if (delta_geo_alt / R1 > MDR_OVERLAP_LIMIT) { + delta_geo = deltamax - R1 * MDR_OVERLAP_LIMIT; } double deltap = deltap0 + deltap1; @@ -618,24 +618,26 @@ double GranSubModNormalMDR::calculate_forces() // R0 = gm->radi; // R1 = gm->radj; // here to mirror above? After confirming, these two conditions can be easily collapsed to remove duplication and clarify differences (also replace gm->radi/radj with R0/R1) - // ANSWER: If I am not mistaken R0 & R1 will always be set to non-zero values from the case above where contactSide = 0: + // ANSWER: If I am not mistaken R0 & R1 will always be set to non-zero values from the case above where contactSide = 0: // R0 = gm->radi; // R1 = gm->radj; - // Then their values will carry over into this else statement for the case of contactSide = 1. I don't want their values to change after they are set above, + // Then their values will carry over into this else statement for the case of contactSide = 1. I don't want their values to change after they are set above, // hence why I didn't redine them. // // However, this is written in a bit of a strange way now that I am reviewing it, I will give it some more thought. - + // ANSWER2: What if the contact type is WALL, then the iteration over contactSide = 0 will skip + // defining R0 and R1? Is that correct? + double delta_geo, delta_geo_alt; double delta_geoOpt1 = deltamax * (deltamax - 2.0 * R1) / (2.0 * (deltamax - R0 - R1)); double delta_geoOpt2 = deltamax * (deltamax - 2.0 * R0) / (2.0 * (deltamax - R0 - R1)); (gm->radi < gm->radj) ? delta_geo = MAX(delta_geoOpt1,delta_geoOpt2) : delta_geo = MIN(delta_geoOpt1, delta_geoOpt2); (gm->radi > gm->radj) ? delta_geo_alt = MAX(delta_geoOpt1,delta_geoOpt2) : delta_geo_alt = MIN(delta_geoOpt1,delta_geoOpt2); - if (delta_geo / gm->radi > overlap_limit) { - delta_geo = gm->radi * overlap_limit; - } else if (delta_geo_alt / gm->radj > overlap_limit) { - delta_geo = deltamax - gm->radj * overlap_limit; + if (delta_geo / gm->radi > MDR_OVERLAP_LIMIT) { + delta_geo = gm->radi * MDR_OVERLAP_LIMIT; + } else if (delta_geo_alt / gm->radj > MDR_OVERLAP_LIMIT) { + delta_geo = deltamax - gm->radj * MDR_OVERLAP_LIMIT; } double deltap = deltap0 + deltap1; From 534632a59803d57ff37a655cdee0da2ffb85d30e Mon Sep 17 00:00:00 2001 From: William Zunker Date: Fri, 3 Jan 2025 14:29:14 -0500 Subject: [PATCH 31/74] Answered commented questions --- src/GRANULAR/fix_granular_mdr.cpp | 16 +++++++++++++++- src/GRANULAR/gran_sub_mod_normal.cpp | 1 + 2 files changed, 16 insertions(+), 1 deletion(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index a2ef4f31b2..2f6676dcce 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -139,6 +139,19 @@ void FixGranularMDR::setup_pre_force(int /*vflag*/) // ANSWER2: So users cannot define 2 MDR models with different moduli? // Should an error be invoked if two MDR models are therefore defined? // Should there be an error if a user uses a non-MDR model with an MDR model? + // ANSWER3: So users cannot define 2 MDR models with different moduli? + // -> Correct, as of now it only makes sense to have 1 MDR model with one set of material + // properties defined per simulation. + // Should an error be invoked if two MDR models are therefore defined? + // -> Yes, it would be good to have an error alerting the user that only 1 MDR model + // is allowed to be defined. + // Should there be an error if a user uses a non-MDR model with an MDR model? + // -> It depends, if it is a rolling or tangential model then its okay. We superimpose + // the MDR model with a rolling and tangential model for the tableting simulation. + // However, I don't think we should allow other normal models to be defined. I don't + // really know what it would mean physically if a hooke-particle contacted a mdr-particle. + // The gran/wall/region interaction should also be MDR so that the mean surface displacement + // is correctly calculated. psi_b_coeff = norm_model->psi_b; @@ -165,9 +178,10 @@ void FixGranularMDR::pre_force(int) mean_surf_disp(); // QUESTION: What about fix wall/gran? - // Answer: We never considered interaction between the mdr contact model and fix wall/gran + // ANSWER: We never considered interaction between the mdr contact model and fix wall/gran // ANSWER2: Ideally this would be added, but at least temporarily I added an // error. This incompatibility should be noted in the docs + // ANSWER3: Sounds good. auto fix_list = modify->get_fix_by_style("wall/gran"); for (int i = 0; i < fix_list.size(); i++) { diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index ef77e138b1..1c3df456f9 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -627,6 +627,7 @@ double GranSubModNormalMDR::calculate_forces() // However, this is written in a bit of a strange way now that I am reviewing it, I will give it some more thought. // ANSWER2: What if the contact type is WALL, then the iteration over contactSide = 0 will skip // defining R0 and R1? Is that correct? + // ANSWER3: Correct, but in that case they are not needed since there is no partitioning of the displacement. double delta_geo, delta_geo_alt; double delta_geoOpt1 = deltamax * (deltamax - 2.0 * R1) / (2.0 * (deltamax - R0 - R1)); From 2b10fc153b291a1e7d8c388f559b86877b143b51 Mon Sep 17 00:00:00 2001 From: William Zunker Date: Fri, 3 Jan 2025 17:43:38 -0500 Subject: [PATCH 32/74] Started adding mdr model to pair_granular.rst --- doc/src/pair_granular.rst | 62 +++++++++++++++++++++++++++++++++++++++ 1 file changed, 62 insertions(+) diff --git a/doc/src/pair_granular.rst b/doc/src/pair_granular.rst index e0f15ccd62..2aec9828ea 100644 --- a/doc/src/pair_granular.rst +++ b/doc/src/pair_granular.rst @@ -82,6 +82,7 @@ and their required arguments are: 3. *hertz/material* : E, :math:`\eta_{n0}` (or :math:`e`), :math:`\nu` 4. *dmt* : E, :math:`\eta_{n0}` (or :math:`e`), :math:`\nu`, :math:`\gamma` 5. *jkr* : E, :math:`\eta_{n0}` (or :math:`e`), :math:`\nu`, :math:`\gamma` +6. *mdr* : :math:`E`, :math:`\nu`, :math:`Y`, :math:`\Delta\gamma`, :math:`\psi_b`, :math:`e` Here, :math:`k_n` is spring stiffness (with units that depend on model choice, see below); :math:`\eta_{n0}` is a damping prefactor (or, in its @@ -162,6 +163,45 @@ initially will not experience force until they come into contact experience a tensile force up to :math:`3\pi\gamma R`, at which point they lose contact. +The *mdr* model is a mechanically-derived contact model able to capture the +contact response between adhesive elastic-plastic particles into large deformation. +The inputs to the model are primarily physical material +properties: Young's Modulus :math:`E`, Poisson's ratio :math:`\nu`, +yield stress :math:`Y`, effective surface energy :math:`\Delta\gamma`, and +coefficent of restitution :math:`e`. The execption is the critical confinement +ratio :math:`\psi_b` which is a geometrically motivated criterion for determining +when the bulk elastic response will trigger. The adhesive response is based on +a JKR-type fracture mechanics based formulation that is valid into large deformation. + +The majority of the theoritical foundations of the *mdr* model are developed in the +two part series :ref:`Zunker and Kamrin Part I ` and +:ref:`Zunker and Kamrin Part II `. Additional development +of the model and demonstration of its ability to simulate industrially relavant +powder compaction processes are presented in :ref:`Zunker et al. ` + +.. note:: + + The *mdr* model requires some specific settings to function properly, + please read the following text carefully to ensure all requirments are + followed. + +Newton's third law must be set *off*. This ensures that the neighbor lists +are constructed properly for the topological penalty algorithm used to screen +for non-physical contacts occurring through obstructing particles, an issue +prevelant under large deformation conditions. For more information on this +algorithm see :ref:`Zunker et al. ` + +.. code-block:: LAMMPS + + newton off + +The damping model must be set to *none*. The *mdr* model already has a built +in damping model. + +.. code-block:: LAMMPS + + pair_coeff * * mdr 5e6 0.4 1.9e5 2 0.5 0.5 damping none + ---------- In addition, the normal force is augmented by a damping term of the @@ -870,6 +910,28 @@ solids. Proc. R. Soc. Lond. A, 324(1558), 301-313. Y. P. (1975). Effect of contact deformations on the adhesion of particles. Journal of Colloid and interface science, 53(2), 314-326. +.. _Zunker2024I: + +**(Zunker et al, 2024)** Zunker, W., & Kamrin, K. (2024). +A mechanically-derived contact model for adhesive elastic-perfectly +plastic particles, Part I: Utilizing the method of dimensionality +reduction. Journal of the Mechanics and Physics of Solids, 183, 105492. + +.. _Zunker2024II: + +**(Zunker et al, 2024)** Zunker, W., & Kamrin, K. (2024). +A mechanically-derived contact model for adhesive elastic-perfectly +plastic particles, Part II: Contact under high compaction—modeling +a bulk elastic response. Journal of the Mechanics and Physics of Solids, +183, 105493. + +.. _Zunker2025: + +**(Zunker et al, 2025)** Zunker, W., Dunatunga, S., Thakur, S., +Tang, P., & Kamrin, K. (2025). Experimentally validated DEM for large +deformation powder compaction: mechanically-derived contact model and +screening of non-physical contacts. engrXiv. + .. _Luding2008: **(Luding, 2008)** Luding, S. (2008). Cohesive, frictional powders: From 119aa59016ebc59c32601db78ccb3e921cb0877d Mon Sep 17 00:00:00 2001 From: jtclemm Date: Fri, 3 Jan 2025 16:47:16 -0700 Subject: [PATCH 33/74] Improving error checks --- src/GRANULAR/fix_granular_mdr.cpp | 177 +++++++++++++++-------------- src/GRANULAR/fix_granular_mdr.h | 3 +- src/GRANULAR/gran_sub_mod_normal.h | 5 +- 3 files changed, 95 insertions(+), 90 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index 2f6676dcce..ac605b8153 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -45,6 +45,7 @@ using namespace FixConst; using MathConst::MY_PI; static constexpr double EPSILON = 1e-16; +static constexpr double OVERLAP_LIMIT = 0.75; enum {COMM_RADIUS_UPDATE, COMM_DDELTA_BAR}; @@ -115,46 +116,62 @@ void FixGranularMDR::setup_pre_force(int /*vflag*/) if (pair == nullptr) error->all(FLERR, "Must use pair granular with MDR model"); - class GranularModel* model; - class GranularModel** models_list = pair->models_list; - class GranSubModNormalMDR* norm_model = nullptr; + // Confirm all MDR models are consistent + + class GranularModel *pair_model, *fix_model; + class GranularModel **models_list = pair->models_list; + class GranSubModNormalMDR *norm_model = nullptr; for (int i = 0; i < pair->nmodels; i++) { - model = models_list[i]; - if (model->normal_model->name == "mdr") - norm_model = dynamic_cast(model->normal_model); + pair_model = models_list[i]; + if (pair_model->normal_model->name == "mdr") { + if (norm_model != nullptr) + error->all(FLERR, "Cannot currently define multiple MDR normal models in the pairstyle"); + norm_model = dynamic_cast(pair_model->normal_model); + } else { + error->all(FLERR, "Cannot combine MDR normal model with a different normal model in the pairstyle"); + } } if (norm_model == nullptr) error->all(FLERR, "Must specify MDR normal model with pair granular"); + psi_b_coeff = norm_model->psi_b; + + fix_wall_list = modify->get_fix_by_style("wall/gran/region"); + class GranSubModNormalMDR *norm_model2; + class FixWallGranRegion *fix; + for (int i = 0; i < fix_wall_list.size(); i++) { + if (!utils::strmatch(fix_wall_list[i]->style, "wall/gran/region")) + error->all(FLERR, "MDR model currently only supports fix wall/gran/region, not fix wall/gran"); + + fix = dynamic_cast(fix_wall_list[i]); + if (fix->model->normal_model->name != "mdr") + error->all(FLERR, "Fix wall/gran/region must use an MDR normal model when using an MDR pair model"); + + norm_model2 = dynamic_cast(fix->model->normal_model); + + // QUESTION: which of these coefficients must be identical? + //if (norm_model->E != norm_model2->E) + // error->all(FLERR, "Young's modulus in pair style, {}, does not agree with value {} in fix gran/wall/region", + // norm_model->E, norm_model2->E); + //if (norm_model->nu != norm_model2->nu) + // error->all(FLERR, "Poisson's ratio in pair style, {}, does not agree with value {} in fix gran/wall/region", + // norm_model->nu, norm_model2->nu); + //if (norm_model->Y != norm_model2->Y) + // error->all(FLERR, "Yield stress in pair style, {}, does not agree with value {} in fix gran/wall/region", + // norm_model->Y, norm_model2->Y); + //if (norm_model->gamma != norm_model2->gamma) + // error->all(FLERR, "Surface energy in pair style, {}, does not agree with value {} in fix gran/wall/region", + // norm_model->gamma, norm_model2->gamma); + //if (norm_model->CoR != norm_model2->CoR) + // error->all(FLERR, "Coefficient of restitution in pair style, {}, does not agree with value {} in fix gran/wall/region", + // norm_model->CoR, norm_model2->CoR); + //if (norm_model->psi_b != norm_model2->psi_b) + // error->all(FLERR, "Bulk response trigger in pair style, {}, does not agree with value {} in fix gran/wall/region", + // norm_model->psi_b, norm_model2->psi_b); + } fix_history = dynamic_cast(modify->get_fix_by_id("NEIGH_HISTORY_GRANULAR")); - - // QUESTION: can psi_b be different in different models? - // ANSWER: psi_b is a required argument when defining the mdr contact model (i.e. coeffs[4]). - // It is a unique parameter to only the mdr model. - // It is allowed to vary as a parameter meaning it can be different for each simulation. - // Like the other coeffs for the MDR model no sensible mixing rule exists at the moment - // meaning only one material type can be considered. - // ANSWER2: So users cannot define 2 MDR models with different moduli? - // Should an error be invoked if two MDR models are therefore defined? - // Should there be an error if a user uses a non-MDR model with an MDR model? - // ANSWER3: So users cannot define 2 MDR models with different moduli? - // -> Correct, as of now it only makes sense to have 1 MDR model with one set of material - // properties defined per simulation. - // Should an error be invoked if two MDR models are therefore defined? - // -> Yes, it would be good to have an error alerting the user that only 1 MDR model - // is allowed to be defined. - // Should there be an error if a user uses a non-MDR model with an MDR model? - // -> It depends, if it is a rolling or tangential model then its okay. We superimpose - // the MDR model with a rolling and tangential model for the tableting simulation. - // However, I don't think we should allow other normal models to be defined. I don't - // really know what it would mean physically if a hooke-particle contacted a mdr-particle. - // The gran/wall/region interaction should also be MDR so that the mean surface displacement - // is correctly calculated. - - psi_b_coeff = norm_model->psi_b; - pre_force(0); } @@ -176,19 +193,7 @@ void FixGranularMDR::pre_force(int) calculate_contact_penalty(); mean_surf_disp(); - - // QUESTION: What about fix wall/gran? - // ANSWER: We never considered interaction between the mdr contact model and fix wall/gran - // ANSWER2: Ideally this would be added, but at least temporarily I added an - // error. This incompatibility should be noted in the docs - // ANSWER3: Sounds good. - - auto fix_list = modify->get_fix_by_style("wall/gran"); - for (int i = 0; i < fix_list.size(); i++) { - if (!utils::strmatch(fix_list[i]->style, "wall/gran/region")) - error->all(FLERR, "MDR model currently only supports fix wall/gran/region, not fix wall/gran"); - update_fix_gran_wall(fix_list[i]); - } + update_fix_gran_wall(); comm_stage = COMM_DDELTA_BAR; comm->forward_comm(this, 1); @@ -675,13 +680,11 @@ void FixGranularMDR::mean_surf_disp() (R0 < R1) ? delta_geo0 = MAX(deltaOpt1, deltaOpt2) : delta_geo0 = MIN(deltaOpt1, deltaOpt2); (R0 < R1) ? delta_geo1 = MIN(deltaOpt1, deltaOpt2) : delta_geo1 = MAX(deltaOpt1, deltaOpt2); - double overlap_limit = 0.75; - - if (delta_geo0 / R0 > overlap_limit) { - delta_geo0 = R0 * overlap_limit; + if (delta_geo0 / R0 > OVERLAP_LIMIT) { + delta_geo0 = R0 * OVERLAP_LIMIT; delta_geo1 = deltamax - delta_geo0; - } else if (delta_geo1 / R1 > overlap_limit) { - delta_geo1 = R1 * overlap_limit; + } else if (delta_geo1 / R1 > OVERLAP_LIMIT) { + delta_geo1 = R1 * OVERLAP_LIMIT; delta_geo0 = deltamax - delta_geo1; } @@ -710,13 +713,8 @@ void FixGranularMDR::mean_surf_disp() Update instance of fix gran/wall ------------------------------------------------------------------------- */ -void FixGranularMDR::update_fix_gran_wall(Fix* fix_in) +void FixGranularMDR::update_fix_gran_wall() { - FixWallGranRegion* fix = dynamic_cast(fix_in); - GranularModel * model = fix->model; - Region * region = fix->region; - - const int size_history = model->size_history; int i, m, nc, iwall; double **x = atom->x; @@ -727,40 +725,47 @@ void FixGranularMDR::update_fix_gran_wall(Fix* fix_in) double *Acon0 = atom->dvector[index_Acon0]; double *ddelta_bar = atom->dvector[index_ddelta_bar]; - if (region->dynamic_check()) - region->prematch(); + for (int w = 0; w < fix_wall_list.size(); w++) { + FixWallGranRegion *fix = dynamic_cast(fix_wall_list[w]); + GranularModel *model = fix->model; + const int size_history = model->size_history; + Region *region = fix->region; - for (i = 0; i < nlocal; i++) { - if (!(mask[i] & groupbit)) continue; - if (! region->match(x[i][0], x[i][1], x[i][2])) continue; + if (region->dynamic_check()) + region->prematch(); - nc = region->surface(x[i][0], x[i][1], x[i][2], radius[i] + model->pulloff_distance(radius[i], 0.0)); + for (i = 0; i < nlocal; i++) { + if (!(mask[i] & groupbit)) continue; + if (! region->match(x[i][0], x[i][1], x[i][2])) continue; - if (nc == 0) { - fix->ncontact[i] = 0; - continue; - } - if (nc == 1) { - fix->c2r[0] = 0; - iwall = region->contact[0].iwall; - if (fix->ncontact[i] == 0) { - fix->ncontact[i] = 1; - fix->walls[i][0] = iwall; - for (m = 0; m < size_history; m++) fix->history_many[i][0][m] = 0.0; - } else if (fix->ncontact[i] > 1 || iwall != fix->walls[i][0]) + nc = region->surface(x[i][0], x[i][1], x[i][2], radius[i] + model->pulloff_distance(radius[i], 0.0)); + + if (nc == 0) { + fix->ncontact[i] = 0; + continue; + } + if (nc == 1) { + fix->c2r[0] = 0; + iwall = region->contact[0].iwall; + if (fix->ncontact[i] == 0) { + fix->ncontact[i] = 1; + fix->walls[i][0] = iwall; + for (m = 0; m < size_history; m++) fix->history_many[i][0] [m] = 0.0; + } else if (fix->ncontact[i] > 1 || iwall != fix->walls[i][0]) + fix->update_contacts(i, nc); + } else fix->update_contacts(i, nc); - } else - fix->update_contacts(i, nc); - // process current contacts - for (int ic = 0; ic < nc; ic++) { - const double wij = 1.0; - if (Acon0[i] != 0.0) { - const double delta = radius[i] - region->contact[ic].r; - const double delta_offset0 = fix->history_many[i][fix->c2r[ic]][0]; - const double ddelta = delta - delta_offset0; - const double Ac_offset0 = fix->history_many[i][fix->c2r[ic]][18]; - ddelta_bar[i] += wij * Ac_offset0 / Acon0[i] * ddelta; + // process current contacts + for (int ic = 0; ic < nc; ic++) { + const double wij = 1.0; + if (Acon0[i] != 0.0) { + const double delta = radius[i] - region->contact[ic].r; + const double delta_offset0 = fix->history_many[i][fix->c2r[ic]][0]; + const double ddelta = delta - delta_offset0; + const double Ac_offset0 = fix->history_many[i][fix->c2r[ic]][18]; + ddelta_bar[i] += wij * Ac_offset0 / Acon0[i] * ddelta; + } } } } diff --git a/src/GRANULAR/fix_granular_mdr.h b/src/GRANULAR/fix_granular_mdr.h index caa90621c3..d97bed6723 100644 --- a/src/GRANULAR/fix_granular_mdr.h +++ b/src/GRANULAR/fix_granular_mdr.h @@ -76,11 +76,12 @@ class FixGranularMDR : public Fix { double psi_b_coeff; class PairGranular *pair; class FixNeighHistory *fix_history; + std::vector fix_wall_list; void radius_update(); void mean_surf_disp(); void calculate_contact_penalty(); - void update_fix_gran_wall(Fix*); + void update_fix_gran_wall(); int index_Ro; // initial radius int index_Vgeo; // geometric particle volume of apparent particle afterremoving spherical cap volume diff --git a/src/GRANULAR/gran_sub_mod_normal.h b/src/GRANULAR/gran_sub_mod_normal.h index 855ae67965..092ab2b147 100644 --- a/src/GRANULAR/gran_sub_mod_normal.h +++ b/src/GRANULAR/gran_sub_mod_normal.h @@ -144,11 +144,10 @@ namespace Granular_NS { void init() override; double calculate_forces() override; void set_fncrit() override; - double psi_b; + double E, nu, Y, gamma, CoR, psi_b; // specified coeffs protected: - double E, nu, Y, gamma, CoR; // specified coeffs - double G, kappa, Eeff; // derived coeffs + double G, kappa, Eeff; // derived coeffs double F; int index_Ro, index_Vgeo, index_Velas, index_Vcaps, index_eps_bar, index_dRnumerator; From df75830d6325cb17f5c6c4909147bfd6ff94abb6 Mon Sep 17 00:00:00 2001 From: William Zunker Date: Sat, 4 Jan 2025 20:38:23 -0500 Subject: [PATCH 34/74] Added error msgs to fix_granular_mdr.cpp and completed first draft mdr pair_granular.rst --- doc/src/pair_granular.rst | 118 ++++++++++++++++++++++++++---- src/GRANULAR/fix_granular_mdr.cpp | 34 ++++----- 2 files changed, 118 insertions(+), 34 deletions(-) diff --git a/doc/src/pair_granular.rst b/doc/src/pair_granular.rst index 2aec9828ea..42b915fa05 100644 --- a/doc/src/pair_granular.rst +++ b/doc/src/pair_granular.rst @@ -40,6 +40,9 @@ Examples pair_style granular pair_coeff * * hertz 1000.0 50.0 tangential mindlin 1000.0 1.0 0.4 heat area 0.1 + pair_style granular + pair_coeff * * mdr 5e6 0.4 1.9e5 2.0 0.5 0.5 tangential linear_history 940.0 0.0 0.7 rolling sds 2.7e5 0.0 0.6 damping none + Description """"""""""" @@ -163,33 +166,77 @@ initially will not experience force until they come into contact experience a tensile force up to :math:`3\pi\gamma R`, at which point they lose contact. -The *mdr* model is a mechanically-derived contact model able to capture the +The *mdr* model is a mechanically-derived contact model designed to capture the contact response between adhesive elastic-plastic particles into large deformation. -The inputs to the model are primarily physical material -properties: Young's Modulus :math:`E`, Poisson's ratio :math:`\nu`, -yield stress :math:`Y`, effective surface energy :math:`\Delta\gamma`, and -coefficent of restitution :math:`e`. The execption is the critical confinement -ratio :math:`\psi_b` which is a geometrically motivated criterion for determining -when the bulk elastic response will trigger. The adhesive response is based on -a JKR-type fracture mechanics based formulation that is valid into large deformation. +The theoritical foundations of the *mdr* model are detailed in the +two-part series :ref:`Zunker and Kamrin Part I ` and +:ref:`Zunker and Kamrin Part II `. Further development +and demonstrations of its application to industrially relevant powder +compaction processes are presented in :ref:`Zunker et al. `. -The majority of the theoritical foundations of the *mdr* model are developed in the -two part series :ref:`Zunker and Kamrin Part I ` and -:ref:`Zunker and Kamrin Part II `. Additional development -of the model and demonstration of its ability to simulate industrially relavant -powder compaction processes are presented in :ref:`Zunker et al. ` +The model requires the following inputs: + + 1. *Young's modulus* :math:`E > 0` : The Young's modulus is commonly reported + for various powders. + + 2. *Poissons ratio* :math:`0 \le \nu \le 0.5` : The Poisson's ratio is commonly + reported for various powders. + + 3. *Yield stress* :math:`Y \ge 0` : The yield stress is often known for powders + composed of materials such as metals but may be unreported for ductile organic + materials, in which case it can be treated as a free parameter. + + 4. *Effective surface energy* :math:`\Delta\gamma \ge 0` : The effective surface + energy for powder compaction applications is most easily determined through its + relation to the more commonly reported critical stress intensity factor + :math:`K_{Ic} = \sqrt{2\Delta\gamma E/(1-\nu^2)}`. + + 5. *Critical confinement ratio* :math:`0 \le \psi_b \le 1` : The critcal confinment + ratio is a tunable parameter that determines when the bulk elastic response is + triggered. Lower values of :math:`\psi_b` delay the onset of the bulk elastic + response. + + 6. *Coefficient of restiution* :math:`0 \le e \le 1` : The coefficient of + restitution is a tunable parameter that controls damping in the normal direction. + +.. note:: + + The values for :math:`E`, :math:`\nu`, :math:`Y`, and :math:`\Delta\gamma` (i.e., + :math:`K_{Ic}`) should be selected for zero porosity to reflect the intrinsic + material property rather than the bulk powder property. + +The *mdr* model produces a nonlinear force-displacement response, therefore the +critical timestep :math:`\Delta t` depends on the inputs and level of +deformation. As a conservative starting point the timestep can be assumed to be +dictated by the bulk elastic response such that +:math:`\Delta t = 0.35\sqrt{m/k_\textrm{bulk}}`, where :math:`m` is the mass of +the smallest particle and :math:`k_\textrm{bulk} = \kappa R_\textrm{min}` is an +effective stiffness related to the bulk elastic response. +Here, :math:`\kappa = E/(3(1-2\nu))` is the bulk modulus and +:math:`R_\textrm{min}` is the radius of the smallest particle. .. note:: The *mdr* model requires some specific settings to function properly, - please read the following text carefully to ensure all requirments are + please read the following text carefully to ensure all requirements are followed. +The *atom_style* must be set to *sphere 1* to enable dynamic particle +radii. The *mdr* model is designed to respect the incompressibility of +plastic deformation and inherently tracks free surface displacements +induced by all particle contacts. Setting *atom_style sphere 1* ensures +that updates to the particle radius are properly reflected throughout +the simulation. + +.. code-block:: LAMMPS + + atom_style sphere 1 + Newton's third law must be set *off*. This ensures that the neighbor lists are constructed properly for the topological penalty algorithm used to screen for non-physical contacts occurring through obstructing particles, an issue prevelant under large deformation conditions. For more information on this -algorithm see :ref:`Zunker et al. ` +algorithm see :ref:`Zunker et al. `. .. code-block:: LAMMPS @@ -202,6 +249,47 @@ in damping model. pair_coeff * * mdr 5e6 0.4 1.9e5 2 0.5 0.5 damping none +The definition of multiple *mdr* models in the *pair_style* is currently not +supported. Similarly, the *mdr* model cannot be combined with a different normal +model in the *pair_style*. Phyiscally this means that only one homogenous +collection of particles governed by a single *mdr* model is allowed. + +The *mdr* model currently only supports *fix wall/gran/region*, not +*fix wall/gran*. If the *mdr* model is specified for the *pair_style* +any *fix wall/gran/region* commands must also use the *mdr* model. +Additionally, the following *mdr* inputs must match between the +*pair_style* and *fix wall/gran/region* definitions: :math:`E`, +:math:`\nu`, :math:`Y`, :math:`\psi_b`, and :math:`e`. The exception +is :math:`\Delta\gamma`, which may vary, permitting different +adhesive behaviors between particle-particle and particle-wall interactions. + +.. note:: + + The *mdr* model has a number of custom *property/atom* definitions that + can be called in the input file. The useful properties for visualization + and analysis are described below. + +In addition to contact forces the *mdr* model also tracks the following +quantities for each particle: elastic volume change, the average normal +stress components for each particle, and total surface area involved in +contact. In the input script these quantities can be accessed through the +*compute* command. + +.. code-block:: LAMMPS + + compute ID group-ID property/atom d_Velas + compute ID group-ID property/atom d_sigmaxx + compute ID group-ID property/atom d_sigmayy + compute ID group-ID property/atom d_sigmazz + compute ID group-ID property/atom d_Acon1 + +.. note:: + + The *mdr* model has two example input scripts within the + *examples/granular* directory. The first is a die compaction + simulation involving 200 particles named *in.tableting.200*. + The second is a triaxial compaction simulation involving 12 + particles named *in.triaxial.compaction.12*. ---------- In addition, the normal force is augmented by a damping term of the diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index ac605b8153..d34d1e6698 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -149,25 +149,21 @@ void FixGranularMDR::setup_pre_force(int /*vflag*/) norm_model2 = dynamic_cast(fix->model->normal_model); - // QUESTION: which of these coefficients must be identical? - //if (norm_model->E != norm_model2->E) - // error->all(FLERR, "Young's modulus in pair style, {}, does not agree with value {} in fix gran/wall/region", - // norm_model->E, norm_model2->E); - //if (norm_model->nu != norm_model2->nu) - // error->all(FLERR, "Poisson's ratio in pair style, {}, does not agree with value {} in fix gran/wall/region", - // norm_model->nu, norm_model2->nu); - //if (norm_model->Y != norm_model2->Y) - // error->all(FLERR, "Yield stress in pair style, {}, does not agree with value {} in fix gran/wall/region", - // norm_model->Y, norm_model2->Y); - //if (norm_model->gamma != norm_model2->gamma) - // error->all(FLERR, "Surface energy in pair style, {}, does not agree with value {} in fix gran/wall/region", - // norm_model->gamma, norm_model2->gamma); - //if (norm_model->CoR != norm_model2->CoR) - // error->all(FLERR, "Coefficient of restitution in pair style, {}, does not agree with value {} in fix gran/wall/region", - // norm_model->CoR, norm_model2->CoR); - //if (norm_model->psi_b != norm_model2->psi_b) - // error->all(FLERR, "Bulk response trigger in pair style, {}, does not agree with value {} in fix gran/wall/region", - // norm_model->psi_b, norm_model2->psi_b); + if (norm_model->E != norm_model2->E) + error->all(FLERR, "Young's modulus in pair style, {}, does not agree with value {} in fix gran/wall/region", + norm_model->E, norm_model2->E); + if (norm_model->nu != norm_model2->nu) + error->all(FLERR, "Poisson's ratio in pair style, {}, does not agree with value {} in fix gran/wall/region", + norm_model->nu, norm_model2->nu); + if (norm_model->Y != norm_model2->Y) + error->all(FLERR, "Yield stress in pair style, {}, does not agree with value {} in fix gran/wall/region", + norm_model->Y, norm_model2->Y); + if (norm_model->psi_b != norm_model2->psi_b) + error->all(FLERR, "Bulk response trigger in pair style, {}, does not agree with value {} in fix gran/wall/region", + norm_model->psi_b, norm_model2->psi_b); + if (norm_model->CoR != norm_model2->CoR) + error->all(FLERR, "Coefficient of restitution in pair style, {}, does not agree with value {} in fix gran/wall/region", + norm_model->CoR, norm_model2->CoR); } fix_history = dynamic_cast(modify->get_fix_by_id("NEIGH_HISTORY_GRANULAR")); From e9057ae5c8b4f1d84204c8538b9a2e99d8dd74f6 Mon Sep 17 00:00:00 2001 From: William Zunker Date: Mon, 6 Jan 2025 14:18:36 -0500 Subject: [PATCH 35/74] mdr radius update explaination added to pair_granular.rst --- doc/src/pair_granular.rst | 15 +++++++++++---- 1 file changed, 11 insertions(+), 4 deletions(-) diff --git a/doc/src/pair_granular.rst b/doc/src/pair_granular.rst index 42b915fa05..2f7efee65a 100644 --- a/doc/src/pair_granular.rst +++ b/doc/src/pair_granular.rst @@ -224,15 +224,22 @@ Here, :math:`\kappa = E/(3(1-2\nu))` is the bulk modulus and The *atom_style* must be set to *sphere 1* to enable dynamic particle radii. The *mdr* model is designed to respect the incompressibility of plastic deformation and inherently tracks free surface displacements -induced by all particle contacts. Setting *atom_style sphere 1* ensures -that updates to the particle radius are properly reflected throughout -the simulation. +induced by all particle contacts. In practice, this means that all particles +begin with an initial radius, however as compaction occurs and plastic +deformation is accumulated, a new enlarged apparent radius is defined to +ensure that that volume change due to plastic deformation is not lost. +This apparent radius is stored as the *atom radius* meaning it is used +for subsequent neighbor list builds and contact dectection checks. The +advantage of this is that multi-neighbor dependent effects such as +formation of secondary contacts caused by radial expansion are captured +by the *mdr* model. Setting *atom_style sphere 1* ensures that updates to +the particle radius are properly reflected throughout the simulation. .. code-block:: LAMMPS atom_style sphere 1 -Newton's third law must be set *off*. This ensures that the neighbor lists +Newton's third law must be set to *off*. This ensures that the neighbor lists are constructed properly for the topological penalty algorithm used to screen for non-physical contacts occurring through obstructing particles, an issue prevelant under large deformation conditions. For more information on this From 2c655db73199a154fe960777f6f7069632c92204 Mon Sep 17 00:00:00 2001 From: William Zunker Date: Mon, 6 Jan 2025 15:11:57 -0500 Subject: [PATCH 36/74] Cleaned up example mdr input files --- doc/src/pair_granular.rst | 6 +- examples/granular/in.avicelTableting200 | 184 ------------------ examples/granular/in.tableting.200 | 153 +++++++++++++++ ...l12particles => in.triaxial.compaction.12} | 42 ++-- 4 files changed, 178 insertions(+), 207 deletions(-) delete mode 100644 examples/granular/in.avicelTableting200 create mode 100644 examples/granular/in.tableting.200 rename examples/granular/{in.mpfem.triaxial12particles => in.triaxial.compaction.12} (79%) diff --git a/doc/src/pair_granular.rst b/doc/src/pair_granular.rst index 2f7efee65a..6eac8dd2d1 100644 --- a/doc/src/pair_granular.rst +++ b/doc/src/pair_granular.rst @@ -279,11 +279,13 @@ adhesive behaviors between particle-particle and particle-wall interactions. In addition to contact forces the *mdr* model also tracks the following quantities for each particle: elastic volume change, the average normal stress components for each particle, and total surface area involved in -contact. In the input script these quantities can be accessed through the -*compute* command. +contact. In the input script these quantities can be accessed by first +calling *run 0* to initialize the values then through subsequent +*compute* commands. .. code-block:: LAMMPS + run 0 compute ID group-ID property/atom d_Velas compute ID group-ID property/atom d_sigmaxx compute ID group-ID property/atom d_sigmayy diff --git a/examples/granular/in.avicelTableting200 b/examples/granular/in.avicelTableting200 deleted file mode 100644 index 863436bade..0000000000 --- a/examples/granular/in.avicelTableting200 +++ /dev/null @@ -1,184 +0,0 @@ -############################### SIMULATION SETTINGS ################################################### - -atom_style sphere 1 -atom_modify map array -comm_modify vel yes -units si -newton off -neighbor 1.0e-3 bin -neigh_modify every 10 delay 60 check no -timestep 4e-6 -#processors 2 2 1 - -######################### SIMULATION BOUNDING BOX, INTEGRATION, AND, GRAVITY ########################### - -boundary f f f -read_data spheres200.data - -######################################### ADD DIE AND ATOM PARAMETERIZATION ############################################## - -variable atomRadius equal 0.44e-3*1.25 -variable atomDiameter equal 2*${atomRadius} -variable atomDensity equal 1560 -variable atomMassAvg equal ${atomDensity}*4.0/3.0*PI*${atomRadius}^3.0 -variable dieRadius equal 4e-3 -variable dieHeight equal 1e-2 - -########################### PARTICLE MATERIAL PROPERTIES AND FORCE MODEL ############################### - -pair_style granular -# mdr = E, nu, Y, gamma, psi_b, CoR -# linear_history = k_t, x_gamma,t, mu_s -variable YoungsModulus equal 5e6 -variable YieldStress equal 1.9e5 -variable PoissonsRatio equal 0.4 -variable SurfaceEnergy equal 2 -variable SurfaceEnergyWall equal 0.0 -variable CoR equal 0.5 -variable psi_b equal 0.5 -variable beta equal -ln(${CoR})/sqrt(ln(${CoR})^2+PI^2) -variable kt equal 2/7*${YoungsModulus}*${atomRadius} -variable kt_wall equal 2/7*${YoungsModulus}*${atomRadius} -variable xgammat equal 0.0 #${beta}*sqrt(${atomMassAvg}*${YoungsModulus}*${atomRadius}) -variable mu_s equal 0.7 -variable mu_s_wall equal 0.1 -variable mu_roll equal 0.6 -variable k_roll equal 2.25*${mu_roll}*${mu_roll}*${YoungsModulus}*${atomRadius} -variable gamma_roll equal 0.0 #${beta}*sqrt(${atomMassAvg}*${YoungsModulus}*${atomRadius}) - -pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} damping none tangential linear_history ${kt} ${xgammat} ${mu_s} rolling sds ${k_roll} ${gamma_roll} ${mu_roll} -#pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none -#pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_nohistory 0.0 0.0 damping none - -######################################### ADD DIE AND PUNCH WALLS ################################################ - -variable disp_upper equal 0.0 -variable disp_lower equal 0.0 -variable disp_xPlanePos equal 0.0 -variable disp_xPlaneNeg equal 0.0 - -variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} damping none tangential linear_history ${kt_wall} ${xgammat} ${mu_s_wall} rolling sds ${k_roll} ${gamma_roll} ${mu_roll}" -#variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none" -#variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} tangential linear_nohistory 0.0 0.0 damping none" - -variable dieHeight2 equal 2*${dieHeight} - -region lowerPunch plane 0 0 0 0 0 1 side in units box move NULL NULL v_disp_lower units box -region upperPunch plane 0 0 ${dieHeight} 0 0 -1 side in move NULL NULL v_disp_upper units box -region die cylinder z 0 0 ${dieRadius} 0 ${dieHeight2} side in units box -variable dieRadiusPlus equal ${dieRadius}*1.05 -variable dieRadiusPlusNeg equal -${dieRadiusPlus} -region xPlanePos plane ${dieRadiusPlus} 0 0 -1 0 0 side in units box move v_disp_xPlanePos NULL NULL units box -region xPlaneNeg plane ${dieRadiusPlusNeg} 0 0 1 0 0 side in units box move v_disp_xPlaneNeg NULL NULL units box - -fix lowerPunch all wall/gran/region ${wall_contact_string} region lowerPunch contacts -fix upperPunch all wall/gran/region ${wall_contact_string} region upperPunch contacts -fix die all wall/gran/region ${wall_contact_string} region die contacts -fix xPlanePos all wall/gran/region ${wall_contact_string} region xPlanePos contacts -fix xPlaneNeg all wall/gran/region ${wall_contact_string} region xPlaneNeg contacts - -compute avgPunchForce all reduce sum f_upperPunch[4] -variable avgPunchForce equal c_avgPunchForce -compute avgLowerPunchForce all reduce sum f_lowerPunch[4] -variable avgLowerPunchForce equal c_avgLowerPunchForce -compute fractureForce all reduce sum f_xPlanePos[2] -variable fractureForce equal c_fractureForce - -fix print1 all print 1 "${disp_upper} ${avgPunchForce} ${avgLowerPunchForce} ${fractureForce}" file upperPunchDispForce.csv screen no -fix printSTL all print 1 "${disp_upper} ${disp_lower}" file punch_disp_STL_generation.csv screen no - -##################################### INSERT PARTICLES #################################################### - -fix 1 all nve/sphere -fix grav all gravity 9.81 vector 0 0 -1 - -######################################## SCREEN OUTPUT #################################################### - -#variable ax atom fx/mass -#variable ay atom fy/mass -#variable az atom fz/mass -#variable aMag atom sqrt(v_ax*v_ax+v_ay*v_ay+v_az*v_az) -#variable force atom sqrt(fx^2+fy^2+fz^2) -#compute aMagAvg all reduce ave v_aMag -#variable forceToAccelRatio atom v_force/(mass*v_aMag) - -compute 1 all erotate/sphere -thermo_style custom dt step atoms ke vol v_disp_upper #c_aMagAvg -thermo 100 -thermo_modify lost ignore norm no - -##################################### SET UP DUMP OUTPUTS #################################################### - -compute ke all ke/atom -variable output_rate equal round(1e-3/dt) -#variable output_rate equal 10 - -#dumpĀ 1 all custom 1 uniaxialCompression id type f_plane_yz_neg[*] -#variable az_upperPunch atom f_upperPunch[7] -#variable afz_upperPunch atom f_upperPunch[4] -#fix log all print 1 "${delta} ${fx_neg}" file uniaxialCompression.csv title "del,fx_yz_neg" screen no - -run 0 - -compute sigmaxx all property/atom d_sigmaxx -compute sigmayy all property/atom d_sigmayy -compute sigmazz all property/atom d_sigmazz -compute Velas all property/atom d_Velas -compute adhesive_length all property/atom d_adhesive_length - -compute sigmaxx_ave all reduce ave c_sigmaxx -compute sigmayy_ave all reduce ave c_sigmayy -compute sigmazz_ave all reduce ave c_sigmazz -compute Velas_sum all reduce sum c_Velas -compute adhesive_length_ave all reduce ave c_adhesive_length - -variable sxx_ave equal c_sigmaxx_ave -variable syy_ave equal c_sigmayy_ave -variable szz_ave equal c_sigmazz_ave -variable Vparticles equal c_Velas_sum -variable adh_length_ave equal c_adhesive_length_ave - -fix log all print 1 "${sxx_ave} ${syy_ave} ${szz_ave} ${Vparticles} ${adh_length_ave}" file avgStresses.csv screen no -dump dumpParticles all custom ${output_rate} avicelTableting.dump id type mass diameter x y z vx vy vz fx fy fz c_ke c_sigmaxx c_sigmayy c_sigmazz #v_aMag v_force v_forceToAccelRatio -#dump dumpParticlesVTK all vtk ${output_rate} post/particles_*.vtk id x y z fx fy fz vx vy vz c_ke radius c_sigmaxx c_sigmayy c_sigmazz - -######################################### RUN SIMULATION ########################################## - -variable upper_punch_stroke equal 0.6733*${dieHeight} # 0.6733 -variable vel_upper equal 0.25 - -variable settling_steps equal round(0.02/dt) -variable compression_steps equal 2*round(${upper_punch_stroke}/${vel_upper}/dt) -variable ejection_steps equal ${compression_steps} -variable free_float_steps equal round(0.02/dt) -variable total_steps equal ${settling_steps}+${compression_steps}+${ejection_steps}+${free_float_steps} - -print "Total steps = ${total_steps}" - -##### SETTLING ##### - -run ${settling_steps} - -##### Compression & Release ##### - -variable punch_frequency equal PI/2/(dt*${compression_steps}/2) -variable disp_upper equal -${upper_punch_stroke}*sin(${punch_frequency}*elapsed*dt) -variable short_release equal round(${compression_steps}*1.0) -run ${short_release} # 189170 upto # - -##### EJECTION ##### - -variable punch_frequency equal PI/2/(dt*${ejection_steps}) -variable disp_lower equal ${dieHeight}*sin(${punch_frequency}*elapsed*dt) -variable disp_upper equal 0.9*v_disp_lower -run ${ejection_steps} - -##### FREE FLOAT ##### - -variable disp_lower equal ${dieHeight} -variable disp_upper equal ${dieHeight}*0.9 -variable max_disp equal ${dieRadius}*0.75 -#variable disp_xPlanePos equal -${max_disp}*elapsed/${free_float_steps} -#variable disp_xPlaneNeg equal -v_disp_xPlanePos -run ${free_float_steps} - diff --git a/examples/granular/in.tableting.200 b/examples/granular/in.tableting.200 new file mode 100644 index 0000000000..425cda3614 --- /dev/null +++ b/examples/granular/in.tableting.200 @@ -0,0 +1,153 @@ +##################################### SIMULATION SETTINGS ################################################### + +atom_style sphere 1 +atom_modify map array +comm_modify vel yes +units si +newton off +neighbor 1.0e-3 bin +neigh_modify every 10 delay 60 check no +timestep 4e-6 +#processors 2 2 1 + +############################## SIMULATION BOUNDING BOX AND INSERT PARTICLES ################################# + +boundary f f f +read_data spheres200.data + +#################################### ADD DIE AND ATOM PARAMETERIZATION ###################################### + +variable atomRadius equal 0.44e-3*1.25 +variable atomDiameter equal 2*${atomRadius} +variable atomDensity equal 1560 +variable atomMassAvg equal ${atomDensity}*4.0/3.0*PI*${atomRadius}^3.0 +variable dieRadius equal 4e-3 +variable dieHeight equal 1e-2 + +############################## PARTICLE MATERIAL PROPERTIES AND FORCE MODEL ################################## + +pair_style granular + +# mdr = E, nu, Y, gamma, psi_b, CoR +variable YoungsModulus equal 5e6 +variable YieldStress equal 1.9e5 +variable PoissonsRatio equal 0.4 +variable SurfaceEnergy equal 2 +variable SurfaceEnergyWall equal 0.0 +variable CoR equal 0.5 +variable psi_b equal 0.5 + +# linear_history = k_t, x_gammat, mu_s +variable kt equal 2/7*${YoungsModulus}*${atomRadius} +variable kt_wall equal 2/7*${YoungsModulus}*${atomRadius} +variable xgammat equal 0.0 +variable mu_s equal 0.7 +variable mu_s_wall equal 0.1 + +# sds = mu_roll, k_roll, gamma_roll +variable mu_roll equal 0.6 +variable k_roll equal 2.25*${mu_roll}*${mu_roll}*${YoungsModulus}*${atomRadius} +variable gamma_roll equal 0.0 + +pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} rolling sds ${k_roll} ${gamma_roll} ${mu_roll} damping none + +######################################### ADD DIE AND PUNCH WALLS ############################################ + +variable disp_upper equal 0.0 +variable disp_lower equal 0.0 +variable disp_xPlanePos equal 0.0 +variable disp_xPlaneNeg equal 0.0 + +variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} tangential linear_history ${kt_wall} ${xgammat} ${mu_s_wall} rolling sds ${k_roll} ${gamma_roll} ${mu_roll} damping none" + +variable dieHeight2 equal 2*${dieHeight} + +region lowerPunch plane 0 0 0 0 0 1 side in units box move NULL NULL v_disp_lower units box +region upperPunch plane 0 0 ${dieHeight} 0 0 -1 side in move NULL NULL v_disp_upper units box +region die cylinder z 0 0 ${dieRadius} 0 ${dieHeight2} side in units box +variable dieRadiusPlus equal ${dieRadius}*1.05 +variable dieRadiusPlusNeg equal -${dieRadiusPlus} + +fix lowerPunch all wall/gran/region ${wall_contact_string} region lowerPunch contacts +fix upperPunch all wall/gran/region ${wall_contact_string} region upperPunch contacts +fix die all wall/gran/region ${wall_contact_string} region die contacts + +compute avgUpperPunchForce all reduce sum f_upperPunch[4] +variable avgUpperPunchForce equal c_avgUpperPunchForce +compute avgLowerPunchForce all reduce sum f_lowerPunch[4] +variable avgLowerPunchForce equal c_avgLowerPunchForce + +fix printFD all print 1 "${disp_upper} ${avgUpperPunchForce} ${avgLowerPunchForce}" file punch_force_disp_tableting200.csv screen no + +##################################### INTEGRATION AND GRAVITY ################################################# + +fix 1 all nve/sphere +fix grav all gravity 9.81 vector 0 0 -1 + +########################################### SCREEN OUTPUT #################################################### + +compute 1 all erotate/sphere +thermo_style custom dt step atoms ke vol v_disp_upper +thermo 100 +thermo_modify lost ignore norm no + +##################################### SET UP DUMP OUTPUTS #################################################### + +compute ke all ke/atom +variable output_rate equal round(1e-3/dt) + +run 0 + +compute sigmaxx all property/atom d_sigmaxx +compute sigmayy all property/atom d_sigmayy +compute sigmazz all property/atom d_sigmazz +compute Velas all property/atom d_Velas + +compute sigmaxx_ave all reduce ave c_sigmaxx +compute sigmayy_ave all reduce ave c_sigmayy +compute sigmazz_ave all reduce ave c_sigmazz +compute Velas_sum all reduce sum c_Velas + +variable sxx_ave equal c_sigmaxx_ave +variable syy_ave equal c_sigmayy_ave +variable szz_ave equal c_sigmazz_ave +variable Vparticles equal c_Velas_sum + +fix log all print 1 "${sxx_ave} ${syy_ave} ${szz_ave} ${Vparticles}" file average_normal_stresses_tableting200.csv screen no +dump dumpParticles all custom ${output_rate} tableting200.dump id type mass diameter x y z vx vy vz fx fy fz c_ke c_sigmaxx c_sigmayy c_sigmazz +#dump dumpParticlesVTK all vtk ${output_rate} post/particles_*.vtk id x y z fx fy fz vx vy vz c_ke radius c_sigmaxx c_sigmayy c_sigmazz + +############################################## RUN SIMULATION ################################################# + +variable upper_punch_stroke equal 0.6733*${dieHeight} +variable vel_upper equal 0.25 + +variable settling_steps equal round(0.02/dt) +variable compression_steps equal 2*round(${upper_punch_stroke}/${vel_upper}/dt) +variable ejection_steps equal ${compression_steps} +variable free_float_steps equal round(0.02/dt) + +##### SETTLING ##### + +run ${settling_steps} + +##### Compression & Release ##### + +variable punch_frequency equal PI/2/(dt*${compression_steps}/2) +variable disp_upper equal -${upper_punch_stroke}*sin(${punch_frequency}*elapsed*dt) +variable short_release equal round(${compression_steps}*1.0) +run ${short_release} + +##### EJECTION ##### + +variable punch_frequency equal PI/2/(dt*${ejection_steps}) +variable disp_lower equal ${dieHeight}*sin(${punch_frequency}*elapsed*dt) +variable disp_upper equal 0.9*v_disp_lower +run ${ejection_steps} + +##### FREE FLOAT ##### + +variable disp_lower equal ${dieHeight} +variable disp_upper equal ${dieHeight}*0.9 +variable max_disp equal ${dieRadius}*0.75 +run ${free_float_steps} \ No newline at end of file diff --git a/examples/granular/in.mpfem.triaxial12particles b/examples/granular/in.triaxial.compaction.12 similarity index 79% rename from examples/granular/in.mpfem.triaxial12particles rename to examples/granular/in.triaxial.compaction.12 index 98b5621c1f..df18bdeb1f 100644 --- a/examples/granular/in.mpfem.triaxial12particles +++ b/examples/granular/in.triaxial.compaction.12 @@ -9,28 +9,30 @@ neighbor 2 bin neigh_modify delay 0 timestep 1e-6 -######################### SIMULATION BOUNDING BOX, INTEGRATION, AND, GRAVITY ########################### +##################### SIMULATION BOUNDING BOX, INSERT PARTICLES, AND INTEGRATION ####################### -boundary f f f +boundary f f f read_data spheres12.data -fix integr all nve/sphere +fix integr all nve/sphere ########################### PARTICLE MATERIAL PROPERTIES AND FORCE MODEL ############################### variable atomRadius equal 0.5 pair_style granular -# mdr = E, nu, Y, gamma, psi_b, CoR -# linear_history = k_t, x_gamma,t, mu_s -variable YoungsModulus equal 1e9 -variable PoissonsRatio equal 0.3 -variable YieldStress equal 50e6 -variable SurfaceEnergy equal 0.0 -variable psi_b equal 0.5 -variable CoR equal 0.5 -variable kt equal 2/7*${YoungsModulus}*${atomRadius} -variable xgammat equal 0.0 -variable mu_s equal 0.5 + +# mdr = E, nu, Y, gamma, psi_b, CoR +variable YoungsModulus equal 1e9 +variable PoissonsRatio equal 0.3 +variable YieldStress equal 50e6 +variable SurfaceEnergy equal 0.0 +variable psi_b equal 0.5 +variable CoR equal 0.5 + +# linear_history = k_t, x_gamma,t, mu_s +variable kt equal 2/7*${YoungsModulus}*${atomRadius} +variable xgammat equal 0.0 +variable mu_s equal 0.5 pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergy} ${psi_b} ${CoR} tangential linear_history ${kt} ${xgammat} ${mu_s} damping none @@ -67,7 +69,7 @@ variable plane_xz_neg_force equal c_plane_xz_neg_force compute plane_yz_neg_force all reduce sum f_plane_yz_neg[2] variable plane_yz_neg_force equal c_plane_yz_neg_force -fix print1 all print 1 "${plane_disp} ${plane_xy_neg_force} ${plane_xz_neg_force} ${plane_yz_neg_force}" file lammps_macro_force_disp_diff_radii.csv screen no +fix print1 all print 1 "${plane_disp} ${plane_xy_neg_force} ${plane_xz_neg_force} ${plane_yz_neg_force}" file force_disp_triaxial12.csv screen no ######################################## SCREEN OUTPUT #################################################### @@ -84,9 +86,9 @@ variable compression_steps equal round(${disp_max}/${ddisp}) variable output_rate equal round(${compression_steps}/100) ##################################### SET UP DUMP OUTPUTS #################################################### - -#dump dmp all vtk ${output_rate} post/triaxial12particles_*.vtk id type mass x y z vx vy vz fx fy fz radius -dump dumpParticles all custom ${output_rate} triaxial12particles.dump id type mass x y z vx vy vz fx fy fz radius + +dump dumpParticles all custom ${output_rate} triaxial_compaction_12.dump id type mass x y z vx vy vz fx fy fz radius +#dump dmp all vtk ${output_rate} post/triaxial12particles_*.vtk id type mass x y z vx vy vz fx fy fz radius #################################### COMPRESS THE PARTICLES ################################################## @@ -95,6 +97,4 @@ run 0 variable plane_disp equal ${ddisp}*elapsed variable plane_disp_neg equal -${ddisp}*elapsed -run ${compression_steps} - -#################################### UNCOMPRESS THE PARTICLES ################################################ +run ${compression_steps} \ No newline at end of file From 53084018aea036d9b074b0128383dc1d906d834c Mon Sep 17 00:00:00 2001 From: William Zunker Date: Mon, 6 Jan 2025 15:35:34 -0500 Subject: [PATCH 37/74] Removed uncessary property/atom's: contacts and adhesive_length --- src/GRANULAR/fix_granular_mdr.cpp | 18 +++--------------- src/GRANULAR/gran_sub_mod_normal.cpp | 7 ------- 2 files changed, 3 insertions(+), 22 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index d34d1e6698..2d51497874 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -54,7 +54,7 @@ enum {COMM_RADIUS_UPDATE, COMM_DDELTA_BAR}; FixGranularMDR::FixGranularMDR(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) { - comm_forward = 20; + comm_forward = 18; create_attribute = 1; id_fix = nullptr; @@ -84,7 +84,7 @@ void FixGranularMDR::post_constructor() { int tmp1, tmp2; id_fix = utils::strdup("MDR_PARTICLE_HISTORY_VARIABLES"); - modify->add_fix(fmt::format("{} all property/atom d_Ro d_Vcaps d_Vgeo d_Velas d_eps_bar d_dRnumerator d_dRdenominator d_Acon0 d_Acon1 d_Atot d_Atot_sum d_ddelta_bar d_psi d_psi_b d_history_setup_flag d_sigmaxx d_sigmayy d_sigmazz d_contacts d_adhesive_length ghost yes", id_fix)); + modify->add_fix(fmt::format("{} all property/atom d_Ro d_Vcaps d_Vgeo d_Velas d_eps_bar d_dRnumerator d_dRdenominator d_Acon0 d_Acon1 d_Atot d_Atot_sum d_ddelta_bar d_psi d_psi_b d_history_setup_flag d_sigmaxx d_sigmayy d_sigmazz ghost yes", id_fix)); index_Ro = atom->find_custom("Ro", tmp1, tmp2); index_Vcaps = atom->find_custom("Vcaps", tmp1, tmp2); @@ -104,8 +104,6 @@ void FixGranularMDR::post_constructor() index_sigmaxx = atom->find_custom("sigmaxx", tmp1, tmp2); index_sigmayy = atom->find_custom("sigmayy", tmp1, tmp2); index_sigmazz = atom->find_custom("sigmazz", tmp1, tmp2); - index_contacts = atom->find_custom("contacts", tmp1, tmp2); - index_adhesive_length = atom->find_custom("adhesive_length", tmp1, tmp2); } /* ---------------------------------------------------------------------- */ @@ -185,7 +183,7 @@ void FixGranularMDR::pre_force(int) radius_update(); comm_stage = COMM_RADIUS_UPDATE; - comm->forward_comm(this, 20); + comm->forward_comm(this, 18); calculate_contact_penalty(); mean_surf_disp(); @@ -222,8 +220,6 @@ int FixGranularMDR::pack_forward_comm(int n, int *list, double *buf, int /*pbc_f buf[m++] = dvector[index_sigmayy][j]; // 16 buf[m++] = dvector[index_sigmazz][j]; // 17 buf[m++] = dvector[index_history_setup_flag][j]; // 18 - buf[m++] = dvector[index_contacts][j]; // 19 - buf[m++] = dvector[index_adhesive_length][j]; // 20 } } else { for (int i = 0; i < n; i++) { @@ -262,8 +258,6 @@ void FixGranularMDR::unpack_forward_comm(int n, int first, double *buf) dvector[index_sigmayy][i] = buf[m++]; // 16 dvector[index_sigmazz][i] = buf[m++]; // 17 dvector[index_history_setup_flag][i] = buf[m++]; // 18 - dvector[index_contacts][i] = buf[m++]; // 19 - dvector[index_adhesive_length][i] = buf[m++]; // 20 } } else { for (int i = first; i < last; i++) { @@ -358,8 +352,6 @@ void FixGranularMDR::set_arrays(int i) // atom->dvector[index_sigmayy][i] = 0.0; // atom->dvector[index_sigmazz][i] = 0.0; atom->dvector[index_history_setup_flag][i] = 0.0; - // atom->dvector[index_contacts][i] = 0.0; - // atom->dvector[index_adhesive_length][i] = 0.0; } /* ---------------------------------------------------------------------- @@ -380,8 +372,6 @@ void FixGranularMDR::radius_update() double *sigmaxx = atom->dvector[index_sigmaxx]; double *sigmayy = atom->dvector[index_sigmayy]; double *sigmazz = atom->dvector[index_sigmazz]; - double *contacts = atom->dvector[index_contacts]; - double *adhesive_length = atom->dvector[index_adhesive_length]; double *history_setup_flag = atom->dvector[index_history_setup_flag]; for (int i = 0; i < nlocal; i++) { @@ -397,8 +387,6 @@ void FixGranularMDR::radius_update() sigmaxx[i] = 0.0; sigmayy[i] = 0.0; sigmazz[i] = 0.0; - contacts[i] = 0.0; - adhesive_length[i] = 0.0; } } diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 1c3df456f9..208e07cd6e 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -491,8 +491,6 @@ void GranSubModNormalMDR::init() index_sigmaxx = atom->find_custom("sigmaxx", tmp1, tmp2); // xx-component of the stress tensor, not necessary for force calculation index_sigmayy = atom->find_custom("sigmayy", tmp1, tmp2); // yy-component of the stress tensor, not necessary for force calculation index_sigmazz = atom->find_custom("sigmazz", tmp1, tmp2); // zz-component of the stress tensor, not necessary for force calculation - index_contacts = atom->find_custom("contacts", tmp1, tmp2); // total contacts on particle - index_adhesive_length = atom->find_custom("adhesive_length", tmp1, tmp2); // total contacts on particle } /* ---------------------------------------------------------------------- */ @@ -532,8 +530,6 @@ double GranSubModNormalMDR::calculate_forces() double *sigmaxx = atom->dvector[index_sigmaxx]; double *sigmayy = atom->dvector[index_sigmayy]; double *sigmazz = atom->dvector[index_sigmazz]; - double *contacts = atom->dvector[index_contacts]; - double *adhesive_length = atom->dvector[index_adhesive_length]; const int itag_true = atom->tag[gm->i]; // true i particle tag const int jtag_true = atom->tag[gm->j]; // true j particle tag @@ -812,9 +808,6 @@ double GranSubModNormalMDR::calculate_forces() } } - contacts[i] += 1; - adhesive_length[i] += aAdh; - // contact penalty scheme penalty_offset = & history[PENALTY]; double pij = *penalty_offset; From 09735b29e7d1d7394c8d7c2908f806a866605480 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Mon, 6 Jan 2025 13:58:49 -0700 Subject: [PATCH 38/74] Adding setup check to MDR submodel --- src/GRANULAR/gran_sub_mod_normal.cpp | 25 +++++++++++++++---------- 1 file changed, 15 insertions(+), 10 deletions(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 208e07cd6e..ade48c7e1b 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -545,7 +545,8 @@ double GranSubModNormalMDR::calculate_forces() double R1 = 0.0; double delta = gm->delta; // apparent overlap - double * history = & gm->history[history_index]; // load in all history variables + double *history = & gm->history[history_index]; // load in all history variables + int update = gm->history_update; // Rigid flat placement scheme double * deltamax_offset = & history[DELTA_MAX]; @@ -816,9 +817,11 @@ double GranSubModNormalMDR::calculate_forces() // area related calculations double Ac; (*Yflag_offset == 0.0) ? Ac = MY_PI * delta * R : Ac = MY_PI * ((2.0 * delta * R - pow(delta, 2)) + cA / MY_PI); - if (Ac < 0.0 ) Ac = 0.0; - Atot_sum[i] += wij * (Ac - 2.0 * MY_PI * R * (deltamax_MDR + delta_BULK)); - Acon1[i] += wij * Ac; + if (Ac < 0.0) Ac = 0.0; + if (update) { + Atot_sum[i] += wij * (Ac - 2.0 * MY_PI * R * (deltamax_MDR + delta_BULK)); + Acon1[i] += wij * Ac; + } // bulk force calculation double F_BULK; @@ -831,7 +834,7 @@ double GranSubModNormalMDR::calculate_forces() *Ac_offset = wij * Ac; // radius update scheme quantity calculation - Vcaps[i] += (MY_PI * THIRD) * pow(delta, 2) * (3.0 * R - delta); + if (update) Vcaps[i] += (MY_PI * THIRD) * pow(delta, 2) * (3.0 * R - delta); const double Fntmp = wij * (F_MDR + F_BULK); const double fx = Fntmp * gm->nx[0]; @@ -841,19 +844,21 @@ double GranSubModNormalMDR::calculate_forces() const double by = -(Ro - deltao) * gm->nx[1]; const double bz = -(Ro - deltao) * gm->nx[2]; const double eps_bar_contact = (1.0 / (3 * kappa * Velas[i])) * (fx * bx + fy * by + fz * bz); - eps_bar[i] += eps_bar_contact; + if (update) eps_bar[i] += eps_bar_contact; double desp_bar_contact = eps_bar_contact - *eps_bar_offset; - if(delta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0){ + if (update && elta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0){ const double Vo = (4.0 * THIRD) * MY_PI * pow(Ro, 3); dRnumerator[i] += -Vo * (eps_bar_contact - *eps_bar_offset) - wij * MY_PI * ddeltao * (2.0 * deltao * Ro - pow(deltao, 2) + pow(R, 2) - pow(Ro, 2)); dRdenominator[i] += wij * 2.0 * MY_PI * R * (deltao + R - Ro); } *eps_bar_offset = eps_bar_contact; - sigmaxx[i] += (1.0 / Velas[i]) * (fx * bx); - sigmayy[i] += (1.0 / Velas[i]) * (fy * by); - sigmazz[i] += (1.0 / Velas[i]) * (fz * bz); + if (update) { + sigmaxx[i] += (1.0 / Velas[i]) * (fx * bx); + sigmayy[i] += (1.0 / Velas[i]) * (fy * by); + sigmazz[i] += (1.0 / Velas[i]) * (fz * bz); + } } gm->i = i_true; From 16f6fe315cd335cd20d390d720c0c878c8033571 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Mon, 6 Jan 2025 14:06:57 -0700 Subject: [PATCH 39/74] Restoring deleted character --- src/GRANULAR/gran_sub_mod_normal.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index ade48c7e1b..8248023395 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -847,7 +847,7 @@ double GranSubModNormalMDR::calculate_forces() if (update) eps_bar[i] += eps_bar_contact; double desp_bar_contact = eps_bar_contact - *eps_bar_offset; - if (update && elta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0){ + if (update && delta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0){ const double Vo = (4.0 * THIRD) * MY_PI * pow(Ro, 3); dRnumerator[i] += -Vo * (eps_bar_contact - *eps_bar_offset) - wij * MY_PI * ddeltao * (2.0 * deltao * Ro - pow(deltao, 2) + pow(R, 2) - pow(Ro, 2)); dRdenominator[i] += wij * 2.0 * MY_PI * R * (deltao + R - Ro); From 14be59d3ccc89d4f86b3b0ff1c55f565fd0907ee Mon Sep 17 00:00:00 2001 From: William Zunker Date: Mon, 6 Jan 2025 19:48:16 -0500 Subject: [PATCH 40/74] Minor spelling errors and input modification --- doc/src/pair_granular.rst | 4 ++-- examples/granular/in.triaxial.compaction.12 | 2 +- 2 files changed, 3 insertions(+), 3 deletions(-) diff --git a/doc/src/pair_granular.rst b/doc/src/pair_granular.rst index 6eac8dd2d1..c5efe2f5f4 100644 --- a/doc/src/pair_granular.rst +++ b/doc/src/pair_granular.rst @@ -168,7 +168,7 @@ lose contact. The *mdr* model is a mechanically-derived contact model designed to capture the contact response between adhesive elastic-plastic particles into large deformation. -The theoritical foundations of the *mdr* model are detailed in the +The theoretical foundations of the *mdr* model are detailed in the two-part series :ref:`Zunker and Kamrin Part I ` and :ref:`Zunker and Kamrin Part II `. Further development and demonstrations of its application to industrially relevant powder @@ -191,7 +191,7 @@ The model requires the following inputs: relation to the more commonly reported critical stress intensity factor :math:`K_{Ic} = \sqrt{2\Delta\gamma E/(1-\nu^2)}`. - 5. *Critical confinement ratio* :math:`0 \le \psi_b \le 1` : The critcal confinment + 5. *Critical confinement ratio* :math:`0 \le \psi_b \le 1` : The critical confinment ratio is a tunable parameter that determines when the bulk elastic response is triggered. Lower values of :math:`\psi_b` delay the onset of the bulk elastic response. diff --git a/examples/granular/in.triaxial.compaction.12 b/examples/granular/in.triaxial.compaction.12 index df18bdeb1f..c56fe521d0 100644 --- a/examples/granular/in.triaxial.compaction.12 +++ b/examples/granular/in.triaxial.compaction.12 @@ -1,6 +1,6 @@ ############################### SIMULATION SETTINGS ################################################### -atom_style sphere +atom_style sphere 1 atom_modify map array comm_modify vel yes units si From c528573b622d45d7eebff4b3a6c6bc070d4f15b5 Mon Sep 17 00:00:00 2001 From: William Zunker Date: Mon, 6 Jan 2025 22:29:58 -0500 Subject: [PATCH 41/74] Simplified delta partition logic and commented update check --- src/GRANULAR/gran_sub_mod_normal.cpp | 97 +++++++++------------------- 1 file changed, 32 insertions(+), 65 deletions(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 8248023395..98fc9e3ebc 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -541,12 +541,10 @@ double GranSubModNormalMDR::calculate_forces() F = 0.0; // average force double F0 = 0.0; // force on contact side 0 double F1 = 0.0; // force on contact side 1 - double R0 = 0.0; - double R1 = 0.0; double delta = gm->delta; // apparent overlap double *history = & gm->history[history_index]; // load in all history variables - int update = gm->history_update; + //int update = gm->history_update; // Rigid flat placement scheme double * deltamax_offset = & history[DELTA_MAX]; @@ -565,81 +563,45 @@ double GranSubModNormalMDR::calculate_forces() double *deltamax_MDR_offset, *Yflag_offset, *deltaY_offset, *cA_offset, *aAdh_offset; double *Ac_offset, *eps_bar_offset, *penalty_offset, *deltap_offset; - if (contactSide == 0) { - if (gm->contact_type == PAIR) { - if (itag_true > jtag_true) { + if (gm->contact_type == PAIR) { // displacement partitioning only necessary for particle-particle contact + + // itag and jtag are persistent even after neighbor list builds, comparison based on tags helps match + // contact history variables consistently across steps for particle pair. + if ((contactSide == 0 && itag_true > jtag_true) || (contactSide != 0 && itag_true < jtag_true)) { gm->i = i_true; gm->j = j_true; gm->radi = radi_true; gm->radj = radj_true; - } else { + } else { gm->i = j_true; gm->j = i_true; gm->radi = radj_true; gm->radj = radi_true; - } - R0 = gm->radi; - R1 = gm->radj; - - double delta_geo, delta_geo_alt; - double delta_geoOpt1 = deltamax * (deltamax - 2.0 * R1) / (2.0 * (deltamax - R0 - R1)); - double delta_geoOpt2 = deltamax * (deltamax - 2.0 * R0) / (2.0 * (deltamax - R0 - R1)); - (R0 < R1) ? delta_geo = MAX(delta_geoOpt1, delta_geoOpt2) : delta_geo = MIN(delta_geoOpt1, delta_geoOpt2); - (R0 > R1) ? delta_geo_alt = MAX(delta_geoOpt1, delta_geoOpt2) : delta_geo_alt = MIN(delta_geoOpt1, delta_geoOpt2); - - if (delta_geo / R0 > MDR_OVERLAP_LIMIT) { - delta_geo = R0 * MDR_OVERLAP_LIMIT; - } else if (delta_geo_alt / R1 > MDR_OVERLAP_LIMIT) { - delta_geo = deltamax - R1 * MDR_OVERLAP_LIMIT; - } - - double deltap = deltap0 + deltap1; - delta = delta_geo + (deltap0 - delta_geo) / (deltap - deltamax) * (gm->delta - deltamax); - } - } else { - if (gm->contact_type != PAIR) break; // contact with particle-wall requires only one evaluation - if (itag_true < jtag_true) { - gm->i = i_true; - gm->j = j_true; - gm->radi = radi_true; - gm->radj = radj_true; - } else { - gm->i = j_true; - gm->j = i_true; - gm->radi = radj_true; - gm->radj = radi_true; } - // QUESTION: R0/R1 here are never defined so they default to zero - // did you mean to define: - // R0 = gm->radi; - // R1 = gm->radj; - // here to mirror above? After confirming, these two conditions can be easily collapsed to remove duplication and clarify differences (also replace gm->radi/radj with R0/R1) - // ANSWER: If I am not mistaken R0 & R1 will always be set to non-zero values from the case above where contactSide = 0: - // R0 = gm->radi; - // R1 = gm->radj; - // Then their values will carry over into this else statement for the case of contactSide = 1. I don't want their values to change after they are set above, - // hence why I didn't redine them. - // - // However, this is written in a bit of a strange way now that I am reviewing it, I will give it some more thought. - // ANSWER2: What if the contact type is WALL, then the iteration over contactSide = 0 will skip - // defining R0 and R1? Is that correct? - // ANSWER3: Correct, but in that case they are not needed since there is no partitioning of the displacement. - + // determine the two maximum experienced geometric overlaps on either side of rigid flat double delta_geo, delta_geo_alt; - double delta_geoOpt1 = deltamax * (deltamax - 2.0 * R1) / (2.0 * (deltamax - R0 - R1)); - double delta_geoOpt2 = deltamax * (deltamax - 2.0 * R0) / (2.0 * (deltamax - R0 - R1)); + double delta_geoOpt1 = deltamax * (deltamax - 2.0 * gm->radj) / (2.0 * (deltamax - gm->radi - gm->radj)); + double delta_geoOpt2 = deltamax * (deltamax - 2.0 * gm->radi) / (2.0 * (deltamax - gm->radi - gm->radj)); (gm->radi < gm->radj) ? delta_geo = MAX(delta_geoOpt1,delta_geoOpt2) : delta_geo = MIN(delta_geoOpt1, delta_geoOpt2); (gm->radi > gm->radj) ? delta_geo_alt = MAX(delta_geoOpt1,delta_geoOpt2) : delta_geo_alt = MIN(delta_geoOpt1,delta_geoOpt2); + // cap displacement if it exceeds the overlap limit and parition the remaining to the other side if (delta_geo / gm->radi > MDR_OVERLAP_LIMIT) { delta_geo = gm->radi * MDR_OVERLAP_LIMIT; } else if (delta_geo_alt / gm->radj > MDR_OVERLAP_LIMIT) { delta_geo = deltamax - gm->radj * MDR_OVERLAP_LIMIT; } + // determine final delta used for subsequent calculations double deltap = deltap0 + deltap1; - delta = delta_geo + (deltap1 - delta_geo) / (deltap - deltamax) * (gm->delta - deltamax); + if (contactSide == 0) { + delta = delta_geo + (deltap0 - delta_geo) / (deltap - deltamax) * (gm->delta - deltamax); + } else { + delta = delta_geo + (deltap1 - delta_geo) / (deltap - deltamax) * (gm->delta - deltamax); + } + } else if (gm->contact_type != PAIR && contactSide != 0) { // contact with particle-wall requires only one evaluation + break; } delta_offset = & history[DELTA_0 + contactSide]; @@ -680,7 +642,7 @@ double GranSubModNormalMDR::calculate_forces() ddelta_MDR = ddelta; } const double delta_MDR = *delta_MDR_offset + ddelta_MDR; // MDR displacement - *delta_MDR_offset = delta_MDR; // Update old MDR displacement + *delta_MDR_offset = delta_MDR; // update old MDR displacement const double delta_BULK = MAX(0.0, *delta_BULK_offset + ddelta_BULK); // bulk displacement *delta_BULK_offset = delta_BULK; // update old bulk displacement @@ -818,10 +780,10 @@ double GranSubModNormalMDR::calculate_forces() double Ac; (*Yflag_offset == 0.0) ? Ac = MY_PI * delta * R : Ac = MY_PI * ((2.0 * delta * R - pow(delta, 2)) + cA / MY_PI); if (Ac < 0.0) Ac = 0.0; - if (update) { + //if (update) { Atot_sum[i] += wij * (Ac - 2.0 * MY_PI * R * (deltamax_MDR + delta_BULK)); Acon1[i] += wij * Ac; - } + //} // bulk force calculation double F_BULK; @@ -834,7 +796,9 @@ double GranSubModNormalMDR::calculate_forces() *Ac_offset = wij * Ac; // radius update scheme quantity calculation - if (update) Vcaps[i] += (MY_PI * THIRD) * pow(delta, 2) * (3.0 * R - delta); + //if (update) { + Vcaps[i] += (MY_PI * THIRD) * pow(delta, 2) * (3.0 * R - delta); + //} const double Fntmp = wij * (F_MDR + F_BULK); const double fx = Fntmp * gm->nx[0]; @@ -844,21 +808,24 @@ double GranSubModNormalMDR::calculate_forces() const double by = -(Ro - deltao) * gm->nx[1]; const double bz = -(Ro - deltao) * gm->nx[2]; const double eps_bar_contact = (1.0 / (3 * kappa * Velas[i])) * (fx * bx + fy * by + fz * bz); - if (update) eps_bar[i] += eps_bar_contact; + //if (update) { + eps_bar[i] += eps_bar_contact; + //} double desp_bar_contact = eps_bar_contact - *eps_bar_offset; - if (update && delta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0){ + //if (update && delta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0){ + if (delta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0){ const double Vo = (4.0 * THIRD) * MY_PI * pow(Ro, 3); dRnumerator[i] += -Vo * (eps_bar_contact - *eps_bar_offset) - wij * MY_PI * ddeltao * (2.0 * deltao * Ro - pow(deltao, 2) + pow(R, 2) - pow(Ro, 2)); dRdenominator[i] += wij * 2.0 * MY_PI * R * (deltao + R - Ro); } *eps_bar_offset = eps_bar_contact; - if (update) { + //if (update) { sigmaxx[i] += (1.0 / Velas[i]) * (fx * bx); sigmayy[i] += (1.0 / Velas[i]) * (fy * by); sigmazz[i] += (1.0 / Velas[i]) * (fz * bz); - } + //} } gm->i = i_true; From b10a5427a1ec8a34eac8330f417edc3e07314ba7 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Mon, 6 Jan 2025 15:55:49 -0700 Subject: [PATCH 42/74] Simplifying variable initialization/resetting --- src/GRANULAR/fix_granular_mdr.cpp | 149 +++++++++++---------------- src/GRANULAR/fix_granular_mdr.h | 2 +- src/GRANULAR/gran_sub_mod_normal.cpp | 19 ++-- 3 files changed, 68 insertions(+), 102 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index 2d51497874..e418a88a80 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -47,14 +47,14 @@ using MathConst::MY_PI; static constexpr double EPSILON = 1e-16; static constexpr double OVERLAP_LIMIT = 0.75; -enum {COMM_RADIUS_UPDATE, COMM_DDELTA_BAR}; +enum {COMM_1, COMM_2}; /* ---------------------------------------------------------------------- */ FixGranularMDR::FixGranularMDR(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) { - comm_forward = 18; + comm_forward = 6; create_attribute = 1; id_fix = nullptr; @@ -74,7 +74,8 @@ FixGranularMDR::~FixGranularMDR() int FixGranularMDR::setmask() { int mask = 0; - mask |= PRE_FORCE | END_OF_STEP; + mask |= PRE_FORCE; + mask |= END_OF_STEP; return mask; } @@ -158,7 +159,7 @@ void FixGranularMDR::setup_pre_force(int /*vflag*/) norm_model->Y, norm_model2->Y); if (norm_model->psi_b != norm_model2->psi_b) error->all(FLERR, "Bulk response trigger in pair style, {}, does not agree with value {} in fix gran/wall/region", - norm_model->psi_b, norm_model2->psi_b); + norm_model->psi_b, norm_model2->psi_b); if (norm_model->CoR != norm_model2->CoR) error->all(FLERR, "Coefficient of restitution in pair style, {}, does not agree with value {} in fix gran/wall/region", norm_model->CoR, norm_model2->CoR); @@ -174,22 +175,51 @@ void FixGranularMDR::setup_pre_force(int /*vflag*/) void FixGranularMDR::setup(int /*vflag*/) { end_of_step(); + reset_properties(); } /* ---------------------------------------------------------------------- */ void FixGranularMDR::pre_force(int) { - radius_update(); + // Initialize variables for any new atoms - comm_stage = COMM_RADIUS_UPDATE; - comm->forward_comm(this, 18); + double *radius = atom->radius; + int nlocal = atom->nlocal; + + double *Ro = atom->dvector[index_Ro]; + double *Vgeo = atom->dvector[index_Vgeo]; + double *Velas = atom->dvector[index_Velas]; + double *Acon1 = atom->dvector[index_Acon1]; + double *Atot = atom->dvector[index_Atot]; + double *psi = atom->dvector[index_psi]; + double *psi_b = atom->dvector[index_psi_b]; + double *history_setup_flag = atom->dvector[index_history_setup_flag]; + + int ntotal = atom->nlocal + atom->nghost; + for (int i = 0; i < ntotal; i++) { + if (history_setup_flag[i] < EPSILON) { + Ro[i] = radius[i]; + Vgeo[i] = 4.0 / 3.0 * MY_PI * pow(Ro[i], 3.0); + Velas[i] = 4.0 / 3.0 * MY_PI * pow(Ro[i], 3.0); + Atot[i] = 4.0 * MY_PI * pow(Ro[i], 2.0); + psi[i] = 1.0; + psi_b[i] = psi_b_coeff; + Acon1[i] = 0.0; + history_setup_flag[i] = 1.0; + } + } + + reset_properties(); + + comm_stage = COMM_1; + comm->forward_comm(this, 6); calculate_contact_penalty(); mean_surf_disp(); update_fix_gran_wall(); - comm_stage = COMM_DDELTA_BAR; + comm_stage = COMM_2; comm->forward_comm(this, 1); } @@ -199,27 +229,15 @@ int FixGranularMDR::pack_forward_comm(int n, int *list, double *buf, int /*pbc_f { double **dvector = atom->dvector; int m = 0; - if (comm_stage == COMM_RADIUS_UPDATE) { + if (comm_stage == COMM_1) { for (int i = 0; i < n; i++) { int j = list[i]; - buf[m++] = dvector[index_Ro][j]; // 1 buf[m++] = dvector[index_Vgeo][j]; // 2 buf[m++] = dvector[index_Velas][j]; // 3 - buf[m++] = dvector[index_Vcaps][j]; // 4 - buf[m++] = dvector[index_eps_bar][j]; // 5 - buf[m++] = dvector[index_dRnumerator][j]; // 6 - buf[m++] = dvector[index_dRdenominator][j]; // 7 buf[m++] = dvector[index_Acon0][j]; // 8 - buf[m++] = dvector[index_Acon1][j]; // 9 buf[m++] = dvector[index_Atot][j]; // 10 - buf[m++] = dvector[index_Atot_sum][j]; // 11 - buf[m++] = dvector[index_ddelta_bar][j]; // 12 buf[m++] = dvector[index_psi][j]; // 13 buf[m++] = dvector[index_psi_b][j]; // 14 - buf[m++] = dvector[index_sigmaxx][j]; // 15 - buf[m++] = dvector[index_sigmayy][j]; // 16 - buf[m++] = dvector[index_sigmazz][j]; // 17 - buf[m++] = dvector[index_history_setup_flag][j]; // 18 } } else { for (int i = 0; i < n; i++) { @@ -238,26 +256,14 @@ void FixGranularMDR::unpack_forward_comm(int n, int first, double *buf) int m = 0; int last = first + n; - if (comm_stage == COMM_RADIUS_UPDATE) { + if (comm_stage == COMM_1) { for (int i = first; i < last; i++) { - dvector[index_Ro][i] = buf[m++]; // 1 dvector[index_Vgeo][i] = buf[m++]; // 2 dvector[index_Velas][i] = buf[m++]; // 3 - dvector[index_Vcaps][i] = buf[m++]; // 4 - dvector[index_eps_bar][i] = buf[m++]; // 5 - dvector[index_dRnumerator][i] = buf[m++]; // 6 - dvector[index_dRdenominator][i] = buf[m++]; // 7 dvector[index_Acon0][i] = buf[m++]; // 8 - dvector[index_Acon1][i] = buf[m++]; // 9 dvector[index_Atot][i] = buf[m++]; // 10 - dvector[index_Atot_sum][i] = buf[m++]; // 11 - dvector[index_ddelta_bar][i] = buf[m++]; // 12 dvector[index_psi][i] = buf[m++]; // 13 dvector[index_psi_b][i] = buf[m++]; // 14 - dvector[index_sigmaxx][i] = buf[m++]; // 15 - dvector[index_sigmayy][i] = buf[m++]; // 16 - dvector[index_sigmazz][i] = buf[m++]; // 17 - dvector[index_history_setup_flag][i] = buf[m++]; // 18 } } else { for (int i = first; i < last; i++) { @@ -307,83 +313,46 @@ void FixGranularMDR::end_of_step() } Velas[i] = Vo * (1.0 + eps_bar[i]); - Vcaps[i] = 0.0; - eps_bar[i] = 0.0; - dRnumerator[i] = 0.0; - dRdenominator[i] = 0.0; Acon0[i] = Acon1[i]; - Acon1[i] = 0.0; - Atot_sum[i] = 0.0; - ddelta_bar[i] = 0.0; } } /* ---------------------------------------------------------------------- - initialize values to zero, called when atom is created + initialize setup flag to zero, called when atom is created ------------------------------------------------------------------------- */ void FixGranularMDR::set_arrays(int i) { - // QUESTION: which of these must be initialized to zero? - // maybe just index_history_setup_flag? - // ANSWER: I would agree with how you have it right now. All of the variables being initialized - // to zero here should be zero when the atom is created. However, is it ever possible for - // calculate_forces() to be called without calling pre_force()? If the answer is no, then - // we might be able to move the initializations/resetting of Velas[i] through ddelta_bar[i] - // from end_of_step to pre_force. Then I think we could get rid of all the set arrays except - // for history_setup_flag. Vo will have to be redefined in pre_force to allow Velas[i] to be set. - - // atom->dvector[index_Ro][i] = 0.0; - // atom->dvector[index_Vgeo][i] = 0.0; - // atom->dvector[index_Velas][i] = 0.0; - atom->dvector[index_Vcaps][i] = 0.0; - atom->dvector[index_eps_bar][i] = 0.0; - atom->dvector[index_dRnumerator][i] = 0.0; - atom->dvector[index_dRdenominator][i] = 0.0; - atom->dvector[index_Acon0][i] = 0.0; - atom->dvector[index_Acon1][i] = 0.0; - // atom->dvector[index_Atot][i] = 0.0; - atom->dvector[index_Atot_sum][i] = 0.0; - atom->dvector[index_ddelta_bar][i] = 0.0; - // atom->dvector[index_psi][i] = 0.0; - // atom->dvector[index_psi_b][i] = 0.0; - // atom->dvector[index_sigmaxx][i] = 0.0; - // atom->dvector[index_sigmayy][i] = 0.0; - // atom->dvector[index_sigmazz][i] = 0.0; atom->dvector[index_history_setup_flag][i] = 0.0; } /* ---------------------------------------------------------------------- - calculate updated radius for atoms + reset all intermediate variables ------------------------------------------------------------------------- */ -void FixGranularMDR::radius_update() +void FixGranularMDR::reset_properties() { - double *radius = atom->radius; - int nlocal = atom->nlocal; - - double *Ro = atom->dvector[index_Ro]; - double *Vgeo = atom->dvector[index_Vgeo]; - double *Velas = atom->dvector[index_Velas]; - double *Atot = atom->dvector[index_Atot]; - double *psi = atom->dvector[index_psi]; - double *psi_b = atom->dvector[index_psi_b]; + double *Vcaps = atom->dvector[index_Vcaps]; + double *eps_bar = atom->dvector[index_eps_bar]; + double *dRnumerator = atom->dvector[index_dRnumerator]; + double *dRdenominator = atom->dvector[index_dRdenominator]; + double *Acon1 = atom->dvector[index_Acon1]; + double *Atot_sum = atom->dvector[index_Atot_sum]; + double *ddelta_bar = atom->dvector[index_ddelta_bar]; double *sigmaxx = atom->dvector[index_sigmaxx]; double *sigmayy = atom->dvector[index_sigmayy]; double *sigmazz = atom->dvector[index_sigmazz]; - double *history_setup_flag = atom->dvector[index_history_setup_flag]; - for (int i = 0; i < nlocal; i++) { - if (history_setup_flag[i] < EPSILON) { - Ro[i] = radius[i]; - Vgeo[i] = 4.0 / 3.0 * MY_PI * pow(Ro[i], 3.0); - Velas[i] = 4.0 / 3.0 * MY_PI * pow(Ro[i], 3.0); - Atot[i] = 4.0 * MY_PI * pow(Ro[i], 2.0); - psi[i] = 1.0; - psi_b[i] = psi_b_coeff; - history_setup_flag[i] = 1.0; - } + int ntotal = atom->nlocal + atom->nghost; + for (int i = 0; i < ntotal; i++) { + Vcaps[i] = 0.0; + eps_bar[i] = 0.0; + dRnumerator[i] = 0.0; + dRdenominator[i] = 0.0; + Acon1[i] = 0.0; + Atot_sum[i] = 0.0; + ddelta_bar[i] = 0.0; sigmaxx[i] = 0.0; sigmayy[i] = 0.0; sigmazz[i] = 0.0; diff --git a/src/GRANULAR/fix_granular_mdr.h b/src/GRANULAR/fix_granular_mdr.h index d97bed6723..a1eed394d9 100644 --- a/src/GRANULAR/fix_granular_mdr.h +++ b/src/GRANULAR/fix_granular_mdr.h @@ -78,7 +78,7 @@ class FixGranularMDR : public Fix { class FixNeighHistory *fix_history; std::vector fix_wall_list; - void radius_update(); + void reset_properties(); void mean_surf_disp(); void calculate_contact_penalty(); void update_fix_gran_wall(); diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 98fc9e3ebc..6300af6479 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -780,10 +780,10 @@ double GranSubModNormalMDR::calculate_forces() double Ac; (*Yflag_offset == 0.0) ? Ac = MY_PI * delta * R : Ac = MY_PI * ((2.0 * delta * R - pow(delta, 2)) + cA / MY_PI); if (Ac < 0.0) Ac = 0.0; - //if (update) { + if (update) { Atot_sum[i] += wij * (Ac - 2.0 * MY_PI * R * (deltamax_MDR + delta_BULK)); Acon1[i] += wij * Ac; - //} + } // bulk force calculation double F_BULK; @@ -796,9 +796,9 @@ double GranSubModNormalMDR::calculate_forces() *Ac_offset = wij * Ac; // radius update scheme quantity calculation - //if (update) { + if (update) { Vcaps[i] += (MY_PI * THIRD) * pow(delta, 2) * (3.0 * R - delta); - //} + } const double Fntmp = wij * (F_MDR + F_BULK); const double fx = Fntmp * gm->nx[0]; @@ -808,24 +808,21 @@ double GranSubModNormalMDR::calculate_forces() const double by = -(Ro - deltao) * gm->nx[1]; const double bz = -(Ro - deltao) * gm->nx[2]; const double eps_bar_contact = (1.0 / (3 * kappa * Velas[i])) * (fx * bx + fy * by + fz * bz); - //if (update) { - eps_bar[i] += eps_bar_contact; - //} + if (update) eps_bar[i] += eps_bar_contact; double desp_bar_contact = eps_bar_contact - *eps_bar_offset; - //if (update && delta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0){ - if (delta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0){ + if (update && delta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0) { const double Vo = (4.0 * THIRD) * MY_PI * pow(Ro, 3); dRnumerator[i] += -Vo * (eps_bar_contact - *eps_bar_offset) - wij * MY_PI * ddeltao * (2.0 * deltao * Ro - pow(deltao, 2) + pow(R, 2) - pow(Ro, 2)); dRdenominator[i] += wij * 2.0 * MY_PI * R * (deltao + R - Ro); } *eps_bar_offset = eps_bar_contact; - //if (update) { + if (update) { sigmaxx[i] += (1.0 / Velas[i]) * (fx * bx); sigmayy[i] += (1.0 / Velas[i]) * (fy * by); sigmazz[i] += (1.0 / Velas[i]) * (fz * bz); - //} + } } gm->i = i_true; From 36b041a9aede27e851dd489faadc993618586b47 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Mon, 6 Jan 2025 16:29:05 -0700 Subject: [PATCH 43/74] Removing EoS update in setup --- src/GRANULAR/fix_granular_mdr.cpp | 11 +---------- src/GRANULAR/fix_granular_mdr.h | 1 - 2 files changed, 1 insertion(+), 11 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index e418a88a80..33eb2d5e0b 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -172,14 +172,6 @@ void FixGranularMDR::setup_pre_force(int /*vflag*/) /* ---------------------------------------------------------------------- */ -void FixGranularMDR::setup(int /*vflag*/) -{ - end_of_step(); - reset_properties(); -} - -/* ---------------------------------------------------------------------- */ - void FixGranularMDR::pre_force(int) { // Initialize variables for any new atoms @@ -291,7 +283,6 @@ void FixGranularMDR::end_of_step() double *Acon1 = atom->dvector[index_Acon1]; double *Atot = atom->dvector[index_Atot]; double *Atot_sum = atom->dvector[index_Atot_sum]; - double *ddelta_bar = atom->dvector[index_ddelta_bar]; double *psi = atom->dvector[index_psi]; double *psi_b = atom->dvector[index_psi_b]; @@ -328,7 +319,7 @@ void FixGranularMDR::set_arrays(int i) } /* ---------------------------------------------------------------------- - reset all intermediate variables + reset all intermediate properties ------------------------------------------------------------------------- */ void FixGranularMDR::reset_properties() diff --git a/src/GRANULAR/fix_granular_mdr.h b/src/GRANULAR/fix_granular_mdr.h index a1eed394d9..b6584e1028 100644 --- a/src/GRANULAR/fix_granular_mdr.h +++ b/src/GRANULAR/fix_granular_mdr.h @@ -62,7 +62,6 @@ class FixGranularMDR : public Fix { ~FixGranularMDR() override; int setmask() override; void post_constructor() override; - void setup(int) override; void setup_pre_force(int) override; void pre_force(int) override; void end_of_step() override; From 6c7d3646c7ff95b2b5db9738a1db2ab2df1d51a7 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Mon, 6 Jan 2025 16:33:24 -0700 Subject: [PATCH 44/74] Moving newton error to fix mdr --- src/GRANULAR/fix_granular_mdr.cpp | 3 +++ src/GRANULAR/granular_model.cpp | 2 -- 2 files changed, 3 insertions(+), 2 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index 33eb2d5e0b..58512b70d6 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -115,6 +115,9 @@ void FixGranularMDR::setup_pre_force(int /*vflag*/) if (pair == nullptr) error->all(FLERR, "Must use pair granular with MDR model"); + if (force->newton) + error->all(FLERR, "MDR contact model requires Newton off"); + // Confirm all MDR models are consistent class GranularModel *pair_model, *fix_model; diff --git a/src/GRANULAR/granular_model.cpp b/src/GRANULAR/granular_model.cpp index eac5c61940..cb0bf29987 100644 --- a/src/GRANULAR/granular_model.cpp +++ b/src/GRANULAR/granular_model.cpp @@ -246,8 +246,6 @@ void GranularModel::init() if (normal_model->name == "mdr") { if (damping_model->name != "none") error->all(FLERR, "MDR require 'none' damping model. To damp, specify a coefficient of restitution < 1."); - if (force->newton) - error->all(FLERR, "MDR contact model requires Newton off"); } else { if (damping_model->name == "none") error->all(FLERR, "Must specify damping granular model"); } From ccc57f85a310296cce67f5e69cd4b7c439e0cbd2 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Tue, 7 Jan 2025 08:46:59 -0700 Subject: [PATCH 45/74] Missed changes --- src/GRANULAR/fix_granular_mdr.cpp | 2 ++ 1 file changed, 2 insertions(+) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index 58512b70d6..433e3ddbf1 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -210,6 +210,8 @@ void FixGranularMDR::pre_force(int) comm_stage = COMM_1; comm->forward_comm(this, 6); + if (update->setupflag) return; + calculate_contact_penalty(); mean_surf_disp(); update_fix_gran_wall(); From 75543e27e42baf5bbd4f746f0b81733be0d9f79b Mon Sep 17 00:00:00 2001 From: jtclemm Date: Tue, 7 Jan 2025 08:56:50 -0700 Subject: [PATCH 46/74] Uncommenting update flag, whitespace --- src/GRANULAR/gran_sub_mod_normal.cpp | 9 +++++---- 1 file changed, 5 insertions(+), 4 deletions(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 6300af6479..8b6e933592 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -544,7 +544,7 @@ double GranSubModNormalMDR::calculate_forces() double delta = gm->delta; // apparent overlap double *history = & gm->history[history_index]; // load in all history variables - //int update = gm->history_update; + int update = gm->history_update; // Rigid flat placement scheme double * deltamax_offset = & history[DELTA_MAX]; @@ -583,8 +583,8 @@ double GranSubModNormalMDR::calculate_forces() double delta_geo, delta_geo_alt; double delta_geoOpt1 = deltamax * (deltamax - 2.0 * gm->radj) / (2.0 * (deltamax - gm->radi - gm->radj)); double delta_geoOpt2 = deltamax * (deltamax - 2.0 * gm->radi) / (2.0 * (deltamax - gm->radi - gm->radj)); - (gm->radi < gm->radj) ? delta_geo = MAX(delta_geoOpt1,delta_geoOpt2) : delta_geo = MIN(delta_geoOpt1, delta_geoOpt2); - (gm->radi > gm->radj) ? delta_geo_alt = MAX(delta_geoOpt1,delta_geoOpt2) : delta_geo_alt = MIN(delta_geoOpt1,delta_geoOpt2); + (gm->radi < gm->radj) ? delta_geo = MAX(delta_geoOpt1, delta_geoOpt2) : delta_geo = MIN(delta_geoOpt1, delta_geoOpt2); + (gm->radi > gm->radj) ? delta_geo_alt = MAX(delta_geoOpt1, delta_geoOpt2) : delta_geo_alt = MIN(delta_geoOpt1,delta_geoOpt2); // cap displacement if it exceeds the overlap limit and parition the remaining to the other side if (delta_geo / gm->radi > MDR_OVERLAP_LIMIT) { @@ -600,7 +600,8 @@ double GranSubModNormalMDR::calculate_forces() } else { delta = delta_geo + (deltap1 - delta_geo) / (deltap - deltamax) * (gm->delta - deltamax); } - } else if (gm->contact_type != PAIR && contactSide != 0) { // contact with particle-wall requires only one evaluation + } else if (gm->contact_type != PAIR && contactSide != 0) { + // contact with particle-wall requires only one evaluation break; } From 61bc514b3888224689bf339fa99c35b90d2f265b Mon Sep 17 00:00:00 2001 From: jtclemm Date: Tue, 7 Jan 2025 11:07:19 -0700 Subject: [PATCH 47/74] removing end of step in fix mdr --- src/GRANULAR/fix_granular_mdr.cpp | 144 +++++++++++------------------- src/GRANULAR/fix_granular_mdr.h | 2 - 2 files changed, 54 insertions(+), 92 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index 433e3ddbf1..45b8f3376a 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -75,7 +75,6 @@ int FixGranularMDR::setmask() { int mask = 0; mask |= PRE_FORCE; - mask |= END_OF_STEP; return mask; } @@ -177,22 +176,30 @@ void FixGranularMDR::setup_pre_force(int /*vflag*/) void FixGranularMDR::pre_force(int) { - // Initialize variables for any new atoms - double *radius = atom->radius; int nlocal = atom->nlocal; double *Ro = atom->dvector[index_Ro]; double *Vgeo = atom->dvector[index_Vgeo]; double *Velas = atom->dvector[index_Velas]; + double *Vcaps = atom->dvector[index_Vcaps]; + double *eps_bar = atom->dvector[index_eps_bar]; + double *dRnumerator = atom->dvector[index_dRnumerator]; + double *dRdenominator = atom->dvector[index_dRdenominator]; + double *Acon0 = atom->dvector[index_Acon0]; double *Acon1 = atom->dvector[index_Acon1]; double *Atot = atom->dvector[index_Atot]; + double *Atot_sum = atom->dvector[index_Atot_sum]; double *psi = atom->dvector[index_psi]; double *psi_b = atom->dvector[index_psi_b]; + double *ddelta_bar = atom->dvector[index_ddelta_bar]; + double *sigmaxx = atom->dvector[index_sigmaxx]; + double *sigmayy = atom->dvector[index_sigmayy]; + double *sigmazz = atom->dvector[index_sigmazz]; double *history_setup_flag = atom->dvector[index_history_setup_flag]; - int ntotal = atom->nlocal + atom->nghost; - for (int i = 0; i < ntotal; i++) { + // update the apparent radius of local particles, will forward to ghosts + for (int i = 0; i < nlocal; i++) { if (history_setup_flag[i] < EPSILON) { Ro[i] = radius[i]; Vgeo[i] = 4.0 / 3.0 * MY_PI * pow(Ro[i], 3.0); @@ -200,24 +207,58 @@ void FixGranularMDR::pre_force(int) Atot[i] = 4.0 * MY_PI * pow(Ro[i], 2.0); psi[i] = 1.0; psi_b[i] = psi_b_coeff; + Acon0[i] = 0.0; Acon1[i] = 0.0; history_setup_flag[i] = 1.0; + continue; } + + if (update->setupflag) continue; + + const double R = radius[i]; + const double Vo = 4.0 / 3.0 * MY_PI * pow(Ro[i], 3.0); + const double Vgeoi = 4.0 / 3.0 * MY_PI * pow(R, 3.0) - Vcaps[i]; + + Vgeo[i] = MIN(Vgeoi, Vo); + Velas[i] = Vo * (1.0 + eps_bar[i]); + Atot[i] = 4.0 * MY_PI * pow(R, 2.0) + Atot_sum[i]; + psi[i] = (Atot[i] - Acon1[i]) / Atot[i]; + + if (psi_b[i] < psi[i]) { + const double dR = MAX(dRnumerator[i] / (dRdenominator[i] - 4.0 * MY_PI * pow(R, 2.0)), 0.0); + if ((radius[i] + dR) < (1.5 * Ro[i])) + radius[i] += dR; + } + + Acon0[i] = Acon1[i]; } - reset_properties(); + // rezero temporary variables for all atoms, no need to communicate + int ntotal = nlocal + atom->nghost; + for (int i = 0; i < ntotal; i++) { + Vcaps[i] = 0.0; + eps_bar[i] = 0.0; + dRnumerator[i] = 0.0; + dRdenominator[i] = 0.0; + Acon1[i] = 0.0; + Atot_sum[i] = 0.0; + ddelta_bar[i] = 0.0; + sigmaxx[i] = 0.0; + sigmayy[i] = 0.0; + sigmazz[i] = 0.0; + } comm_stage = COMM_1; comm->forward_comm(this, 6); - if (update->setupflag) return; + if (!update->setupflag) { + calculate_contact_penalty(); + mean_surf_disp(); + update_fix_gran_wall(); - calculate_contact_penalty(); - mean_surf_disp(); - update_fix_gran_wall(); - - comm_stage = COMM_2; - comm->forward_comm(this, 1); + comm_stage = COMM_2; + comm->forward_comm(this, 1); + } } /* ---------------------------------------------------------------------- */ @@ -269,51 +310,6 @@ void FixGranularMDR::unpack_forward_comm(int n, int first, double *buf) } } -/* ---------------------------------------------------------------------- */ - -void FixGranularMDR::end_of_step() -{ - // update the apparent radius of every particle - double *radius = atom->radius; - int nlocal = atom->nlocal; - - double *Ro = atom->dvector[index_Ro]; - double *Vgeo = atom->dvector[index_Vgeo]; - double *Velas = atom->dvector[index_Velas]; - double *Vcaps = atom->dvector[index_Vcaps]; - double *eps_bar = atom->dvector[index_eps_bar]; - double *dRnumerator = atom->dvector[index_dRnumerator]; - double *dRdenominator = atom->dvector[index_dRdenominator]; - double *Acon0 = atom->dvector[index_Acon0]; - double *Acon1 = atom->dvector[index_Acon1]; - double *Atot = atom->dvector[index_Atot]; - double *Atot_sum = atom->dvector[index_Atot_sum]; - double *psi = atom->dvector[index_psi]; - double *psi_b = atom->dvector[index_psi_b]; - - for (int i = 0; i < nlocal; i++) { - - const double R = radius[i]; - Atot[i] = 4.0 * MY_PI * pow(R, 2.0) + Atot_sum[i]; - - const double Vo = 4.0 / 3.0 * MY_PI * pow(Ro[i], 3.0); - const double Vgeoi = 4.0 / 3.0 * MY_PI * pow(R, 3.0) - Vcaps[i]; - Vgeo[i] = MIN(Vgeoi, Vo); - - const double Afree = Atot[i] - Acon1[i]; - psi[i] = Afree / Atot[i]; - - const double dR = MAX(dRnumerator[i] / (dRdenominator[i] - 4.0 * MY_PI * pow(R, 2.0)), 0.0); - if (psi_b[i] < psi[i]) { - if ((radius[i] + dR) < (1.5 * Ro[i])) radius[i] += dR; - } - - Velas[i] = Vo * (1.0 + eps_bar[i]); - Acon0[i] = Acon1[i]; - } -} - - /* ---------------------------------------------------------------------- initialize setup flag to zero, called when atom is created ------------------------------------------------------------------------- */ @@ -323,38 +319,6 @@ void FixGranularMDR::set_arrays(int i) atom->dvector[index_history_setup_flag][i] = 0.0; } -/* ---------------------------------------------------------------------- - reset all intermediate properties -------------------------------------------------------------------------- */ - -void FixGranularMDR::reset_properties() -{ - double *Vcaps = atom->dvector[index_Vcaps]; - double *eps_bar = atom->dvector[index_eps_bar]; - double *dRnumerator = atom->dvector[index_dRnumerator]; - double *dRdenominator = atom->dvector[index_dRdenominator]; - double *Acon1 = atom->dvector[index_Acon1]; - double *Atot_sum = atom->dvector[index_Atot_sum]; - double *ddelta_bar = atom->dvector[index_ddelta_bar]; - double *sigmaxx = atom->dvector[index_sigmaxx]; - double *sigmayy = atom->dvector[index_sigmayy]; - double *sigmazz = atom->dvector[index_sigmazz]; - - int ntotal = atom->nlocal + atom->nghost; - for (int i = 0; i < ntotal; i++) { - Vcaps[i] = 0.0; - eps_bar[i] = 0.0; - dRnumerator[i] = 0.0; - dRdenominator[i] = 0.0; - Acon1[i] = 0.0; - Atot_sum[i] = 0.0; - ddelta_bar[i] = 0.0; - sigmaxx[i] = 0.0; - sigmayy[i] = 0.0; - sigmazz[i] = 0.0; - } -} - /* ---------------------------------------------------------------------- Screen for non-physical contacts occuring through obstructing particles. Assign non-zero penalties to these contacts to adjust force evaluation. diff --git a/src/GRANULAR/fix_granular_mdr.h b/src/GRANULAR/fix_granular_mdr.h index b6584e1028..4ece86aec0 100644 --- a/src/GRANULAR/fix_granular_mdr.h +++ b/src/GRANULAR/fix_granular_mdr.h @@ -64,7 +64,6 @@ class FixGranularMDR : public Fix { void post_constructor() override; void setup_pre_force(int) override; void pre_force(int) override; - void end_of_step() override; int pack_forward_comm(int, int *, double *, int, int *) override; void unpack_forward_comm(int, int, double *) override; void set_arrays(int) override; @@ -77,7 +76,6 @@ class FixGranularMDR : public Fix { class FixNeighHistory *fix_history; std::vector fix_wall_list; - void reset_properties(); void mean_surf_disp(); void calculate_contact_penalty(); void update_fix_gran_wall(); From 2c64d3b711b723956588bd9b43cf004c63340012 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Tue, 7 Jan 2025 12:58:18 -0700 Subject: [PATCH 48/74] Moving contact penalty update --- src/GRANULAR/fix_granular_mdr.cpp | 20 ++++++-- src/GRANULAR/gran_sub_mod_normal.cpp | 71 ++++++++++++++-------------- 2 files changed, 50 insertions(+), 41 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index 45b8f3376a..455576e170 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -333,7 +333,7 @@ void FixGranularMDR::calculate_contact_penalty() int *ilist, *jlist, *numneigh, **firstneigh; int *touch, **firsttouch; - double *history_ij, *history_ik, *history_jk, *history_kj; + double *history, *history_ij, *history_ik, *history_jk, *history_kj; double *allhistory, *allhistory_j, *allhistory_k, **firsthistory; bool touchflag = false; @@ -349,6 +349,16 @@ void FixGranularMDR::calculate_contact_penalty() firsttouch = fix_history->firstflag; firsthistory = fix_history->firstvalue; + // zero existing penalties + + for (ii = 0; ii < inum; ii++) { + i = ilist[ii]; + allhistory = firsthistory[i]; + jnum = numneigh[i]; + for (jj = 0; jj < jnum; jj++) + (&allhistory[size_history * jj])[PENALTY] = 0.0; + } + // contact penalty calculation for (ii = 0; ii < inum; ii++) { i = ilist[ii]; @@ -402,11 +412,11 @@ void FixGranularMDR::calculate_contact_penalty() // pull ij history history_ij = &allhistory[size_history * jj]; - double * pij = &history_ij[22]; // penalty for contact i and j + double * pij = &history_ij[PENALTY]; // penalty for contact i and j // pull ik history history_ik = &allhistory[size_history * kk]; - double * pik = &history_ik[22]; // penalty for contact i and k + double * pik = &history_ik[PENALTY]; // penalty for contact i and k // Find pair of atoms with the smallest overlap, atoms a & b, 3rd atom c is central // if a & b are both local: @@ -457,7 +467,7 @@ void FixGranularMDR::calculate_contact_penalty() if (k == kneigh) { allhistory_j = firsthistory[j]; history_jk = &allhistory_j[size_history * jk]; - pjk = &history_jk[22]; // penalty for contact j and k + pjk = &history_jk[PENALTY]; // penalty for contact j and k break; } } @@ -472,7 +482,7 @@ void FixGranularMDR::calculate_contact_penalty() if (j == jneigh) { allhistory_k = firsthistory[k]; history_kj = &allhistory_k[size_history * kj]; - pjk = &history_kj[22]; // penalty for contact j and k + pjk = &history_kj[PENALTY]; // penalty for contact j and k break; } } diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 8b6e933592..7ef6cdad16 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -547,15 +547,15 @@ double GranSubModNormalMDR::calculate_forces() int update = gm->history_update; // Rigid flat placement scheme - double * deltamax_offset = & history[DELTA_MAX]; + double *deltamax_offset = & history[DELTA_MAX]; double deltamax = *deltamax_offset; - double * deltap_offset0 = & history[DELTAP_0]; - double * deltap_offset1 = & history[DELTAP_1]; + double *deltap_offset0 = & history[DELTAP_0]; + double *deltap_offset1 = & history[DELTAP_1]; double deltap0 = *deltap_offset0; double deltap1 = *deltap_offset1; if (gm->delta >= *deltamax_offset) *deltamax_offset = gm->delta; - deltamax = *deltamax_offset; + if (update) deltamax = *deltamax_offset; for (int contactSide = 0; contactSide < 2; contactSide++) { @@ -605,18 +605,18 @@ double GranSubModNormalMDR::calculate_forces() break; } - delta_offset = & history[DELTA_0 + contactSide]; - deltao_offset = & history[DELTAO_0 + contactSide]; - delta_MDR_offset = & history[DELTA_MDR_0 + contactSide]; - delta_BULK_offset = & history[DELTA_BULK_0 + contactSide]; - deltamax_MDR_offset = & history[DELTAMAX_MDR_0 + contactSide]; - Yflag_offset = & history[YFLAG_0 + contactSide]; - deltaY_offset = & history[DELTAY_0 + contactSide]; - cA_offset = & history[CA_0 + contactSide]; - aAdh_offset = & history[AADH_0 + contactSide]; - Ac_offset = & history[AC_0 + contactSide]; - eps_bar_offset = & history[EPS_BAR_0 + contactSide]; - deltap_offset = & history[DELTAP_0 + contactSide]; + delta_offset = &history[DELTA_0 + contactSide]; + deltao_offset = &history[DELTAO_0 + contactSide]; + delta_MDR_offset = &history[DELTA_MDR_0 + contactSide]; + delta_BULK_offset = &history[DELTA_BULK_0 + contactSide]; + deltamax_MDR_offset = &history[DELTAMAX_MDR_0 + contactSide]; + Yflag_offset = &history[YFLAG_0 + contactSide]; + deltaY_offset = &history[DELTAY_0 + contactSide]; + cA_offset = &history[CA_0 + contactSide]; + aAdh_offset = &history[AADH_0 + contactSide]; + Ac_offset = &history[AC_0 + contactSide]; + eps_bar_offset = &history[EPS_BAR_0 + contactSide]; + deltap_offset = &history[DELTAP_0 + contactSide]; // temporary i and j indices const int i = gm->i; @@ -628,11 +628,11 @@ double GranSubModNormalMDR::calculate_forces() // kinematics const double ddelta = delta - *delta_offset; - *delta_offset = delta; + if (update) *delta_offset = delta; const double deltao = delta - (R - Ro); const double ddeltao = deltao - *deltao_offset; - *deltao_offset = deltao; + if (update) *deltao_offset = deltao; double ddelta_MDR, ddelta_BULK; if (psi[i] < psi_b) { // if true, bulk response has triggered, split displacement increment between the MDR and BULK components @@ -643,17 +643,17 @@ double GranSubModNormalMDR::calculate_forces() ddelta_MDR = ddelta; } const double delta_MDR = *delta_MDR_offset + ddelta_MDR; // MDR displacement - *delta_MDR_offset = delta_MDR; // update old MDR displacement + if (update) *delta_MDR_offset = delta_MDR; // update old MDR displacement const double delta_BULK = MAX(0.0, *delta_BULK_offset + ddelta_BULK); // bulk displacement - *delta_BULK_offset = delta_BULK; // update old bulk displacement + if (update) *delta_BULK_offset = delta_BULK; // update old bulk displacement - if (delta_MDR > *deltamax_MDR_offset) *deltamax_MDR_offset = delta_MDR; + if (update && delta_MDR > *deltamax_MDR_offset) *deltamax_MDR_offset = delta_MDR; const double deltamax_MDR = *deltamax_MDR_offset; const double pY = Y * (1.75 * exp(-4.4 * deltamax_MDR / R) + 1.0); // Set value of average pressure along yield surface if (*Yflag_offset == 0.0 && delta_MDR >= deltamax_MDR) { const double phertz = 4 * Eeff * sqrt(delta_MDR) / (3 * MY_PI * sqrt(R)); - if ( phertz > pY ) { + if (update && phertz > pY) { *Yflag_offset = 1.0; *deltaY_offset = delta_MDR; *cA_offset = MY_PI * (pow(*deltaY_offset, 2) - *deltaY_offset * R); @@ -669,7 +669,7 @@ double GranSubModNormalMDR::calculate_forces() double amax, amaxsq; // maximum experienced contact radius const double cA = *cA_offset; // contact area intercept - if ( *Yflag_offset == 0.0 ) { // elastic contact + if (*Yflag_offset == 0.0) { // elastic contact A = 4.0 * R; Ainv = 1.0 / A; B = 2.0 * R; @@ -689,7 +689,7 @@ double GranSubModNormalMDR::calculate_forces() deltae1D = (delta_MDR - deltamax_MDR + deltae1Dmax + deltaR) / (1 + deltaR / deltae1Dmax); // transformed elastic displacement // added for rigid flat placement - *deltap_offset = deltamax_MDR - (deltae1Dmax + deltaR); + if (update) *deltap_offset = deltamax_MDR - (deltae1Dmax + deltaR); } double a_na; @@ -701,7 +701,7 @@ double GranSubModNormalMDR::calculate_forces() if ( gamma > 0.0 ) { // adhesive contact double g_aAdh; - if (delta_MDR == deltamax_MDR || a_na >= aAdh ) { // case 1: no tensile springs, purely compressive contact + if (delta_MDR == deltamax_MDR || a_na >= aAdh) { // case 1: no tensile springs, purely compressive contact if (deltae1D <= 0.0) { F_MDR = 0.0; } else { @@ -711,7 +711,7 @@ double GranSubModNormalMDR::calculate_forces() if (std::isnan(F_MDR)) { error->one(FLERR, "F_MDR is NaN, case 1: no tensile springs"); } - *aAdh_offset = a_fac * a_na; + if (update) *aAdh_offset = a_fac * a_na; } else { const double lmax = sqrt(2.0 * MY_PI * aAdh * gamma / Eeff); g_aAdh = A * 0.5 - A / B * sqrt(pow(B, 2.0) * 0.25 - pow(aAdh, 2)); @@ -761,11 +761,11 @@ double GranSubModNormalMDR::calculate_forces() F_MDR = F_na + F_Adhes; if (std::isnan(F_MDR)) error->one(FLERR, "F_MDR is NaN, case 3: tensile springs exceed critical length"); } - *aAdh_offset = aAdh; + if (update) *aAdh_offset = aAdh; } } } else { // non-adhesive contact - *aAdh_offset = a_na; + if (update) *aAdh_offset = a_na; (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff * (A * B * 0.25) * (acos(1.0 - 2.0 * deltae1D / A) - (1.0 - 2.0 * deltae1D / A) * sqrt(4.0 * deltae1D / A - 4.0 * pow(deltae1D, 2) / pow(A, 2))); if (std::isnan(F_MDR)) { error->one(FLERR, "F_MDR is NaN, non-adhesive case"); @@ -773,7 +773,7 @@ double GranSubModNormalMDR::calculate_forces() } // contact penalty scheme - penalty_offset = & history[PENALTY]; + penalty_offset = &history[PENALTY]; double pij = *penalty_offset; const double wij = MAX(1.0 - pij, 0.0); @@ -793,11 +793,11 @@ double GranSubModNormalMDR::calculate_forces() // total force calculation (contactSide == 0) ? F0 = F_MDR + F_BULK : F1 = F_MDR + F_BULK; - // mean surface dipslacement calculation - *Ac_offset = wij * Ac; - - // radius update scheme quantity calculation if (update) { + // mean surface dipslacement calculation + *Ac_offset = wij * Ac; + + // radius update scheme quantity calculation Vcaps[i] += (MY_PI * THIRD) * pow(delta, 2) * (3.0 * R - delta); } @@ -817,9 +817,9 @@ double GranSubModNormalMDR::calculate_forces() dRnumerator[i] += -Vo * (eps_bar_contact - *eps_bar_offset) - wij * MY_PI * ddeltao * (2.0 * deltao * Ro - pow(deltao, 2) + pow(R, 2) - pow(Ro, 2)); dRdenominator[i] += wij * 2.0 * MY_PI * R * (deltao + R - Ro); } - *eps_bar_offset = eps_bar_contact; if (update) { + *eps_bar_offset = eps_bar_contact; sigmaxx[i] += (1.0 / Velas[i]) * (fx * bx); sigmayy[i] += (1.0 / Velas[i]) * (fy * by); sigmazz[i] += (1.0 / Velas[i]) * (fz * bz); @@ -831,10 +831,9 @@ double GranSubModNormalMDR::calculate_forces() gm->radi = radi_true; gm->radj = radj_true; - double * penalty_offset = & history[PENALTY]; + double *penalty_offset = &history[PENALTY]; const double pij = *penalty_offset; const double wij = MAX(1.0 - pij, 0.0); - *penalty_offset = 0.0; // assign final force if (gm->contact_type != PAIR) { From d9e40a79c1f29b9f41af4045cf053d7c4d4309ca Mon Sep 17 00:00:00 2001 From: jtclemm Date: Tue, 7 Jan 2025 13:19:07 -0700 Subject: [PATCH 49/74] Removing psi_b peratom variable --- src/GRANULAR/fix_granular_mdr.cpp | 13 ++++--------- src/GRANULAR/fix_granular_mdr.h | 1 - 2 files changed, 4 insertions(+), 10 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index 455576e170..ea702ae77f 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -54,7 +54,7 @@ enum {COMM_1, COMM_2}; FixGranularMDR::FixGranularMDR(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg) { - comm_forward = 6; + comm_forward = 5; create_attribute = 1; id_fix = nullptr; @@ -84,7 +84,7 @@ void FixGranularMDR::post_constructor() { int tmp1, tmp2; id_fix = utils::strdup("MDR_PARTICLE_HISTORY_VARIABLES"); - modify->add_fix(fmt::format("{} all property/atom d_Ro d_Vcaps d_Vgeo d_Velas d_eps_bar d_dRnumerator d_dRdenominator d_Acon0 d_Acon1 d_Atot d_Atot_sum d_ddelta_bar d_psi d_psi_b d_history_setup_flag d_sigmaxx d_sigmayy d_sigmazz ghost yes", id_fix)); + modify->add_fix(fmt::format("{} all property/atom d_Ro d_Vcaps d_Vgeo d_Velas d_eps_bar d_dRnumerator d_dRdenominator d_Acon0 d_Acon1 d_Atot d_Atot_sum d_ddelta_bar d_psi d_history_setup_flag d_sigmaxx d_sigmayy d_sigmazz ghost yes", id_fix)); index_Ro = atom->find_custom("Ro", tmp1, tmp2); index_Vcaps = atom->find_custom("Vcaps", tmp1, tmp2); @@ -99,7 +99,6 @@ void FixGranularMDR::post_constructor() index_Atot_sum = atom->find_custom("Atot_sum", tmp1, tmp2); index_ddelta_bar = atom->find_custom("ddelta_bar", tmp1, tmp2); index_psi = atom->find_custom("psi", tmp1, tmp2); - index_psi_b = atom->find_custom("psi_b", tmp1, tmp2); index_history_setup_flag = atom->find_custom("history_setup_flag", tmp1, tmp2); index_sigmaxx = atom->find_custom("sigmaxx", tmp1, tmp2); index_sigmayy = atom->find_custom("sigmayy", tmp1, tmp2); @@ -191,7 +190,6 @@ void FixGranularMDR::pre_force(int) double *Atot = atom->dvector[index_Atot]; double *Atot_sum = atom->dvector[index_Atot_sum]; double *psi = atom->dvector[index_psi]; - double *psi_b = atom->dvector[index_psi_b]; double *ddelta_bar = atom->dvector[index_ddelta_bar]; double *sigmaxx = atom->dvector[index_sigmaxx]; double *sigmayy = atom->dvector[index_sigmayy]; @@ -206,7 +204,6 @@ void FixGranularMDR::pre_force(int) Velas[i] = 4.0 / 3.0 * MY_PI * pow(Ro[i], 3.0); Atot[i] = 4.0 * MY_PI * pow(Ro[i], 2.0); psi[i] = 1.0; - psi_b[i] = psi_b_coeff; Acon0[i] = 0.0; Acon1[i] = 0.0; history_setup_flag[i] = 1.0; @@ -224,7 +221,7 @@ void FixGranularMDR::pre_force(int) Atot[i] = 4.0 * MY_PI * pow(R, 2.0) + Atot_sum[i]; psi[i] = (Atot[i] - Acon1[i]) / Atot[i]; - if (psi_b[i] < psi[i]) { + if (psi_b_coeff < psi[i]) { const double dR = MAX(dRnumerator[i] / (dRdenominator[i] - 4.0 * MY_PI * pow(R, 2.0)), 0.0); if ((radius[i] + dR) < (1.5 * Ro[i])) radius[i] += dR; @@ -249,7 +246,7 @@ void FixGranularMDR::pre_force(int) } comm_stage = COMM_1; - comm->forward_comm(this, 6); + comm->forward_comm(this, 5); if (!update->setupflag) { calculate_contact_penalty(); @@ -275,7 +272,6 @@ int FixGranularMDR::pack_forward_comm(int n, int *list, double *buf, int /*pbc_f buf[m++] = dvector[index_Acon0][j]; // 8 buf[m++] = dvector[index_Atot][j]; // 10 buf[m++] = dvector[index_psi][j]; // 13 - buf[m++] = dvector[index_psi_b][j]; // 14 } } else { for (int i = 0; i < n; i++) { @@ -301,7 +297,6 @@ void FixGranularMDR::unpack_forward_comm(int n, int first, double *buf) dvector[index_Acon0][i] = buf[m++]; // 8 dvector[index_Atot][i] = buf[m++]; // 10 dvector[index_psi][i] = buf[m++]; // 13 - dvector[index_psi_b][i] = buf[m++]; // 14 } } else { for (int i = first; i < last; i++) { diff --git a/src/GRANULAR/fix_granular_mdr.h b/src/GRANULAR/fix_granular_mdr.h index 4ece86aec0..f0ba76d155 100644 --- a/src/GRANULAR/fix_granular_mdr.h +++ b/src/GRANULAR/fix_granular_mdr.h @@ -93,7 +93,6 @@ class FixGranularMDR : public Fix { int index_Atot_sum; // running sum of contact area minus cap area int index_ddelta_bar; // change in mean surface displacement int index_psi; // ratio of free surface area to total surface area - int index_psi_b; // TEMPORARY, SINCE PSI_B IS ALREADY DEFINED IN THEINPUT SCRIPT int index_sigmaxx; // xx-component of the stress tensor, not necessary forforce calculation int index_sigmayy; // yy-component of the stress tensor, not necessary forforce calculation int index_sigmazz; // zz-component of the stress tensor, not necessary forforce calculation From 2482cfafe925e34cc5fd1619a951a6997fe18c9e Mon Sep 17 00:00:00 2001 From: jtclemm Date: Tue, 7 Jan 2025 13:27:01 -0700 Subject: [PATCH 50/74] Simplifying fncrit --- src/GRANULAR/gran_sub_mod_normal.cpp | 9 +-------- src/GRANULAR/gran_sub_mod_normal.h | 2 -- 2 files changed, 1 insertion(+), 10 deletions(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 7ef6cdad16..457162c871 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -538,7 +538,7 @@ double GranSubModNormalMDR::calculate_forces() const double radi_true = gm->radi; // true i particle initial radius const double radj_true = gm->radj; // true j particle initial radius - F = 0.0; // average force + double F = 0.0; // average force double F0 = 0.0; // force on contact side 0 double F1 = 0.0; // force on contact side 1 double delta = gm->delta; // apparent overlap @@ -863,10 +863,3 @@ double GranSubModNormalMDR::calculate_forces() return F; } - -/* ---------------------------------------------------------------------- */ - -void GranSubModNormalMDR::set_fncrit() -{ - Fncrit = fabs(F); -} diff --git a/src/GRANULAR/gran_sub_mod_normal.h b/src/GRANULAR/gran_sub_mod_normal.h index 092ab2b147..7e9aed5d0f 100644 --- a/src/GRANULAR/gran_sub_mod_normal.h +++ b/src/GRANULAR/gran_sub_mod_normal.h @@ -143,12 +143,10 @@ namespace Granular_NS { void coeffs_to_local() override; void init() override; double calculate_forces() override; - void set_fncrit() override; double E, nu, Y, gamma, CoR, psi_b; // specified coeffs protected: double G, kappa, Eeff; // derived coeffs - double F; int index_Ro, index_Vgeo, index_Velas, index_Vcaps, index_eps_bar, index_dRnumerator; int index_dRdenominator, index_Acon0, index_Acon1, index_Atot, index_Atot_sum, index_ddelta_bar; From de667de8ebe1957554c1d9e749e17df3fb186ec3 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Tue, 7 Jan 2025 15:36:37 -0700 Subject: [PATCH 51/74] Fixing setup order --- src/GRANULAR/fix_granular_mdr.cpp | 63 ++++++++++++++++++------------- 1 file changed, 37 insertions(+), 26 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index ea702ae77f..fa6f1f59c3 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -176,8 +176,6 @@ void FixGranularMDR::setup_pre_force(int /*vflag*/) void FixGranularMDR::pre_force(int) { double *radius = atom->radius; - int nlocal = atom->nlocal; - double *Ro = atom->dvector[index_Ro]; double *Vgeo = atom->dvector[index_Vgeo]; double *Velas = atom->dvector[index_Velas]; @@ -196,21 +194,36 @@ void FixGranularMDR::pre_force(int) double *sigmazz = atom->dvector[index_sigmazz]; double *history_setup_flag = atom->dvector[index_history_setup_flag]; - // update the apparent radius of local particles, will forward to ghosts - for (int i = 0; i < nlocal; i++) { + int new_atom; + int nlocal = atom->nlocal; + int ntotal = nlocal + atom->nghost; + for (int i = 0; i < ntotal; i++) { + // initialize new atoms + new_atom = 0; if (history_setup_flag[i] < EPSILON) { Ro[i] = radius[i]; - Vgeo[i] = 4.0 / 3.0 * MY_PI * pow(Ro[i], 3.0); - Velas[i] = 4.0 / 3.0 * MY_PI * pow(Ro[i], 3.0); - Atot[i] = 4.0 * MY_PI * pow(Ro[i], 2.0); - psi[i] = 1.0; Acon0[i] = 0.0; Acon1[i] = 0.0; + Vcaps[i] = 0.0; + eps_bar[i] = 0.0; + dRnumerator[i] = 0.0; + dRdenominator[i] = 0.0; + Atot_sum[i] = 0.0; + ddelta_bar[i] = 0.0; + sigmaxx[i] = 0.0; + sigmayy[i] = 0.0; + sigmazz[i] = 0.0; history_setup_flag[i] = 1.0; - continue; + new_atom = 1; } - if (update->setupflag) continue; + // update apparent radius + + // will forward to ghosts + if (i >= nlocal) continue; + + // only update outside of setup (unless a new atom) + if (update->setupflag && (!new_atom)) continue; const double R = radius[i]; const double Vo = 4.0 / 3.0 * MY_PI * pow(Ro[i], 3.0); @@ -226,29 +239,27 @@ void FixGranularMDR::pre_force(int) if ((radius[i] + dR) < (1.5 * Ro[i])) radius[i] += dR; } - Acon0[i] = Acon1[i]; } - // rezero temporary variables for all atoms, no need to communicate - int ntotal = nlocal + atom->nghost; - for (int i = 0; i < ntotal; i++) { - Vcaps[i] = 0.0; - eps_bar[i] = 0.0; - dRnumerator[i] = 0.0; - dRdenominator[i] = 0.0; - Acon1[i] = 0.0; - Atot_sum[i] = 0.0; - ddelta_bar[i] = 0.0; - sigmaxx[i] = 0.0; - sigmayy[i] = 0.0; - sigmazz[i] = 0.0; - } - comm_stage = COMM_1; comm->forward_comm(this, 5); if (!update->setupflag) { + // rezero temporary variables for all atoms, no need to communicate + for (int i = 0; i < ntotal; i++) { + Vcaps[i] = 0.0; + eps_bar[i] = 0.0; + dRnumerator[i] = 0.0; + dRdenominator[i] = 0.0; + Acon1[i] = 0.0; + Atot_sum[i] = 0.0; + ddelta_bar[i] = 0.0; + sigmaxx[i] = 0.0; + sigmayy[i] = 0.0; + sigmazz[i] = 0.0; + } + calculate_contact_penalty(); mean_surf_disp(); update_fix_gran_wall(); From 9c7714e40fa3c15499e25ee217f79cabff64e4a9 Mon Sep 17 00:00:00 2001 From: William Zunker Date: Tue, 14 Jan 2025 10:52:12 -0500 Subject: [PATCH 52/74] Simplified deltamax definition --- src/GRANULAR/gran_sub_mod_normal.cpp | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 457162c871..11a084512e 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -548,14 +548,14 @@ double GranSubModNormalMDR::calculate_forces() // Rigid flat placement scheme double *deltamax_offset = & history[DELTA_MAX]; - double deltamax = *deltamax_offset; double *deltap_offset0 = & history[DELTAP_0]; double *deltap_offset1 = & history[DELTAP_1]; double deltap0 = *deltap_offset0; double deltap1 = *deltap_offset1; - if (gm->delta >= *deltamax_offset) *deltamax_offset = gm->delta; - if (update) deltamax = *deltamax_offset; + if (update && gm->delta >= *deltamax_offset) *deltamax_offset = gm->delta; + double deltamax = *deltamax_offset; + for (int contactSide = 0; contactSide < 2; contactSide++) { From 14389cfd2c77e8bb6c3aa9616dc73b87c23f6a7a Mon Sep 17 00:00:00 2001 From: William Zunker Date: Tue, 14 Jan 2025 11:33:55 -0500 Subject: [PATCH 53/74] Reset ddelta_bar even during update->setupflag=true --- src/GRANULAR/fix_granular_mdr.cpp | 16 +++++++++------- 1 file changed, 9 insertions(+), 7 deletions(-) diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index fa6f1f59c3..40397b142d 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -245,28 +245,30 @@ void FixGranularMDR::pre_force(int) comm_stage = COMM_1; comm->forward_comm(this, 5); - if (!update->setupflag) { + // rezero temporary variables for all atoms, no need to communicate - for (int i = 0; i < ntotal; i++) { + for (int i = 0; i < ntotal; i++) { + ddelta_bar[i] = 0.0; + if (!update->setupflag) { Vcaps[i] = 0.0; eps_bar[i] = 0.0; dRnumerator[i] = 0.0; dRdenominator[i] = 0.0; Acon1[i] = 0.0; Atot_sum[i] = 0.0; - ddelta_bar[i] = 0.0; sigmaxx[i] = 0.0; sigmayy[i] = 0.0; sigmazz[i] = 0.0; } - + } + if (!update->setupflag) { calculate_contact_penalty(); mean_surf_disp(); update_fix_gran_wall(); - - comm_stage = COMM_2; - comm->forward_comm(this, 1); } + + comm_stage = COMM_2; + comm->forward_comm(this, 1); } /* ---------------------------------------------------------------------- */ From 853a8efa887b0504f36c5cf5945323c5adde3eb7 Mon Sep 17 00:00:00 2001 From: William Zunker Date: Tue, 14 Jan 2025 12:32:20 -0500 Subject: [PATCH 54/74] Remove README_MDR.md --- examples/granular/README_MDR.md | 46 ------------------------------- src/GRANULAR/fix_granular_mdr.cpp | 2 +- 2 files changed, 1 insertion(+), 47 deletions(-) delete mode 100644 examples/granular/README_MDR.md diff --git a/examples/granular/README_MDR.md b/examples/granular/README_MDR.md deleted file mode 100644 index 74083cef47..0000000000 --- a/examples/granular/README_MDR.md +++ /dev/null @@ -1,46 +0,0 @@ -# Building the executable: -------------------------------------------------------------------------------- - -CMAKE may be used to build the executable, below is a short shell script that builds a fresh version of the executable. - - #!/bin/bash - - rm -r build - mkdir build; cd build - cmake ../cmake - PKGS="-D PKG_GRANULAR=on -D PKG_VTK=on -D PKG_SRD=on -D PKG_MPI=on" - cmake -C ../cmake/presets/most.cmake -C ../cmake/presets/nolib.cmake $PKGS ../cmake - cmake --build . -- -j 10 - -The GRANULAR package allows DEM simulation in LAMMPS and the VTK package allows creation of VTK files for viewing in paraview. The SRD package is for fluid coupling and the MPI is for parallelization. There are various other ways to build the lammps executable if you are interested: https://docs.lammps.org/Build.html. - - -# Running the code: -------------------------------------------------------------------------------- - -In the sims directory of the code base there is a folder called avicelTableting. Inside there is an input file called in.avicelTableting200. This input file defines a tableting simulation that is composed of die filling, compaction, release, and ejection. The geometry of the simulation is modeled after a real compaction simulator die. The material properties that are set roughly represent Avicel PH102. To run this simulation in serial, navigate inside the avicelTableting folder and run the following command: - - (path to lmp executable) < in.avicelTableting200 - -The simulation consists of 200 particles and takes ~10 minutes to run on a 2021 M1 Max. To generate a new packing with particles of different radii or distribution you can use the matlab script within generatePackings called generateCylinderPacking.m. It allows you to define the cylinder size, number of desired particles, minimum radius, and maximum radius. It will then generate a packing called spheres.data that is saved in the avicelTableting folder. If you change the distribution of the particle packing make sure to update the following items in the input script: - - neighbor - should be ~1.5x greater than the max radius Rmax. - timestep - dt = 0.35*sqrt{m/k} = 0.35*sqrt{(rho*4/3*pi*Rmin^3)/(kappa*Rmin)}. - variable atomRadius - specified value in front of prefactor should match Rmin from generateCylinderPacking.m. - -Once running the program should output three files a dump file and two csv files. The dump file can be used in Ovito for visualization. If you desire vtk files for visualization in Paraview create a folder called post and uncomment the dump command in in.avicelTableting. The generated csv files contain the upper punch displacement force relation and particle stress information. - -Plots of the axial stress and radial stress versus displacement can be generated using the matlab script avicelTabletingPlotStresses.m. The script will work even while the simulation is in the middle of running and is a good way to check on the status of the simulation. - -The other input script in the folder is in.avicelTableting20000 this 20,000 particle simulation is the exact one presented in Zunker et al., 2024 and is most efficiently run in parallel with the following command: - - mpirun --np 4 (path to lmp executable) -in in.avicelTableting20000 - -Anticipate this simulation to take longer to run, on a 2021 M1 Max running in parallel on 4 processors the simulation took 28 hours to complete. - -Also within the sims directory is the MPFEM folder, which contains two small simulations involving the compaction of 14 monodisperse particles and 12 tridisperse particles as described in Zunker et al., 2024. The input files for these simulations can then be run using the following commands: - - (path to lmp executable) < in.triaxial14particles - (path to lmp executable) < in.triaxial12particles - -The outputs of each of these simulations are a dump file and a .csv containing the measured forces in each principal direction. To visualize the measured stresses you can run the Matlab script macro_stresses.m. This will plot stresses for both the LAMMPS results and data from corresponding FEM simulations. The Abaqus 2022 input files for the monodisperse and tridisperse FEM are included in the folder as MPFEM.inp and MPFEM_diff_radii.inp, respectively. For convenience, the principal stress output data for these FEM simulations is already included in the folder as fem.mat and fem_diff_radii.mat. \ No newline at end of file diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index 40397b142d..d6a84a7c6b 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -246,7 +246,7 @@ void FixGranularMDR::pre_force(int) comm->forward_comm(this, 5); - // rezero temporary variables for all atoms, no need to communicate + // rezero temporary variables for all atoms, no need to communicate for (int i = 0; i < ntotal; i++) { ddelta_bar[i] = 0.0; if (!update->setupflag) { From b2e35f180841781f692b4c423d18a671e91c3f37 Mon Sep 17 00:00:00 2001 From: William Zunker Date: Tue, 14 Jan 2025 13:18:43 -0500 Subject: [PATCH 55/74] Doc spell check --- doc/src/pair_granular.rst | 25 ++++++++++++------------- 1 file changed, 12 insertions(+), 13 deletions(-) diff --git a/doc/src/pair_granular.rst b/doc/src/pair_granular.rst index c5efe2f5f4..5fb063f1c3 100644 --- a/doc/src/pair_granular.rst +++ b/doc/src/pair_granular.rst @@ -179,7 +179,7 @@ The model requires the following inputs: 1. *Young's modulus* :math:`E > 0` : The Young's modulus is commonly reported for various powders. - 2. *Poissons ratio* :math:`0 \le \nu \le 0.5` : The Poisson's ratio is commonly + 2. *Poisson's ratio* :math:`0 \le \nu \le 0.5` : The Poisson's ratio is commonly reported for various powders. 3. *Yield stress* :math:`Y \ge 0` : The yield stress is often known for powders @@ -191,12 +191,12 @@ The model requires the following inputs: relation to the more commonly reported critical stress intensity factor :math:`K_{Ic} = \sqrt{2\Delta\gamma E/(1-\nu^2)}`. - 5. *Critical confinement ratio* :math:`0 \le \psi_b \le 1` : The critical confinment + 5. *Critical confinement ratio* :math:`0 \le \psi_b \le 1` : The critical confinement ratio is a tunable parameter that determines when the bulk elastic response is triggered. Lower values of :math:`\psi_b` delay the onset of the bulk elastic response. - 6. *Coefficient of restiution* :math:`0 \le e \le 1` : The coefficient of + 6. *Coefficient of restitution* :math:`0 \le e \le 1` : The coefficient of restitution is a tunable parameter that controls damping in the normal direction. .. note:: @@ -229,11 +229,11 @@ begin with an initial radius, however as compaction occurs and plastic deformation is accumulated, a new enlarged apparent radius is defined to ensure that that volume change due to plastic deformation is not lost. This apparent radius is stored as the *atom radius* meaning it is used -for subsequent neighbor list builds and contact dectection checks. The +for subsequent neighbor list builds and contact detection checks. The advantage of this is that multi-neighbor dependent effects such as formation of secondary contacts caused by radial expansion are captured by the *mdr* model. Setting *atom_style sphere 1* ensures that updates to -the particle radius are properly reflected throughout the simulation. +the particle radii are properly reflected throughout the simulation. .. code-block:: LAMMPS @@ -242,7 +242,7 @@ the particle radius are properly reflected throughout the simulation. Newton's third law must be set to *off*. This ensures that the neighbor lists are constructed properly for the topological penalty algorithm used to screen for non-physical contacts occurring through obstructing particles, an issue -prevelant under large deformation conditions. For more information on this +prevalent under large deformation conditions. For more information on this algorithm see :ref:`Zunker et al. `. .. code-block:: LAMMPS @@ -258,7 +258,7 @@ in damping model. The definition of multiple *mdr* models in the *pair_style* is currently not supported. Similarly, the *mdr* model cannot be combined with a different normal -model in the *pair_style*. Phyiscally this means that only one homogenous +model in the *pair_style*. Physically this means that only one homogenous collection of particles governed by a single *mdr* model is allowed. The *mdr* model currently only supports *fix wall/gran/region*, not @@ -279,9 +279,8 @@ adhesive behaviors between particle-particle and particle-wall interactions. In addition to contact forces the *mdr* model also tracks the following quantities for each particle: elastic volume change, the average normal stress components for each particle, and total surface area involved in -contact. In the input script these quantities can be accessed by first -calling *run 0* to initialize the values then through subsequent -*compute* commands. +contact. In the input script, these quantities are initialized by calling +*run 0* and can then be accessed using subsequent *compute* commands. .. code-block:: LAMMPS @@ -1003,20 +1002,20 @@ solids. Proc. R. Soc. Lond. A, 324(1558), 301-313. .. _DMT1975: -**Derjaguin et al, 1975)** Derjaguin, B. V., Muller, V. M., & Toporov, +**(Derjaguin et al, 1975)** Derjaguin, B. V., Muller, V. M., & Toporov, Y. P. (1975). Effect of contact deformations on the adhesion of particles. Journal of Colloid and interface science, 53(2), 314-326. .. _Zunker2024I: -**(Zunker et al, 2024)** Zunker, W., & Kamrin, K. (2024). +**(Zunker and Kamrin, 2024)** Zunker, W., & Kamrin, K. (2024). A mechanically-derived contact model for adhesive elastic-perfectly plastic particles, Part I: Utilizing the method of dimensionality reduction. Journal of the Mechanics and Physics of Solids, 183, 105492. .. _Zunker2024II: -**(Zunker et al, 2024)** Zunker, W., & Kamrin, K. (2024). +**(Zunker and Kamrin, 2024)** Zunker, W., & Kamrin, K. (2024). A mechanically-derived contact model for adhesive elastic-perfectly plastic particles, Part II: Contact under high compaction—modeling a bulk elastic response. Journal of the Mechanics and Physics of Solids, From b7c02d6a03be5e55b7760d2bd14ae6c925f563e3 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Tue, 14 Jan 2025 13:49:56 -0700 Subject: [PATCH 56/74] Starting to break down MDR equations --- src/GRANULAR/gran_sub_mod_normal.cpp | 104 +++++++++++++++++---------- src/GRANULAR/gran_sub_mod_normal.h | 2 + 2 files changed, 70 insertions(+), 36 deletions(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 11a084512e..859c0d25eb 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -30,12 +30,15 @@ using namespace LAMMPS_NS; using namespace Granular_NS; using namespace MathConst; -static constexpr double PI27SQ = 266.47931882941264802866; // 27*PI**2 +static constexpr double PISQ = MY_PI * MY_PI; +static constexpr double PI27SQ = 27 * PISQ; +static constexpr double PITOFIVETHIRDS = pow(MY_PI, 5.0 / 3.0); +static constexpr double CBRT2 = cbrt(2.0); +static constexpr double CBRTHALFPI = cbrt(MY_PI * 0.5); static constexpr double THREEROOT3 = 5.19615242270663202362; // 3*sqrt(3) static constexpr double SIXROOT6 = 14.69693845669906728801; // 6*sqrt(6) static constexpr double INVROOT6 = 0.40824829046386307274; // 1/sqrt(6) -static constexpr double FOURTHIRDS = (4.0 / 3.0); // 4/3 -static constexpr double FIVETHIRDS = (5.0 / 3.0); // 5/3 +static constexpr double FOURTHIRDS = 4.0 / 3.0; static constexpr double JKRPREFIX = 1.2277228507842888; // cbrt(3*PI**2/16) static constexpr int MDR_MAX_IT = 100; // Newton-Raphson for MDR static constexpr double MDR_EPSILON1 = 1e-10; // Newton-Raphson for MDR @@ -459,6 +462,16 @@ void GranSubModNormalMDR::coeffs_to_local() G = E / (2.0 * (1.0 + nu)); // shear modulus kappa = E / (3.0 * (1.0 - 2.0 * nu)); // bulk modulus Eeff = E / (1.0 - pow(nu, 2.0)); // composite plane strain modulus + + // precomputing factors + + Eeffinv = 1.0 / Eeff; + Eeffsq = Eeff * Eeff; + Eeffsqinv = Eeffinv * Eeffinv; + + gammasq = gamma * gamma; + gamma3 = gammasq * gamma; + gamma4 = gammasq * gammasq; } /* ---------------------------------------------------------------------- */ @@ -677,15 +690,19 @@ double GranSubModNormalMDR::calculate_forces() amax = sqrt(deltamax_MDR * R); } else { // plastic contact amax = sqrt((2.0 * deltamax_MDR * R - pow(deltamax_MDR, 2)) + cA / MY_PI); - amaxsq = amax * amax; // TODO later, breaks BFB - A = 4.0 * pY / Eeff * amax; - Ainv = 1.0 / A; // TODO later, breaks BFB + amaxsq = amax * amax; + A = 4.0 * pY * Eeffinv * amax; + Ainv = 1.0 / A; B = 2.0 * amax; const double deltae1Dmax = A * 0.5; // maximum transformed elastic displacement - const double Fmax = Eeff * (A * B * 0.25) * acos(1.0 - 2.0 * deltae1Dmax / A) - (1.0 - 2.0 * deltae1Dmax / A) * sqrt(4.0 * deltae1Dmax / A - 4.0 * pow(deltae1Dmax, 2) / pow(A, 2)); // force caused by full submersion of elliptical indenter to depth of A/2 + double Fmax = Eeff * (A * B * 0.25) * acos(1.0 - 2.0 * deltae1Dmax * Ainv); + + // force caused by full submersion of elliptical indenter to depth of A/2 + Fmax -= (1.0 - 2.0 * deltae1Dmax * Ainv) * sqrt(4.0 * deltae1Dmax * Ainv - 4.0 * pow(deltae1Dmax, 2) * pow(Ainv, 2)); + const double zR = R - (deltamax_MDR - deltae1Dmax); // depth of particle center - deltaR = (Fmax * (2 * pow(amax, 2) * (-1 + nu) - (-1 + 2 * nu) * zR * (-zR + sqrt(pow(amax, 2) + pow(zR, 2))))); - deltaR /= (MY_PI * pow(amax, 2) * 2 * G * sqrt(pow(amax, 2) + pow(zR, 2))); + deltaR = (Fmax * (2 * amaxsq * (-1 + nu) - (-1 + 2 * nu) * zR * (-zR + sqrt(amaxsq + pow(zR, 2))))); + deltaR /= (MY_PI * amaxsq * 2 * G * sqrt(amaxsq + pow(zR, 2))); deltae1D = (delta_MDR - deltamax_MDR + deltae1Dmax + deltaR) / (1 + deltaR / deltae1Dmax); // transformed elastic displacement // added for rigid flat placement @@ -694,11 +711,20 @@ double GranSubModNormalMDR::calculate_forces() double a_na; double a_fac = 0.99; - (deltae1D >= 0.0) ? a_na = B * sqrt(A - deltae1D) * sqrt(deltae1D) / A : a_na = 0.0; + (deltae1D >= 0.0) ? a_na = B * sqrt(A - deltae1D) * sqrt(deltae1D) * Ainv : a_na = 0.0; double aAdh = *aAdh_offset; if (aAdh > a_fac * amax) aAdh = a_fac * amax; - if ( gamma > 0.0 ) { // adhesive contact + double Ainvsq = Ainv * Ainv; + double Asq = A * A; + double A3 = Asq * A; + double A4 = Asq * Asq; + + double Binv = 1.0 / B; + double Bsq = B * B; + double B4 = Bsq * Bsq; + + if (gamma > 0.0) { // adhesive contact double g_aAdh; if (delta_MDR == deltamax_MDR || a_na >= aAdh) { // case 1: no tensile springs, purely compressive contact @@ -706,24 +732,29 @@ double GranSubModNormalMDR::calculate_forces() F_MDR = 0.0; } else { F_MDR = Eeff * (A * B * 0.25); - F_MDR *= acos(1.0 - 2.0 * deltae1D / A) - (1.0 - 2.0 * deltae1D / A) * sqrt(4.0 * deltae1D / A - 4.0 * pow(deltae1D, 2) / pow(A, 2)); + F_MDR *= acos(1.0 - 2.0 * deltae1D * Ainv) - (1.0 - 2.0 * deltae1D * Ainv) * sqrt(4.0 * deltae1D * Ainv - 4.0 * pow(deltae1D, 2) * Ainvsq); } if (std::isnan(F_MDR)) { error->one(FLERR, "F_MDR is NaN, case 1: no tensile springs"); } if (update) *aAdh_offset = a_fac * a_na; } else { - const double lmax = sqrt(2.0 * MY_PI * aAdh * gamma / Eeff); - g_aAdh = A * 0.5 - A / B * sqrt(pow(B, 2.0) * 0.25 - pow(aAdh, 2)); - const double acrit = (-((pow(B, 2) * gamma * MY_PI) / (pow(A, 2) * Eeff)) + (pow(2, THIRD) * pow(B, 4) * pow(gamma, 2) * pow(MY_PI, FIVETHIRDS)) / - (pow(A, 2) * pow(Eeff, 2) * pow((27 * pow(A, 4) * pow(B, 4) * gamma) / Eeff - (2 * pow(B, 6) * pow(gamma, 3) * pow(MY_PI, 2)) / pow(Eeff, 3) + (3 * sqrt(3) * sqrt(27 * pow(A, 8) * pow(B, 8) * pow(Eeff, 2) * pow(gamma, 2) - - 4 * pow(A, 4) * pow(B, 10) * pow(gamma, 4) * pow(MY_PI, 2))) / pow(Eeff, 2), THIRD)) + (pow(MY_PI * 0.5, THIRD) * pow((27 * pow(A, 4) * pow(B, 4) * gamma) / Eeff - - (2 * pow(B, 6) * pow(gamma, 3) * pow(MY_PI, 2)) / pow(Eeff, 3) + (3 * sqrt(3) * sqrt(27 * pow(A, 8) * pow(B, 8) * pow(Eeff, 2) * pow(gamma, 2) - 4 * pow(A, 4) * pow(B, 10) * pow(gamma, 4) * pow(MY_PI, 2))) / - pow(Eeff, 2), THIRD)) / pow(A, 2)) / 6; + const double lmax = sqrt(2.0 * MY_PI * aAdh * gamma * Eeffinv); + g_aAdh = A * 0.5 - A * Binv * sqrt(Bsq * 0.25 - pow(aAdh, 2)); + + double tmp = 27 * A4 * B4 * gamma * Eeffinv; + tmp -= 2 * pow(B, 6) * gamma3 * PISQ * pow(Eeffinv, 3); + tmp += (3 * sqrt(3) * sqrt(27 * pow(A, 8) * pow(B, 8) * Eeffsq * gammasq - 4 * A4 * pow(B, 10) * gamma4 * PISQ)) * Eeffsqinv; + tmp = cbrt(tmp); + + double acrit = -Bsq * gamma * MY_PI * Ainvsq * Eeffinv; + acrit += CBRT2 * B4 * gammasq * PITOFIVETHIRDS / (Asq * Eeffsq * tmp); + acrit += CBRTHALFPI * tmp * Ainvsq; + acrit /= 6; if ( (deltae1D + lmax - g_aAdh) >= 0.0) { // case 2: tensile springs, but not exceeding critical length --> deltae + lmax - g(aAdhes) >= 0 const double deltaeAdh = g_aAdh; - const double F_na = Eeff * (A * B * 0.25) * (acos(1.0 - 2.0 * deltaeAdh / A) - (1.0 - 2.0 * deltaeAdh / A) * sqrt(4.0 * deltaeAdh / A - 4.0 * pow(deltaeAdh, 2) / pow(A, 2))); + const double F_na = Eeff * (A * B * 0.25) * (acos(1.0 - 2.0 * deltaeAdh * Ainv) - (1.0 - 2.0 * deltaeAdh * Ainv) * 2.0 * sqrt(deltaeAdh * Ainv - pow(deltaeAdh, 2) * Ainvsq)); const double F_Adhes = 2.0 * Eeff * (deltae1D - deltaeAdh) * aAdh; F_MDR = F_na + F_Adhes; if (std::isnan(F_MDR)) error->one(FLERR, "F_MDR is NaN, case 2: tensile springs, but not exceeding critical length"); @@ -734,29 +765,30 @@ double GranSubModNormalMDR::calculate_forces() } else { // newton-raphson to find aAdh double aAdh_tmp = aAdh; - double fa; - double fa2; - double dfda; + double fa, fa2, fa_tmp, dfda; for (int lv1 = 0; lv1 < MDR_MAX_IT; ++lv1) { - fa = deltae1D + sqrt(2.0 * MY_PI * aAdh_tmp * gamma / Eeff) - (A * 0.5 - A / B * sqrt(pow(B, 2) * 0.25 - pow(aAdh_tmp, 2))); + fa_tmp = deltae1D - A * 0.5 - A * sqrt(Bsq * 0.25 - pow(aAdh_tmp, 2)) * Binv; + fa = fa_tmp + sqrt(MY_2PI * aAdh_tmp * gamma * Eeffinv); if (abs(fa) < MDR_EPSILON1) { break; } - dfda = -((aAdh_tmp * A) / (B * sqrt(-pow(aAdh_tmp, 2) + pow(B, 2) * 0.25))) + (gamma * sqrt(MY_PI * 0.5)) / (Eeff * sqrt((aAdh_tmp * gamma) / Eeff)); + dfda = -aAdh_tmp * A / (B * sqrt(-pow(aAdh_tmp, 2) + Bsq * 0.25)); + dfda += gamma * sqrt(MY_PI * 0.5) / sqrt(aAdh_tmp * gamma * Eeff); aAdh_tmp = aAdh_tmp - fa / dfda; - fa2 = deltae1D + sqrt(2.0 * MY_PI * aAdh_tmp * gamma / Eeff) - (A * 0.5 - A / B * sqrt(pow(B, 2) * 0.25 - pow(aAdh_tmp, 2))); + fa2 = fa_tmp + sqrt(MY_2PI * aAdh_tmp * gamma * Eeffinv); if (abs(fa - fa2) < MDR_EPSILON2) { break; } - if (lv1 == MDR_MAX_IT - 1){ + if (lv1 == MDR_MAX_IT - 1) { aAdh_tmp = 0.0; } } aAdh = aAdh_tmp; - g_aAdh = A * 0.5 - A / B * sqrt(pow(B, 2) * 0.25 - pow(aAdh, 2)); + g_aAdh = A * 0.5 - A * Binv * sqrt(Bsq * 0.25 - pow(aAdh, 2)); const double deltaeAdh = g_aAdh; - const double F_na = Eeff * (A * B * 0.25) * (acos(1.0 - 2.0 * deltaeAdh / A) - (1.0 - 2.0 * deltaeAdh / A) * sqrt(4.0 * deltaeAdh / A - 4.0 * pow(deltaeAdh, 2) / pow(A, 2))); + double F_na = acos(1.0 - 2.0 * deltaeAdh * Ainv) - (1.0 - 2.0 * deltaeAdh * Ainv) * 2.0 * sqrt(deltaeAdh * Ainv - pow(deltaeAdh, 2) * Ainvsq); + F_na *= 0.25 * Eeff * A * B; const double F_Adhes = 2.0 * Eeff * (deltae1D - deltaeAdh) * aAdh; F_MDR = F_na + F_Adhes; if (std::isnan(F_MDR)) error->one(FLERR, "F_MDR is NaN, case 3: tensile springs exceed critical length"); @@ -766,7 +798,7 @@ double GranSubModNormalMDR::calculate_forces() } } else { // non-adhesive contact if (update) *aAdh_offset = a_na; - (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff * (A * B * 0.25) * (acos(1.0 - 2.0 * deltae1D / A) - (1.0 - 2.0 * deltae1D / A) * sqrt(4.0 * deltae1D / A - 4.0 * pow(deltae1D, 2) / pow(A, 2))); + (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff * (A * B * 0.25) * (acos(1.0 - 2.0 * deltae1D * Ainv) - (1.0 - 2.0 * deltae1D * Ainv) * 2.0 * sqrt(deltae1D * Ainv - pow(deltae1D, 2) * Ainvsq)); if (std::isnan(F_MDR)) { error->one(FLERR, "F_MDR is NaN, non-adhesive case"); } @@ -779,7 +811,7 @@ double GranSubModNormalMDR::calculate_forces() // area related calculations double Ac; - (*Yflag_offset == 0.0) ? Ac = MY_PI * delta * R : Ac = MY_PI * ((2.0 * delta * R - pow(delta, 2)) + cA / MY_PI); + (*Yflag_offset == 0.0) ? Ac = MY_PI * delta * R : Ac = MY_PI * (2.0 * delta * R - pow(delta, 2)) + cA; if (Ac < 0.0) Ac = 0.0; if (update) { Atot_sum[i] += wij * (Ac - 2.0 * MY_PI * R * (deltamax_MDR + delta_BULK)); @@ -844,17 +876,17 @@ double GranSubModNormalMDR::calculate_forces() // calculate damping force if (F > 0.0) { - double Eeff; + double Eeff2; double Reff; if (gm->contact_type == PAIR) { - Eeff = E / (2.0 * (1.0 - pow(nu, 2))); + Eeff2 = E / (2.0 * (1.0 - pow(nu, 2))); Reff = pow((1 / gm->radi + 1 / gm->radj), -1); } else { - Eeff = E / (1.0 - pow(nu, 2)); + Eeff2 = E / (1.0 - pow(nu, 2)); Reff = gm->radi; } - const double kn = Eeff * Reff; - const double beta = -log(CoR) / sqrt(pow(log(CoR), 2) + MY_PI * MY_PI); + const double kn = Eeff2 * Reff; + const double beta = -log(CoR) / sqrt(pow(log(CoR), 2) + PISQ); const double damp_prefactor = beta * sqrt(gm->meff * kn); const double F_DAMP = -damp_prefactor * gm->vnnr; diff --git a/src/GRANULAR/gran_sub_mod_normal.h b/src/GRANULAR/gran_sub_mod_normal.h index 7e9aed5d0f..fdc00be0ba 100644 --- a/src/GRANULAR/gran_sub_mod_normal.h +++ b/src/GRANULAR/gran_sub_mod_normal.h @@ -147,6 +147,8 @@ namespace Granular_NS { protected: double G, kappa, Eeff; // derived coeffs + double Eeffsq, Eeffinv, Eeffsqinv; + double gammasq, gamma3, gamma4; int index_Ro, index_Vgeo, index_Velas, index_Vcaps, index_eps_bar, index_dRnumerator; int index_dRdenominator, index_Acon0, index_Acon1, index_Atot, index_Atot_sum, index_ddelta_bar; From 4611b84b6fed8c10543f678a8c10fd071203ad19 Mon Sep 17 00:00:00 2001 From: William Zunker Date: Tue, 14 Jan 2025 16:20:37 -0500 Subject: [PATCH 57/74] Filled in mdr cite command --- src/GRANULAR/gran_sub_mod_normal.cpp | 33 +++++++++++++++++++++------- 1 file changed, 25 insertions(+), 8 deletions(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 859c0d25eb..06e24a65e2 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -46,14 +46,31 @@ static constexpr double MDR_EPSILON2 = 1e-16; // Newton-Raphso static constexpr double MDR_OVERLAP_LIMIT = 0.75; // Maximum contact overlap for MDR static const char cite_mdr[] = - "MDR contact model command: \n\n" - "@Article\n" - " author = \n" - " title = \n" - " journal = ,\n" - " year = ,\n" - " volume = ,\n" - " pages = \n" + "MDR contact model command: (i) https://doi.org/10.1016/j.jmps.2023.105492 || (ii) https://doi.org/10.1016/j.jmps.2023.105493 || (iii) https://doi.org/10.31224/4289\n\n" + "@Article{zunker2024mechanicallyI,\n" + " author = {Zunker, William and Kamrin, Ken},\n" + " title = {A mechanically-derived contact model for adhesive elastic-perfectly plastic particles,\n" + " Part I: Utilizing the method of dimensionality reduction},\n" + " journal = {Journal of the Mechanics and Physics of Solids},\n" + " year = {2024},\n" + " volume = {183},\n" + " pages = {105492},\n" + "}\n\n" + "@Article{zunker2024mechanicallyII,\n" + " author = {Zunker, William and Kamrin, Ken},\n" + " title = {A mechanically-derived contact model for adhesive elastic-perfectly plastic particles,\n" + " Part II: Contact under high compaction—modeling a bulk elastic response},\n" + " journal = {Journal of the Mechanics and Physics of Solids},\n" + " year = {2024},\n" + " volume = {183},\n" + " pages = {105493},\n" + "}\n\n" + "@Article{zunker2025experimentally,\n" + " author = {Zunker, William and Dunatunga, Sachith and Thakur, Subhash and Tang, Pingjun and Kamrin, Ken},\n" + " title = {Experimentally validated DEM for large deformation powder compaction:\n" + " mechanically-derived contact model and screening of non-physical contacts},\n" + " year = {2025},\n" + " journal = {engrXiv},\n" "}\n\n"; /* ---------------------------------------------------------------------- From 028367804ee980e48520de0663a3924154a55b81 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Tue, 14 Jan 2025 16:08:29 -0700 Subject: [PATCH 58/74] Finshed condensing equations --- src/GRANULAR/gran_sub_mod_normal.cpp | 178 +++++++++++++++++---------- src/GRANULAR/gran_sub_mod_normal.h | 2 + 2 files changed, 117 insertions(+), 63 deletions(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 06e24a65e2..6cd669ff4b 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -31,14 +31,16 @@ using namespace Granular_NS; using namespace MathConst; static constexpr double PISQ = MY_PI * MY_PI; +static constexpr double PIINV = 1.0 / MY_PI; static constexpr double PI27SQ = 27 * PISQ; static constexpr double PITOFIVETHIRDS = pow(MY_PI, 5.0 / 3.0); static constexpr double CBRT2 = cbrt(2.0); +static constexpr double SQRTHALFPI = sqrt(MY_PI * 0.5); static constexpr double CBRTHALFPI = cbrt(MY_PI * 0.5); +static constexpr double FOURTHIRDS = 4.0 / 3.0; static constexpr double THREEROOT3 = 5.19615242270663202362; // 3*sqrt(3) static constexpr double SIXROOT6 = 14.69693845669906728801; // 6*sqrt(6) static constexpr double INVROOT6 = 0.40824829046386307274; // 1/sqrt(6) -static constexpr double FOURTHIRDS = 4.0 / 3.0; static constexpr double JKRPREFIX = 1.2277228507842888; // cbrt(3*PI**2/16) static constexpr int MDR_MAX_IT = 100; // Newton-Raphson for MDR static constexpr double MDR_EPSILON1 = 1e-10; // Newton-Raphson for MDR @@ -593,10 +595,11 @@ double GranSubModNormalMDR::calculate_forces() double *deltamax_MDR_offset, *Yflag_offset, *deltaY_offset, *cA_offset, *aAdh_offset; double *Ac_offset, *eps_bar_offset, *penalty_offset, *deltap_offset; - if (gm->contact_type == PAIR) { // displacement partitioning only necessary for particle-particle contact + if (gm->contact_type == PAIR) { + // displacement partitioning only necessary for particle-particle contact - // itag and jtag are persistent even after neighbor list builds, comparison based on tags helps match - // contact history variables consistently across steps for particle pair. + // itag and jtag persist after neighbor list builds, use tags to compare to match + // contact history variables consistently across steps for particle pair. if ((contactSide == 0 && itag_true > jtag_true) || (contactSide != 0 && itag_true < jtag_true)) { gm->i = i_true; gm->j = j_true; @@ -611,12 +614,18 @@ double GranSubModNormalMDR::calculate_forces() // determine the two maximum experienced geometric overlaps on either side of rigid flat double delta_geo, delta_geo_alt; - double delta_geoOpt1 = deltamax * (deltamax - 2.0 * gm->radj) / (2.0 * (deltamax - gm->radi - gm->radj)); - double delta_geoOpt2 = deltamax * (deltamax - 2.0 * gm->radi) / (2.0 * (deltamax - gm->radi - gm->radj)); - (gm->radi < gm->radj) ? delta_geo = MAX(delta_geoOpt1, delta_geoOpt2) : delta_geo = MIN(delta_geoOpt1, delta_geoOpt2); - (gm->radi > gm->radj) ? delta_geo_alt = MAX(delta_geoOpt1, delta_geoOpt2) : delta_geo_alt = MIN(delta_geoOpt1,delta_geoOpt2); + double denom = 1.0 / (2.0 * (deltamax - gm->radi - gm->radj)); + double delta_geoOpt1 = deltamax * (deltamax - 2.0 * gm->radj) * denom; + double delta_geoOpt2 = deltamax * (deltamax - 2.0 * gm->radi) * denom; + if (gm->radi < gm->radj) { + delta_geo = MAX(delta_geoOpt1, delta_geoOpt2); + delta_geo_alt = MIN(delta_geoOpt1,delta_geoOpt2); + } else { + delta_geo = MIN(delta_geoOpt1, delta_geoOpt2); + delta_geo_alt = MAX(delta_geoOpt1, delta_geoOpt2); + } - // cap displacement if it exceeds the overlap limit and parition the remaining to the other side + // cap displacement if exceeds the overlap limit, parition the remaining to the other side if (delta_geo / gm->radi > MDR_OVERLAP_LIMIT) { delta_geo = gm->radi * MDR_OVERLAP_LIMIT; } else if (delta_geo_alt / gm->radj > MDR_OVERLAP_LIMIT) { @@ -626,9 +635,9 @@ double GranSubModNormalMDR::calculate_forces() // determine final delta used for subsequent calculations double deltap = deltap0 + deltap1; if (contactSide == 0) { - delta = delta_geo + (deltap0 - delta_geo) / (deltap - deltamax) * (gm->delta - deltamax); + delta = delta_geo + (deltap0 - delta_geo) * (gm->delta - deltamax) / (deltap - deltamax); } else { - delta = delta_geo + (deltap1 - delta_geo) / (deltap - deltamax) * (gm->delta - deltamax); + delta = delta_geo + (deltap1 - delta_geo) * (gm->delta - deltamax) / (deltap - deltamax); } } else if (gm->contact_type != PAIR && contactSide != 0) { // contact with particle-wall requires only one evaluation @@ -665,22 +674,28 @@ double GranSubModNormalMDR::calculate_forces() if (update) *deltao_offset = deltao; double ddelta_MDR, ddelta_BULK; - if (psi[i] < psi_b) { // if true, bulk response has triggered, split displacement increment between the MDR and BULK components + if (psi[i] < psi_b) { + // bulk response triggered, split displacement increment between MDR and BULK components ddelta_MDR = MIN(ddelta - ddelta_bar[i], delta - *delta_MDR_offset); ddelta_BULK = ddelta_bar[i]; - } else { // if false, no bulk response, full displacement increment goes to the MDR component + } else { + // no bulk response, full displacement increment goes to the MDR component ddelta_BULK = 0.0; ddelta_MDR = ddelta; } - const double delta_MDR = *delta_MDR_offset + ddelta_MDR; // MDR displacement - if (update) *delta_MDR_offset = delta_MDR; // update old MDR displacement - const double delta_BULK = MAX(0.0, *delta_BULK_offset + ddelta_BULK); // bulk displacement - if (update) *delta_BULK_offset = delta_BULK; // update old bulk displacement + + // calculate and update MDR/BULK displacements + const double delta_MDR = *delta_MDR_offset + ddelta_MDR; + if (update) *delta_MDR_offset = delta_MDR; + const double delta_BULK = MAX(0.0, *delta_BULK_offset + ddelta_BULK); + if (update) *delta_BULK_offset = delta_BULK; if (update && delta_MDR > *deltamax_MDR_offset) *deltamax_MDR_offset = delta_MDR; const double deltamax_MDR = *deltamax_MDR_offset; - const double pY = Y * (1.75 * exp(-4.4 * deltamax_MDR / R) + 1.0); // Set value of average pressure along yield surface + // average pressure along yield surface + const double pY = Y * (1.75 * exp(-4.4 * deltamax_MDR / R) + 1.0); + if (*Yflag_offset == 0.0 && delta_MDR >= deltamax_MDR) { const double phertz = 4 * Eeff * sqrt(delta_MDR) / (3 * MY_PI * sqrt(R)); if (update && phertz > pY) { @@ -699,28 +714,36 @@ double GranSubModNormalMDR::calculate_forces() double amax, amaxsq; // maximum experienced contact radius const double cA = *cA_offset; // contact area intercept - if (*Yflag_offset == 0.0) { // elastic contact + if (*Yflag_offset == 0.0) { + // elastic contact A = 4.0 * R; Ainv = 1.0 / A; B = 2.0 * R; deltae1D = delta_MDR; amax = sqrt(deltamax_MDR * R); - } else { // plastic contact - amax = sqrt((2.0 * deltamax_MDR * R - pow(deltamax_MDR, 2)) + cA / MY_PI); + } else { + // plastic contact + amax = sqrt(2.0 * deltamax_MDR * R - pow(deltamax_MDR, 2) + cA * PIINV); amaxsq = amax * amax; A = 4.0 * pY * Eeffinv * amax; Ainv = 1.0 / A; B = 2.0 * amax; - const double deltae1Dmax = A * 0.5; // maximum transformed elastic displacement - double Fmax = Eeff * (A * B * 0.25) * acos(1.0 - 2.0 * deltae1Dmax * Ainv); + + // maximum transformed elastic displacement + const double deltae1Dmax = A * 0.5; // force caused by full submersion of elliptical indenter to depth of A/2 - Fmax -= (1.0 - 2.0 * deltae1Dmax * Ainv) * sqrt(4.0 * deltae1Dmax * Ainv - 4.0 * pow(deltae1Dmax, 2) * pow(Ainv, 2)); + double Fmax = Eeff * (A * B * 0.25) * acos(1 - 2 * deltae1Dmax * Ainv); + Fmax -= (2 - 4 * deltae1Dmax * Ainv) * sqrt(deltae1Dmax * Ainv - pow(deltae1Dmax * Ainv, 2)); - const double zR = R - (deltamax_MDR - deltae1Dmax); // depth of particle center - deltaR = (Fmax * (2 * amaxsq * (-1 + nu) - (-1 + 2 * nu) * zR * (-zR + sqrt(amaxsq + pow(zR, 2))))); - deltaR /= (MY_PI * amaxsq * 2 * G * sqrt(amaxsq + pow(zR, 2))); - deltae1D = (delta_MDR - deltamax_MDR + deltae1Dmax + deltaR) / (1 + deltaR / deltae1Dmax); // transformed elastic displacement + // depth of particle center + const double zR = R - (deltamax_MDR - deltae1Dmax); + + deltaR = 2 * amaxsq * (-1 + nu) - (-1 + 2 * nu) * zR * (-zR + sqrt(amaxsq + pow(zR, 2))); + deltaR *= Fmax / (MY_2PI * amaxsq * G * sqrt(amaxsq + pow(zR, 2))); + + // transformed elastic displacement + deltae1D = (delta_MDR - deltamax_MDR + deltae1Dmax + deltaR) / (1 + deltaR / deltae1Dmax); // added for rigid flat placement if (update) *deltap_offset = deltamax_MDR - (deltae1Dmax + deltaR); @@ -741,27 +764,45 @@ double GranSubModNormalMDR::calculate_forces() double Bsq = B * B; double B4 = Bsq * Bsq; - if (gamma > 0.0) { // adhesive contact + if (gamma <= 0.0) { + // non-adhesive contact + + if (deltae1D <= 0.0) { + F_MDR = 0.0; + } else { + F_MDR = calculate_nonadhesive_mdr_force(deltae1D, Ainv, Eeff, A, B); + } + + if (std::isnan(F_MDR)) { + error->one(FLERR, "F_MDR is NaN, non-adhesive case"); + } + + if (update) *aAdh_offset = a_na; + } else { + // adhesive contact double g_aAdh; - if (delta_MDR == deltamax_MDR || a_na >= aAdh) { // case 1: no tensile springs, purely compressive contact + if (delta_MDR == deltamax_MDR || a_na >= aAdh) { + // case 1: no tensile springs, purely compressive contact + if (deltae1D <= 0.0) { F_MDR = 0.0; } else { - F_MDR = Eeff * (A * B * 0.25); - F_MDR *= acos(1.0 - 2.0 * deltae1D * Ainv) - (1.0 - 2.0 * deltae1D * Ainv) * sqrt(4.0 * deltae1D * Ainv - 4.0 * pow(deltae1D, 2) * Ainvsq); + F_MDR = calculate_nonadhesive_mdr_force(deltae1D, Ainv, Eeff, A, B); } - if (std::isnan(F_MDR)) { + + if (std::isnan(F_MDR)) error->one(FLERR, "F_MDR is NaN, case 1: no tensile springs"); - } + if (update) *aAdh_offset = a_fac * a_na; } else { - const double lmax = sqrt(2.0 * MY_PI * aAdh * gamma * Eeffinv); + // case 2+3, tensile springs + const double lmax = sqrt(MY_2PI * aAdh * gamma * Eeffinv); g_aAdh = A * 0.5 - A * Binv * sqrt(Bsq * 0.25 - pow(aAdh, 2)); double tmp = 27 * A4 * B4 * gamma * Eeffinv; tmp -= 2 * pow(B, 6) * gamma3 * PISQ * pow(Eeffinv, 3); - tmp += (3 * sqrt(3) * sqrt(27 * pow(A, 8) * pow(B, 8) * Eeffsq * gammasq - 4 * A4 * pow(B, 10) * gamma4 * PISQ)) * Eeffsqinv; + tmp += sqrt(27) * Asq * B4 * sqrt(27 * A4 * Eeffsq * gammasq - 4 * Bsq * gamma4 * PISQ) * Eeffsqinv; tmp = cbrt(tmp); double acrit = -Bsq * gamma * MY_PI * Ainvsq * Eeffinv; @@ -769,14 +810,18 @@ double GranSubModNormalMDR::calculate_forces() acrit += CBRTHALFPI * tmp * Ainvsq; acrit /= 6; - if ( (deltae1D + lmax - g_aAdh) >= 0.0) { // case 2: tensile springs, but not exceeding critical length --> deltae + lmax - g(aAdhes) >= 0 + if ((deltae1D + lmax - g_aAdh) >= 0.0) { + // case 2: tensile springs do not exceed critical length --> deltae + lmax - g(aAdhes) >= 0 const double deltaeAdh = g_aAdh; - const double F_na = Eeff * (A * B * 0.25) * (acos(1.0 - 2.0 * deltaeAdh * Ainv) - (1.0 - 2.0 * deltaeAdh * Ainv) * 2.0 * sqrt(deltaeAdh * Ainv - pow(deltaeAdh, 2) * Ainvsq)); + const double F_na = calculate_nonadhesive_mdr_force(deltaeAdh, Ainv, Eeff, A, B); const double F_Adhes = 2.0 * Eeff * (deltae1D - deltaeAdh) * aAdh; F_MDR = F_na + F_Adhes; - if (std::isnan(F_MDR)) error->one(FLERR, "F_MDR is NaN, case 2: tensile springs, but not exceeding critical length"); - } else { // case 3: tensile springs exceed critical length --> deltae + lmax - g(aAdhes) = 0 - if ( aAdh < acrit ) { + if (std::isnan(F_MDR)) + error->one(FLERR, "F_MDR is NaN, case 2: tensile springs, but not exceeding critical length"); + } else { + // case 3: tensile springs exceed critical length --> deltae + lmax - g(aAdhes) = 0 + + if (aAdh < acrit) { aAdh = 0.0; F_MDR = 0.0; } else { @@ -790,7 +835,7 @@ double GranSubModNormalMDR::calculate_forces() break; } dfda = -aAdh_tmp * A / (B * sqrt(-pow(aAdh_tmp, 2) + Bsq * 0.25)); - dfda += gamma * sqrt(MY_PI * 0.5) / sqrt(aAdh_tmp * gamma * Eeff); + dfda += gamma * SQRTHALFPI / sqrt(aAdh_tmp * gamma * Eeff); aAdh_tmp = aAdh_tmp - fa / dfda; fa2 = fa_tmp + sqrt(MY_2PI * aAdh_tmp * gamma * Eeffinv); if (abs(fa - fa2) < MDR_EPSILON2) { @@ -804,21 +849,15 @@ double GranSubModNormalMDR::calculate_forces() g_aAdh = A * 0.5 - A * Binv * sqrt(Bsq * 0.25 - pow(aAdh, 2)); const double deltaeAdh = g_aAdh; - double F_na = acos(1.0 - 2.0 * deltaeAdh * Ainv) - (1.0 - 2.0 * deltaeAdh * Ainv) * 2.0 * sqrt(deltaeAdh * Ainv - pow(deltaeAdh, 2) * Ainvsq); - F_na *= 0.25 * Eeff * A * B; + const double F_na = calculate_nonadhesive_mdr_force(deltaeAdh, Ainv, Eeff, A, B); const double F_Adhes = 2.0 * Eeff * (deltae1D - deltaeAdh) * aAdh; F_MDR = F_na + F_Adhes; - if (std::isnan(F_MDR)) error->one(FLERR, "F_MDR is NaN, case 3: tensile springs exceed critical length"); + if (std::isnan(F_MDR)) + error->one(FLERR, "F_MDR is NaN, case 3: tensile springs exceed critical length"); } if (update) *aAdh_offset = aAdh; } } - } else { // non-adhesive contact - if (update) *aAdh_offset = a_na; - (deltae1D <= 0.0) ? F_MDR = 0.0 : F_MDR = Eeff * (A * B * 0.25) * (acos(1.0 - 2.0 * deltae1D * Ainv) - (1.0 - 2.0 * deltae1D * Ainv) * 2.0 * sqrt(deltae1D * Ainv - pow(deltae1D, 2) * Ainvsq)); - if (std::isnan(F_MDR)) { - error->one(FLERR, "F_MDR is NaN, non-adhesive case"); - } } // contact penalty scheme @@ -831,7 +870,7 @@ double GranSubModNormalMDR::calculate_forces() (*Yflag_offset == 0.0) ? Ac = MY_PI * delta * R : Ac = MY_PI * (2.0 * delta * R - pow(delta, 2)) + cA; if (Ac < 0.0) Ac = 0.0; if (update) { - Atot_sum[i] += wij * (Ac - 2.0 * MY_PI * R * (deltamax_MDR + delta_BULK)); + Atot_sum[i] += wij * (Ac - MY_2PI * R * (deltamax_MDR + delta_BULK)); Acon1[i] += wij * Ac; } @@ -847,7 +886,7 @@ double GranSubModNormalMDR::calculate_forces() *Ac_offset = wij * Ac; // radius update scheme quantity calculation - Vcaps[i] += (MY_PI * THIRD) * pow(delta, 2) * (3.0 * R - delta); + Vcaps[i] += MY_PI * THIRD * pow(delta, 2) * (3.0 * R - delta); } const double Fntmp = wij * (F_MDR + F_BULK); @@ -857,21 +896,22 @@ double GranSubModNormalMDR::calculate_forces() const double bx = -(Ro - deltao) * gm->nx[0]; const double by = -(Ro - deltao) * gm->nx[1]; const double bz = -(Ro - deltao) * gm->nx[2]; - const double eps_bar_contact = (1.0 / (3 * kappa * Velas[i])) * (fx * bx + fy * by + fz * bz); + const double eps_bar_contact = (fx * bx + fy * by + fz * bz) / (3 * kappa * Velas[i]); if (update) eps_bar[i] += eps_bar_contact; double desp_bar_contact = eps_bar_contact - *eps_bar_offset; if (update && delta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0) { - const double Vo = (4.0 * THIRD) * MY_PI * pow(Ro, 3); - dRnumerator[i] += -Vo * (eps_bar_contact - *eps_bar_offset) - wij * MY_PI * ddeltao * (2.0 * deltao * Ro - pow(deltao, 2) + pow(R, 2) - pow(Ro, 2)); + const double Vo = FOURTHIRDS * MY_PI * pow(Ro, 3); + dRnumerator[i] -= Vo * (eps_bar_contact - *eps_bar_offset); + dRnumerator[i] -= wij * MY_PI * ddeltao * (2 * deltao * Ro - pow(deltao, 2) + pow(R, 2) - pow(Ro, 2)); dRdenominator[i] += wij * 2.0 * MY_PI * R * (deltao + R - Ro); } if (update) { *eps_bar_offset = eps_bar_contact; - sigmaxx[i] += (1.0 / Velas[i]) * (fx * bx); - sigmayy[i] += (1.0 / Velas[i]) * (fy * by); - sigmazz[i] += (1.0 / Velas[i]) * (fz * bz); + sigmaxx[i] += fx * bx / Velas[i]; + sigmayy[i] += fy * by / Velas[i]; + sigmazz[i] += fz * bz / Velas[i]; } } @@ -894,15 +934,15 @@ double GranSubModNormalMDR::calculate_forces() // calculate damping force if (F > 0.0) { double Eeff2; - double Reff; + double Reff2; if (gm->contact_type == PAIR) { Eeff2 = E / (2.0 * (1.0 - pow(nu, 2))); - Reff = pow((1 / gm->radi + 1 / gm->radj), -1); + Reff2 = 1.0 / ((1.0 / gm->radi + 1.0 / gm->radj)); } else { Eeff2 = E / (1.0 - pow(nu, 2)); - Reff = gm->radi; + Reff2 = gm->radi; } - const double kn = Eeff2 * Reff; + const double kn = Eeff2 * Reff2; const double beta = -log(CoR) / sqrt(pow(log(CoR), 2) + PISQ); const double damp_prefactor = beta * sqrt(gm->meff * kn); const double F_DAMP = -damp_prefactor * gm->vnnr; @@ -912,3 +952,15 @@ double GranSubModNormalMDR::calculate_forces() return F; } + + +/* ---------------------------------------------------------------------- */ + +double GranSubModNormalMDR::calculate_nonadhesive_mdr_force(double delta, double Ainv, double Eeff, double A, double B) +{ + double F_na = acos(1.0 - 2.0 * delta * Ainv); + F_na -= (2 - 4 * delta * Ainv) * sqrt(delta * Ainv - pow(delta * Ainv, 2)); + F_na *= 0.25 * Eeff * A * B; + + return F_na; +} diff --git a/src/GRANULAR/gran_sub_mod_normal.h b/src/GRANULAR/gran_sub_mod_normal.h index fdc00be0ba..1dfcdb4b44 100644 --- a/src/GRANULAR/gran_sub_mod_normal.h +++ b/src/GRANULAR/gran_sub_mod_normal.h @@ -156,6 +156,8 @@ namespace Granular_NS { int fix_mdr_flag; char *id_fix; + + inline double calculate_nonadhesive_mdr_force(double, double, double, double, double); }; } // namespace Granular_NS From a5e3e755c21abac5774952fe25dadcd392ff05ca Mon Sep 17 00:00:00 2001 From: jtclemm Date: Wed, 15 Jan 2025 11:33:02 -0700 Subject: [PATCH 59/74] Adding safety checks for some variables --- src/GRANULAR/gran_sub_mod_normal.cpp | 18 ++++++++++++++++-- src/GRANULAR/gran_sub_mod_normal.h | 1 + 2 files changed, 17 insertions(+), 2 deletions(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 6cd669ff4b..1e8add2e12 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -45,6 +45,7 @@ static constexpr double JKRPREFIX = 1.2277228507842888; // cbrt(3*PI**2/ static constexpr int MDR_MAX_IT = 100; // Newton-Raphson for MDR static constexpr double MDR_EPSILON1 = 1e-10; // Newton-Raphson for MDR static constexpr double MDR_EPSILON2 = 1e-16; // Newton-Raphson for MDR +static constexpr double MDR_EPSILON3 = 1e-20; // For precision checks static constexpr double MDR_OVERLAP_LIMIT = 0.75; // Maximum contact overlap for MDR static const char cite_mdr[] = @@ -599,7 +600,7 @@ double GranSubModNormalMDR::calculate_forces() // displacement partitioning only necessary for particle-particle contact // itag and jtag persist after neighbor list builds, use tags to compare to match - // contact history variables consistently across steps for particle pair. + // contact history variables consistently across steps for a particle pair. if ((contactSide == 0 && itag_true > jtag_true) || (contactSide != 0 && itag_true < jtag_true)) { gm->i = i_true; gm->j = j_true; @@ -799,6 +800,7 @@ double GranSubModNormalMDR::calculate_forces() // case 2+3, tensile springs const double lmax = sqrt(MY_2PI * aAdh * gamma * Eeffinv); g_aAdh = A * 0.5 - A * Binv * sqrt(Bsq * 0.25 - pow(aAdh, 2)); + g_aAdh = round_up_negative_epsilon(g_aAdh); double tmp = 27 * A4 * B4 * gamma * Eeffinv; tmp -= 2 * pow(B, 6) * gamma3 * PISQ * pow(Eeffinv, 3); @@ -848,6 +850,8 @@ double GranSubModNormalMDR::calculate_forces() aAdh = aAdh_tmp; g_aAdh = A * 0.5 - A * Binv * sqrt(Bsq * 0.25 - pow(aAdh, 2)); + g_aAdh = round_up_negative_epsilon(g_aAdh); + const double deltaeAdh = g_aAdh; const double F_na = calculate_nonadhesive_mdr_force(deltaeAdh, Ainv, Eeff, A, B); const double F_Adhes = 2.0 * Eeff * (deltae1D - deltaeAdh) * aAdh; @@ -882,7 +886,7 @@ double GranSubModNormalMDR::calculate_forces() (contactSide == 0) ? F0 = F_MDR + F_BULK : F1 = F_MDR + F_BULK; if (update) { - // mean surface dipslacement calculation + // mean surface displacement calculation *Ac_offset = wij * Ac; // radius update scheme quantity calculation @@ -964,3 +968,13 @@ double GranSubModNormalMDR::calculate_nonadhesive_mdr_force(double delta, double return F_na; } + +/* ---------------------------------------------------------------------- + round values within (-EPSILON,0.0) due to machine precision errors to zero +------------------------------------------------------------------------- */ + +double GranSubModNormalMDR::round_up_negative_epsilon(double value) +{ + if (value < 0.0 && value > -MDR_EPSILON3) value = 0.0; + return value; +} diff --git a/src/GRANULAR/gran_sub_mod_normal.h b/src/GRANULAR/gran_sub_mod_normal.h index 1dfcdb4b44..ea9d507df7 100644 --- a/src/GRANULAR/gran_sub_mod_normal.h +++ b/src/GRANULAR/gran_sub_mod_normal.h @@ -158,6 +158,7 @@ namespace Granular_NS { char *id_fix; inline double calculate_nonadhesive_mdr_force(double, double, double, double, double); + inline double round_up_negative_epsilon(double); }; } // namespace Granular_NS From 50f932ba9e54713fae55efc9cd7861c0f2ca2c39 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Wed, 15 Jan 2025 13:06:10 -0700 Subject: [PATCH 60/74] Updating const expressions --- src/GRANULAR/gran_sub_mod_normal.cpp | 35 ++++++++++++++-------------- 1 file changed, 18 insertions(+), 17 deletions(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 1e8add2e12..769863c49f 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -30,23 +30,24 @@ using namespace LAMMPS_NS; using namespace Granular_NS; using namespace MathConst; -static constexpr double PISQ = MY_PI * MY_PI; -static constexpr double PIINV = 1.0 / MY_PI; -static constexpr double PI27SQ = 27 * PISQ; -static constexpr double PITOFIVETHIRDS = pow(MY_PI, 5.0 / 3.0); -static constexpr double CBRT2 = cbrt(2.0); -static constexpr double SQRTHALFPI = sqrt(MY_PI * 0.5); -static constexpr double CBRTHALFPI = cbrt(MY_PI * 0.5); -static constexpr double FOURTHIRDS = 4.0 / 3.0; -static constexpr double THREEROOT3 = 5.19615242270663202362; // 3*sqrt(3) -static constexpr double SIXROOT6 = 14.69693845669906728801; // 6*sqrt(6) -static constexpr double INVROOT6 = 0.40824829046386307274; // 1/sqrt(6) -static constexpr double JKRPREFIX = 1.2277228507842888; // cbrt(3*PI**2/16) -static constexpr int MDR_MAX_IT = 100; // Newton-Raphson for MDR -static constexpr double MDR_EPSILON1 = 1e-10; // Newton-Raphson for MDR -static constexpr double MDR_EPSILON2 = 1e-16; // Newton-Raphson for MDR -static constexpr double MDR_EPSILON3 = 1e-20; // For precision checks -static constexpr double MDR_OVERLAP_LIMIT = 0.75; // Maximum contact overlap for MDR +static constexpr double PISQ = 9.8696044010893579923; // PI^2 +static constexpr double PIINV = 0.318309886183790691216; // 1/PI +static constexpr double PI27SQ = 266.479318829412648029; // 27*PI^2 +static constexpr double PITOFIVETHIRDS = 6.73880859569814116838; // PI^(5/3) +static constexpr double CBRT2 = 1.25992104989487319067; // cbrt(2) +static constexpr double SQRTHALFPI = 1.25331413731550012081; // sqrt(PI/2) +static constexpr double CBRTHALFPI = 1.16244735150962652526; // cbrt(PI/2) +static constexpr double FOURTHIRDS = 1.33333333333333333333; // 4/3 +static constexpr double THREEROOT3 = 5.19615242270663202362; // 3*sqrt(3) +static constexpr double SIXROOT6 = 14.69693845669906728801; // 6*sqrt(6) +static constexpr double INVROOT6 = 0.40824829046386307274; // 1/sqrt(6) +static constexpr double JKRPREFIX = 1.2277228507842888; // cbrt(3*PI**2/16) + +static constexpr int MDR_MAX_IT = 100; // Newton-Raphson for MDR +static constexpr double MDR_EPSILON1 = 1e-10; // Newton-Raphson for MDR +static constexpr double MDR_EPSILON2 = 1e-16; // Newton-Raphson for MDR +static constexpr double MDR_EPSILON3 = 1e-20; // For precision checks +static constexpr double MDR_OVERLAP_LIMIT = 0.75; // Maximum contact overlap for MDR static const char cite_mdr[] = "MDR contact model command: (i) https://doi.org/10.1016/j.jmps.2023.105492 || (ii) https://doi.org/10.1016/j.jmps.2023.105493 || (iii) https://doi.org/10.31224/4289\n\n" From 0f462a60fff8c4923ae4d69d9a55e805efa726b0 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Wed, 15 Jan 2025 14:40:08 -0700 Subject: [PATCH 61/74] sign error, better variable name --- src/GRANULAR/gran_sub_mod_normal.cpp | 36 ++++++++++++++-------------- 1 file changed, 18 insertions(+), 18 deletions(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 769863c49f..047d0ccc35 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -578,7 +578,7 @@ double GranSubModNormalMDR::calculate_forces() double delta = gm->delta; // apparent overlap double *history = & gm->history[history_index]; // load in all history variables - int update = gm->history_update; + int history_update = gm->history_update; // Rigid flat placement scheme double *deltamax_offset = & history[DELTA_MAX]; @@ -587,7 +587,7 @@ double GranSubModNormalMDR::calculate_forces() double deltap0 = *deltap_offset0; double deltap1 = *deltap_offset1; - if (update && gm->delta >= *deltamax_offset) *deltamax_offset = gm->delta; + if (history_update && gm->delta >= *deltamax_offset) *deltamax_offset = gm->delta; double deltamax = *deltamax_offset; @@ -669,11 +669,11 @@ double GranSubModNormalMDR::calculate_forces() // kinematics const double ddelta = delta - *delta_offset; - if (update) *delta_offset = delta; + if (history_update) *delta_offset = delta; const double deltao = delta - (R - Ro); const double ddeltao = deltao - *deltao_offset; - if (update) *deltao_offset = deltao; + if (history_update) *deltao_offset = deltao; double ddelta_MDR, ddelta_BULK; if (psi[i] < psi_b) { @@ -688,11 +688,11 @@ double GranSubModNormalMDR::calculate_forces() // calculate and update MDR/BULK displacements const double delta_MDR = *delta_MDR_offset + ddelta_MDR; - if (update) *delta_MDR_offset = delta_MDR; + if (history_update) *delta_MDR_offset = delta_MDR; const double delta_BULK = MAX(0.0, *delta_BULK_offset + ddelta_BULK); - if (update) *delta_BULK_offset = delta_BULK; + if (history_update) *delta_BULK_offset = delta_BULK; - if (update && delta_MDR > *deltamax_MDR_offset) *deltamax_MDR_offset = delta_MDR; + if (history_update && delta_MDR > *deltamax_MDR_offset) *deltamax_MDR_offset = delta_MDR; const double deltamax_MDR = *deltamax_MDR_offset; // average pressure along yield surface @@ -700,7 +700,7 @@ double GranSubModNormalMDR::calculate_forces() if (*Yflag_offset == 0.0 && delta_MDR >= deltamax_MDR) { const double phertz = 4 * Eeff * sqrt(delta_MDR) / (3 * MY_PI * sqrt(R)); - if (update && phertz > pY) { + if (history_update && phertz > pY) { *Yflag_offset = 1.0; *deltaY_offset = delta_MDR; *cA_offset = MY_PI * (pow(*deltaY_offset, 2) - *deltaY_offset * R); @@ -748,7 +748,7 @@ double GranSubModNormalMDR::calculate_forces() deltae1D = (delta_MDR - deltamax_MDR + deltae1Dmax + deltaR) / (1 + deltaR / deltae1Dmax); // added for rigid flat placement - if (update) *deltap_offset = deltamax_MDR - (deltae1Dmax + deltaR); + if (history_update) *deltap_offset = deltamax_MDR - (deltae1Dmax + deltaR); } double a_na; @@ -779,7 +779,7 @@ double GranSubModNormalMDR::calculate_forces() error->one(FLERR, "F_MDR is NaN, non-adhesive case"); } - if (update) *aAdh_offset = a_na; + if (history_update) *aAdh_offset = a_na; } else { // adhesive contact double g_aAdh; @@ -796,7 +796,7 @@ double GranSubModNormalMDR::calculate_forces() if (std::isnan(F_MDR)) error->one(FLERR, "F_MDR is NaN, case 1: no tensile springs"); - if (update) *aAdh_offset = a_fac * a_na; + if (history_update) *aAdh_offset = a_fac * a_na; } else { // case 2+3, tensile springs const double lmax = sqrt(MY_2PI * aAdh * gamma * Eeffinv); @@ -832,7 +832,7 @@ double GranSubModNormalMDR::calculate_forces() double aAdh_tmp = aAdh; double fa, fa2, fa_tmp, dfda; for (int lv1 = 0; lv1 < MDR_MAX_IT; ++lv1) { - fa_tmp = deltae1D - A * 0.5 - A * sqrt(Bsq * 0.25 - pow(aAdh_tmp, 2)) * Binv; + fa_tmp = deltae1D - A * 0.5 + A * sqrt(Bsq * 0.25 - pow(aAdh_tmp, 2)) * Binv; fa = fa_tmp + sqrt(MY_2PI * aAdh_tmp * gamma * Eeffinv); if (abs(fa) < MDR_EPSILON1) { break; @@ -860,7 +860,7 @@ double GranSubModNormalMDR::calculate_forces() if (std::isnan(F_MDR)) error->one(FLERR, "F_MDR is NaN, case 3: tensile springs exceed critical length"); } - if (update) *aAdh_offset = aAdh; + if (history_update) *aAdh_offset = aAdh; } } } @@ -874,7 +874,7 @@ double GranSubModNormalMDR::calculate_forces() double Ac; (*Yflag_offset == 0.0) ? Ac = MY_PI * delta * R : Ac = MY_PI * (2.0 * delta * R - pow(delta, 2)) + cA; if (Ac < 0.0) Ac = 0.0; - if (update) { + if (history_update) { Atot_sum[i] += wij * (Ac - MY_2PI * R * (deltamax_MDR + delta_BULK)); Acon1[i] += wij * Ac; } @@ -886,7 +886,7 @@ double GranSubModNormalMDR::calculate_forces() // total force calculation (contactSide == 0) ? F0 = F_MDR + F_BULK : F1 = F_MDR + F_BULK; - if (update) { + if (history_update) { // mean surface displacement calculation *Ac_offset = wij * Ac; @@ -902,17 +902,17 @@ double GranSubModNormalMDR::calculate_forces() const double by = -(Ro - deltao) * gm->nx[1]; const double bz = -(Ro - deltao) * gm->nx[2]; const double eps_bar_contact = (fx * bx + fy * by + fz * bz) / (3 * kappa * Velas[i]); - if (update) eps_bar[i] += eps_bar_contact; + if (history_update) eps_bar[i] += eps_bar_contact; double desp_bar_contact = eps_bar_contact - *eps_bar_offset; - if (update && delta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0) { + if (history_update && delta_MDR == deltamax_MDR && *Yflag_offset > 0.0 && F_MDR > 0.0) { const double Vo = FOURTHIRDS * MY_PI * pow(Ro, 3); dRnumerator[i] -= Vo * (eps_bar_contact - *eps_bar_offset); dRnumerator[i] -= wij * MY_PI * ddeltao * (2 * deltao * Ro - pow(deltao, 2) + pow(R, 2) - pow(Ro, 2)); dRdenominator[i] += wij * 2.0 * MY_PI * R * (deltao + R - Ro); } - if (update) { + if (history_update) { *eps_bar_offset = eps_bar_contact; sigmaxx[i] += fx * bx / Velas[i]; sigmayy[i] += fy * by / Velas[i]; From 4cfe4831ed6fd47710ec3e34df39abfc533b3dd1 Mon Sep 17 00:00:00 2001 From: William Zunker Date: Wed, 15 Jan 2025 21:13:08 -0500 Subject: [PATCH 62/74] Removed unnecessary input file lines --- examples/granular/in.tableting.200 | 2 -- 1 file changed, 2 deletions(-) diff --git a/examples/granular/in.tableting.200 b/examples/granular/in.tableting.200 index 425cda3614..edd018c3d8 100644 --- a/examples/granular/in.tableting.200 +++ b/examples/granular/in.tableting.200 @@ -55,8 +55,6 @@ pair_coeff * * mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEne variable disp_upper equal 0.0 variable disp_lower equal 0.0 -variable disp_xPlanePos equal 0.0 -variable disp_xPlaneNeg equal 0.0 variable wall_contact_string string "granular mdr ${YoungsModulus} ${PoissonsRatio} ${YieldStress} ${SurfaceEnergyWall} ${psi_b} ${CoR} tangential linear_history ${kt_wall} ${xgammat} ${mu_s_wall} rolling sds ${k_roll} ${gamma_roll} ${mu_roll} damping none" From 6aa0c95c5ef5eb1d24e11008d7f25f0b9d9712a9 Mon Sep 17 00:00:00 2001 From: William Zunker Date: Wed, 15 Jan 2025 21:46:42 -0500 Subject: [PATCH 63/74] Removed more unnecessary input file lines --- examples/granular/in.tableting.200 | 2 -- 1 file changed, 2 deletions(-) diff --git a/examples/granular/in.tableting.200 b/examples/granular/in.tableting.200 index edd018c3d8..41723c72af 100644 --- a/examples/granular/in.tableting.200 +++ b/examples/granular/in.tableting.200 @@ -63,8 +63,6 @@ variable dieHeight2 equal 2*${dieHeight} region lowerPunch plane 0 0 0 0 0 1 side in units box move NULL NULL v_disp_lower units box region upperPunch plane 0 0 ${dieHeight} 0 0 -1 side in move NULL NULL v_disp_upper units box region die cylinder z 0 0 ${dieRadius} 0 ${dieHeight2} side in units box -variable dieRadiusPlus equal ${dieRadius}*1.05 -variable dieRadiusPlusNeg equal -${dieRadiusPlus} fix lowerPunch all wall/gran/region ${wall_contact_string} region lowerPunch contacts fix upperPunch all wall/gran/region ${wall_contact_string} region upperPunch contacts From b21f804e4eb951ff5944afb2d6ba041e2d82521a Mon Sep 17 00:00:00 2001 From: jtclemm Date: Wed, 15 Jan 2025 19:55:50 -0700 Subject: [PATCH 64/74] Fixing initialized overlap bug --- src/GRANULAR/gran_sub_mod_normal.cpp | 4 +++- 1 file changed, 3 insertions(+), 1 deletion(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 047d0ccc35..616bbed4ab 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -587,7 +587,9 @@ double GranSubModNormalMDR::calculate_forces() double deltap0 = *deltap_offset0; double deltap1 = *deltap_offset1; - if (history_update && gm->delta >= *deltamax_offset) *deltamax_offset = gm->delta; + // always update deltamax since gm->delta won't change until initial integrate + // also need to define deltamax if an atom is created with an overlap + if (gm->delta >= *deltamax_offset) *deltamax_offset = gm->delta; double deltamax = *deltamax_offset; From af8b873bf5333bbed5f786385c4df4dfa8fb31f5 Mon Sep 17 00:00:00 2001 From: jtclemm Date: Thu, 16 Jan 2025 12:22:50 -0700 Subject: [PATCH 65/74] Adding error message for initial overlaps --- src/GRANULAR/gran_sub_mod_normal.cpp | 10 ++++++++++ src/GRANULAR/gran_sub_mod_normal.h | 2 ++ 2 files changed, 12 insertions(+) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 616bbed4ab..c8ab64bada 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -493,6 +493,8 @@ void GranSubModNormalMDR::coeffs_to_local() gammasq = gamma * gamma; gamma3 = gammasq * gamma; gamma4 = gammasq * gammasq; + + warn_flag = 1; } /* ---------------------------------------------------------------------- */ @@ -589,6 +591,7 @@ double GranSubModNormalMDR::calculate_forces() // always update deltamax since gm->delta won't change until initial integrate // also need to define deltamax if an atom is created with an overlap + double deltamaxi = *deltamax_offset; if (gm->delta >= *deltamax_offset) *deltamax_offset = gm->delta; double deltamax = *deltamax_offset; @@ -702,6 +705,13 @@ double GranSubModNormalMDR::calculate_forces() if (*Yflag_offset == 0.0 && delta_MDR >= deltamax_MDR) { const double phertz = 4 * Eeff * sqrt(delta_MDR) / (3 * MY_PI * sqrt(R)); + if (!history_update && warn_flag && deltamaxi == 0) { + error->all(FLERR, "Warning: The newly inserted particles have pre-existing overlaps that " + "have caused immediate plastic deformation. This could lead to " + "non-physical results in the MDR model, as it handles some aspects " + "related to plastic deformation incrementally."); + warn_flag = 0; + } if (history_update && phertz > pY) { *Yflag_offset = 1.0; *deltaY_offset = delta_MDR; diff --git a/src/GRANULAR/gran_sub_mod_normal.h b/src/GRANULAR/gran_sub_mod_normal.h index ea9d507df7..db96227f13 100644 --- a/src/GRANULAR/gran_sub_mod_normal.h +++ b/src/GRANULAR/gran_sub_mod_normal.h @@ -150,6 +150,8 @@ namespace Granular_NS { double Eeffsq, Eeffinv, Eeffsqinv; double gammasq, gamma3, gamma4; + int warn_flag; + int index_Ro, index_Vgeo, index_Velas, index_Vcaps, index_eps_bar, index_dRnumerator; int index_dRdenominator, index_Acon0, index_Acon1, index_Atot, index_Atot_sum, index_ddelta_bar; int index_psi, index_sigmaxx, index_sigmayy, index_sigmazz, index_contacts, index_adhesive_length; From 95152b1eb6f41406ebe4f6ab3f0168accf9dea17 Mon Sep 17 00:00:00 2001 From: William Zunker Date: Thu, 16 Jan 2025 16:00:16 -0500 Subject: [PATCH 66/74] Slight adjustments to overlap check --- src/GRANULAR/gran_sub_mod_normal.cpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index c8ab64bada..78472aeea3 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -697,7 +697,7 @@ double GranSubModNormalMDR::calculate_forces() const double delta_BULK = MAX(0.0, *delta_BULK_offset + ddelta_BULK); if (history_update) *delta_BULK_offset = delta_BULK; - if (history_update && delta_MDR > *deltamax_MDR_offset) *deltamax_MDR_offset = delta_MDR; + if (delta_MDR > *deltamax_MDR_offset) *deltamax_MDR_offset = delta_MDR; const double deltamax_MDR = *deltamax_MDR_offset; // average pressure along yield surface @@ -705,7 +705,7 @@ double GranSubModNormalMDR::calculate_forces() if (*Yflag_offset == 0.0 && delta_MDR >= deltamax_MDR) { const double phertz = 4 * Eeff * sqrt(delta_MDR) / (3 * MY_PI * sqrt(R)); - if (!history_update && warn_flag && deltamaxi == 0) { + if (!history_update && warn_flag && deltamaxi == 0 && phertz > pY) { error->all(FLERR, "Warning: The newly inserted particles have pre-existing overlaps that " "have caused immediate plastic deformation. This could lead to " "non-physical results in the MDR model, as it handles some aspects " From 1bcbf6dc4bdc69f7a07d749eed95557405898e66 Mon Sep 17 00:00:00 2001 From: William Zunker Date: Thu, 16 Jan 2025 16:28:19 -0500 Subject: [PATCH 67/74] Error to warning for overlap check --- src/GRANULAR/gran_sub_mod_normal.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 78472aeea3..9aef4eb6f4 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -706,7 +706,7 @@ double GranSubModNormalMDR::calculate_forces() if (*Yflag_offset == 0.0 && delta_MDR >= deltamax_MDR) { const double phertz = 4 * Eeff * sqrt(delta_MDR) / (3 * MY_PI * sqrt(R)); if (!history_update && warn_flag && deltamaxi == 0 && phertz > pY) { - error->all(FLERR, "Warning: The newly inserted particles have pre-existing overlaps that " + error->warning(FLERR, "The newly inserted particles have pre-existing overlaps that " "have caused immediate plastic deformation. This could lead to " "non-physical results in the MDR model, as it handles some aspects " "related to plastic deformation incrementally."); From 57d47ebb4f2ef2cfb53b5858f9930c33f803a97d Mon Sep 17 00:00:00 2001 From: jtclemm Date: Thu, 16 Jan 2025 15:31:31 -0700 Subject: [PATCH 68/74] Adding custom svector gransubmod quantities --- doc/src/fix_wall_gran.rst | 14 +++++++-- doc/src/fix_wall_gran_region.rst | 14 +++++++-- doc/src/pair_granular.rst | 43 ++++++++++++++++----------- src/GRANULAR/fix_wall_gran.cpp | 9 ++++-- src/GRANULAR/fix_wall_gran.h | 2 +- src/GRANULAR/fix_wall_gran_region.cpp | 7 ++++- src/GRANULAR/gran_sub_mod.cpp | 1 + src/GRANULAR/gran_sub_mod.h | 2 ++ src/GRANULAR/gran_sub_mod_heat.cpp | 10 +++++-- src/GRANULAR/granular_model.cpp | 21 +++++++++++-- src/GRANULAR/granular_model.h | 4 +++ src/GRANULAR/pair_granular.cpp | 26 ++++++++++++++-- src/GRANULAR/pair_granular.h | 2 ++ 13 files changed, 121 insertions(+), 34 deletions(-) diff --git a/doc/src/fix_wall_gran.rst b/doc/src/fix_wall_gran.rst index 25d659241c..0d864cce88 100644 --- a/doc/src/fix_wall_gran.rst +++ b/doc/src/fix_wall_gran.rst @@ -222,10 +222,10 @@ restart file, so that the operation of the fix continues in an uninterrupted fashion. If the :code:`contacts` option is used, this fix generates a per-atom array -with 8 columns as output, containing the contact information for owned +with at least 8 columns as output, containing the contact information for owned particles (nlocal on each processor). All columns in this per-atom array will -be zero if no contact has occurred. The values of these columns are listed in -the following table: +be zero if no contact has occurred. The first 8 values of these columns are +listed in the following table. +-------+----------------------------------------------------+----------------+ | Index | Value | Units | @@ -248,6 +248,14 @@ the following table: | 8 | Radius :math:`r` of atom | distance units | +-------+----------------------------------------------------+----------------+ +If a granular submodel calculates additional contact information (e.g. the +heat submodels calculate the amount of heat exchanged), these quantities +are appended to the end of this array. First, any extra values from the +normal submodel are appended followed by the damping, tangential, rolling, +twisting, then heat models. See the descriptions of granular submodels in +the :doc:`pair granular ` page for information on any extra +quantities. + None of the :doc:`fix_modify ` options are relevant to this fix. No parameter of this fix can be used with the *start/stop* keywords of the :doc:`run ` command. This fix is not invoked during :doc:`energy diff --git a/doc/src/fix_wall_gran_region.rst b/doc/src/fix_wall_gran_region.rst index 0a4343493b..0e5e98f1a8 100644 --- a/doc/src/fix_wall_gran_region.rst +++ b/doc/src/fix_wall_gran_region.rst @@ -243,10 +243,10 @@ uninterrupted fashion. with a different region ID. If the :code:`contacts` option is used, this fix generates a per-atom array -with 8 columns as output, containing the contact information for owned +with at least 8 columns as output, containing the contact information for owned particles (nlocal on each processor). All columns in this per-atom array will -be zero if no contact has occurred. The values of these columns are listed in -the following table: +be zero if no contact has occurred. The first 8 values of these columns are +listed in the following table. +-------+----------------------------------------------------+----------------+ | Index | Value | Units | @@ -269,6 +269,14 @@ the following table: | 8 | Radius :math:`r` of atom | distance units | +-------+----------------------------------------------------+----------------+ +If a granular submodel calculates additional contact information (e.g. the +heat submodels calculate the amount of heat exchanged), these quantities +are appended to the end of this array. First, any extra values from the +normal submodel are appended followed by the damping, tangential, rolling, +twisting, then heat models. See the descriptions of granular submodels in +the :doc:`pair granular ` page for information on any extra +quantities. + None of the :doc:`fix_modify ` options are relevant to this fix. No parameter of this fix can be used with the *start/stop* keywords of the :doc:`run ` command. This fix is not invoked during :doc:`energy diff --git a/doc/src/pair_granular.rst b/doc/src/pair_granular.rst index 5fb063f1c3..ed24507dda 100644 --- a/doc/src/pair_granular.rst +++ b/doc/src/pair_granular.rst @@ -166,15 +166,15 @@ initially will not experience force until they come into contact experience a tensile force up to :math:`3\pi\gamma R`, at which point they lose contact. -The *mdr* model is a mechanically-derived contact model designed to capture the +The *mdr* model is a mechanically-derived contact model designed to capture the contact response between adhesive elastic-plastic particles into large deformation. The theoretical foundations of the *mdr* model are detailed in the -two-part series :ref:`Zunker and Kamrin Part I ` and -:ref:`Zunker and Kamrin Part II `. Further development +two-part series :ref:`Zunker and Kamrin Part I ` and +:ref:`Zunker and Kamrin Part II `. Further development and demonstrations of its application to industrially relevant powder compaction processes are presented in :ref:`Zunker et al. `. -The model requires the following inputs: +The model requires the following inputs: 1. *Young's modulus* :math:`E > 0` : The Young's modulus is commonly reported for various powders. @@ -197,12 +197,12 @@ The model requires the following inputs: response. 6. *Coefficient of restitution* :math:`0 \le e \le 1` : The coefficient of - restitution is a tunable parameter that controls damping in the normal direction. + restitution is a tunable parameter that controls damping in the normal direction. .. note:: The values for :math:`E`, :math:`\nu`, :math:`Y`, and :math:`\Delta\gamma` (i.e., - :math:`K_{Ic}`) should be selected for zero porosity to reflect the intrinsic + :math:`K_{Ic}`) should be selected for zero porosity to reflect the intrinsic material property rather than the bulk powder property. The *mdr* model produces a nonlinear force-displacement response, therefore the @@ -218,7 +218,7 @@ Here, :math:`\kappa = E/(3(1-2\nu))` is the bulk modulus and .. note:: The *mdr* model requires some specific settings to function properly, - please read the following text carefully to ensure all requirements are + please read the following text carefully to ensure all requirements are followed. The *atom_style* must be set to *sphere 1* to enable dynamic particle @@ -230,7 +230,7 @@ deformation is accumulated, a new enlarged apparent radius is defined to ensure that that volume change due to plastic deformation is not lost. This apparent radius is stored as the *atom radius* meaning it is used for subsequent neighbor list builds and contact detection checks. The -advantage of this is that multi-neighbor dependent effects such as +advantage of this is that multi-neighbor dependent effects such as formation of secondary contacts caused by radial expansion are captured by the *mdr* model. Setting *atom_style sphere 1* ensures that updates to the particle radii are properly reflected throughout the simulation. @@ -243,14 +243,14 @@ Newton's third law must be set to *off*. This ensures that the neighbor lists are constructed properly for the topological penalty algorithm used to screen for non-physical contacts occurring through obstructing particles, an issue prevalent under large deformation conditions. For more information on this -algorithm see :ref:`Zunker et al. `. +algorithm see :ref:`Zunker et al. `. .. code-block:: LAMMPS newton off -The damping model must be set to *none*. The *mdr* model already has a built -in damping model. +The damping model must be set to *none*. The *mdr* model already has a built +in damping model. .. code-block:: LAMMPS @@ -268,7 +268,7 @@ Additionally, the following *mdr* inputs must match between the *pair_style* and *fix wall/gran/region* definitions: :math:`E`, :math:`\nu`, :math:`Y`, :math:`\psi_b`, and :math:`e`. The exception is :math:`\Delta\gamma`, which may vary, permitting different -adhesive behaviors between particle-particle and particle-wall interactions. +adhesive behaviors between particle-particle and particle-wall interactions. .. note:: @@ -297,7 +297,7 @@ contact. In the input script, these quantities are initialized by calling *examples/granular* directory. The first is a die compaction simulation involving 200 particles named *in.tableting.200*. The second is a triaxial compaction simulation involving 12 - particles named *in.triaxial.compaction.12*. + particles named *in.triaxial.compaction.12*. ---------- In addition, the normal force is augmented by a damping term of the @@ -806,7 +806,10 @@ supported are: 2. *radius* : :math:`k_{s}` 3. *area* : :math:`h_{s}` -If the *heat* keyword is not specified, the model defaults to *none*. +If the *heat* keyword is not specified, the model defaults to *none*. All +heat models calculate an additional pairwise quantity accessible by the +single() function (described below) which is the heat conducted between the +two particles. For *heat* *radius*, the heat :math:`Q` conducted between two particles is given by @@ -921,7 +924,7 @@ The single() function of these pair styles returns 0.0 for the energy of a pairwise interaction, since energy is not conserved in these dissipative potentials. It also returns only the normal component of the pairwise interaction force. However, the single() function also -calculates 13 extra pairwise quantities. The first 3 are the +calculates at least 13 extra pairwise quantities. The first 3 are the components of the tangential force between particles I and J, acting on particle I. The fourth is the magnitude of this tangential force. The next 3 (5-7) are the components of the rolling torque acting on @@ -929,9 +932,13 @@ particle I. The next entry (8) is the magnitude of the rolling torque. The next entry (9) is the magnitude of the twisting torque acting about the vector connecting the two particle centers. The next 3 (10-12) are the components of the vector connecting -the centers of the two particles (x_I - x_J). The last quantity (13) -is the heat flow between the two particles, set to 0 if no heat model -is active. +the centers of the two particles (x_I - x_J). If a granular submodel +calculates additional contact information (e.g. the heat submodels +calculate the amount of heat exchanged), these quantities are appended +to the end of this list. First, any extra values from the normal submodel +are appended followed by the damping, tangential, rolling, twisting, then +heat models. See the descriptions of specific granular submodels above +for information on any extra quantities. These extra quantities can be accessed by the :doc:`compute pair/local ` command, as *p1*, *p2*, ..., *p12*\ . diff --git a/src/GRANULAR/fix_wall_gran.cpp b/src/GRANULAR/fix_wall_gran.cpp index 3336a8a4d7..f91857ba13 100644 --- a/src/GRANULAR/fix_wall_gran.cpp +++ b/src/GRANULAR/fix_wall_gran.cpp @@ -199,7 +199,7 @@ FixWallGran::FixWallGran(LAMMPS *lmp, int narg, char **arg) : iarg += 3; } else if (strcmp(arg[iarg],"contacts") == 0) { peratom_flag = 1; - size_peratom_cols = 8; + size_peratom_cols = 8 + model->nsvector; peratom_freq = 1; iarg += 1; } else if (strcmp(arg[iarg],"temperature") == 0) { @@ -363,7 +363,7 @@ void FixWallGran::setup(int vflag) void FixWallGran::post_force(int /*vflag*/) { - int i,j; + int i,j,n; double dx,dy,dz,del1,del2,delxy,delr,rwall,meff; double *forces, *torquesi; double vwall[3]; @@ -523,7 +523,9 @@ void FixWallGran::post_force(int /*vflag*/) if (use_history) model->history = history_one[i]; if (heat_flag) model->Ti = temperature[i]; + if (peratom_flag) model->calculate_svector = 1; model->calculate_forces(); + if (peratom_flag) model->calculate_svector = 0; forces = model->forces; torquesi = model->torquesi; @@ -544,6 +546,9 @@ void FixWallGran::post_force(int /*vflag*/) array_atom[i][5] = x[i][1] - dy; array_atom[i][6] = x[i][2] - dz; array_atom[i][7] = radius[i]; + + for (n = 0; n < model->nsvector; n++) + array_atom[i][8 + n] = model->svector[n]; } } } diff --git a/src/GRANULAR/fix_wall_gran.h b/src/GRANULAR/fix_wall_gran.h index e1e8c38ffe..e3d35fcc36 100644 --- a/src/GRANULAR/fix_wall_gran.h +++ b/src/GRANULAR/fix_wall_gran.h @@ -84,7 +84,7 @@ class FixWallGran : public Fix { // store particle interactions - int store; + int nsvector; void clear_stored_contacts(); }; diff --git a/src/GRANULAR/fix_wall_gran_region.cpp b/src/GRANULAR/fix_wall_gran_region.cpp index 4a59c1aea2..9d760b5659 100644 --- a/src/GRANULAR/fix_wall_gran_region.cpp +++ b/src/GRANULAR/fix_wall_gran_region.cpp @@ -118,7 +118,7 @@ void FixWallGranRegion::init() void FixWallGranRegion::post_force(int /*vflag*/) { - int i, m, nc, iwall; + int i, n, m, nc, iwall; double *forces, *torquesi; double meff, vwall[3], w0[3] = {0.0, 0.0, 0.0}; bool touchflag = false; @@ -262,7 +262,9 @@ void FixWallGranRegion::post_force(int /*vflag*/) if (use_history) model->history = history_many[i][c2r[ic]]; if (heat_flag) model->Ti = temperature[i]; + if (peratom_flag) model->calculate_svector = 1; model->calculate_forces(); + if (peratom_flag) model->calculate_svector = 0; forces = model->forces; torquesi = model->torquesi; @@ -283,6 +285,9 @@ void FixWallGranRegion::post_force(int /*vflag*/) array_atom[i][5] = x[i][1] - model->dx[1]; array_atom[i][6] = x[i][2] - model->dx[2]; array_atom[i][7] = radius[i]; + + for (n = 0; n < model->nsvector; n++) + array_atom[i][8 + n] = model->svector[n]; } } } diff --git a/src/GRANULAR/gran_sub_mod.cpp b/src/GRANULAR/gran_sub_mod.cpp index bac9c9edfe..c31fbd7241 100644 --- a/src/GRANULAR/gran_sub_mod.cpp +++ b/src/GRANULAR/gran_sub_mod.cpp @@ -42,6 +42,7 @@ GranSubMod::GranSubMod(class GranularModel *gm, LAMMPS *lmp) : Pointers(lmp) beyond_contact = 0; num_coeffs = 0; contact_radius_flag = 0; + nsvector = 0; nondefault_history_transfer = 0; transfer_history_factor = nullptr; diff --git a/src/GRANULAR/gran_sub_mod.h b/src/GRANULAR/gran_sub_mod.h index 88e77eb77b..857f70cc59 100644 --- a/src/GRANULAR/gran_sub_mod.h +++ b/src/GRANULAR/gran_sub_mod.h @@ -46,6 +46,8 @@ namespace Granular_NS { GranularModel *gm; + int nsvector, index_svector; + protected: int allocated; diff --git a/src/GRANULAR/gran_sub_mod_heat.cpp b/src/GRANULAR/gran_sub_mod_heat.cpp index 5378a72fd4..c26501c584 100644 --- a/src/GRANULAR/gran_sub_mod_heat.cpp +++ b/src/GRANULAR/gran_sub_mod_heat.cpp @@ -50,6 +50,7 @@ GranSubModHeatRadius::GranSubModHeatRadius(GranularModel *gm, LAMMPS *lmp) : Gra num_coeffs = 1; contact_radius_flag = 1; conductivity = 0.0; + nsvector = 1; } /* ---------------------------------------------------------------------- */ @@ -65,7 +66,9 @@ void GranSubModHeatRadius::coeffs_to_local() double GranSubModHeatRadius::calculate_heat() { - return 2 * conductivity * gm->contact_radius * (gm->Tj - gm->Ti); + double heat = 2 * conductivity * gm->contact_radius * (gm->Tj - gm->Ti); + if (gm->calculate_svector) gm->svector[index_svector] = heat; + return heat; } @@ -78,6 +81,7 @@ GranSubModHeatArea::GranSubModHeatArea(GranularModel *gm, LAMMPS *lmp) : GranSub num_coeffs = 1; contact_radius_flag = 1; heat_transfer_coeff = 0.0; + nsvector = 1; } /* ---------------------------------------------------------------------- */ @@ -93,5 +97,7 @@ void GranSubModHeatArea::coeffs_to_local() double GranSubModHeatArea::calculate_heat() { - return heat_transfer_coeff * MY_PI * gm->contact_radius * gm->contact_radius * (gm->Tj - gm->Ti); + double heat = heat_transfer_coeff * MY_PI * gm->contact_radius * gm->contact_radius * (gm->Tj - gm->Ti); + if (gm->calculate_svector) gm->svector[index_svector] = heat; + return heat; } diff --git a/src/GRANULAR/granular_model.cpp b/src/GRANULAR/granular_model.cpp index cb0bf29987..f85774554c 100644 --- a/src/GRANULAR/granular_model.cpp +++ b/src/GRANULAR/granular_model.cpp @@ -27,6 +27,7 @@ #include "force.h" #include "gran_sub_mod.h" #include "math_extra.h" +#include "memory.h" #include "style_gran_sub_mod.h" // IWYU pragma: keep @@ -64,6 +65,10 @@ GranularModel::GranularModel(LAMMPS *lmp) : Pointers(lmp) twisting_model = nullptr; heat_model = nullptr; + calculate_svector = 0; + nsvector = 0; + svector = nullptr; + for (int i = 0; i < NSUBMODELS; i++) sub_models[i] = nullptr; transfer_history_factor = nullptr; @@ -100,6 +105,7 @@ GranularModel::~GranularModel() delete[] gran_sub_mod_class; delete[] gran_sub_mod_names; delete[] gran_sub_mod_types; + delete[] svector; for (int i = 0; i < NSUBMODELS; i++) delete sub_models[i]; } @@ -298,6 +304,18 @@ void GranularModel::init() } for (int i = 0; i < NSUBMODELS; i++) sub_models[i]->init(); + + int index_svector = 0; + for (int i = 0; i < NSUBMODELS; i++) { + if (sub_models[i]->nsvector != 0) { + sub_models[i]->index_svector = index_svector; + nsvector += sub_models[i]->nsvector; + index_svector += sub_models[i]->nsvector; + } + } + + if (nsvector != 0) + svector = new double[nsvector]; } /* ---------------------------------------------------------------------- */ @@ -498,9 +516,8 @@ void GranularModel::calculate_forces() if (contact_type == PAIR) sub3(torquesj, tortwist, torquesj); } - if (heat_defined) { + if (heat_defined) dq = heat_model->calculate_heat(); - } } /* ---------------------------------------------------------------------- diff --git a/src/GRANULAR/granular_model.h b/src/GRANULAR/granular_model.h index c514f736f7..67df1410d9 100644 --- a/src/GRANULAR/granular_model.h +++ b/src/GRANULAR/granular_model.h @@ -96,6 +96,10 @@ class GranularModel : protected Pointers { double magtwist; bool touch; + // Extra output + int calculate_svector, nsvector; + double *svector; + protected: int rolling_defined, twisting_defined, heat_defined; // Flag optional sub models int classic_model; // Flag original pair/gran calculations diff --git a/src/GRANULAR/pair_granular.cpp b/src/GRANULAR/pair_granular.cpp index 5cc9ddf2bc..79b6c2406e 100644 --- a/src/GRANULAR/pair_granular.cpp +++ b/src/GRANULAR/pair_granular.cpp @@ -417,8 +417,10 @@ void PairGranular::init_style() error->all(FLERR,"Heat conduction in pair granular requires atom style with heatflow property"); } - // allocate history and initialize models + // allocate history and aggregate model information class GranularModel* model; + double nsvector_total; + extra_svector = 0; int size_max[NSUBMODELS] = {0}; for (int n = 0; n < nmodels; n++) { model = models_list[n]; @@ -429,13 +431,23 @@ void PairGranular::init_style() } if (model->size_history != 0) use_history = 1; - for (int i = 0; i < NSUBMODELS; i++) + nsvector_total = 0; + for (int i = 0; i < NSUBMODELS; i++) { + nsvector_total += model->sub_models[i]->nsvector; if (model->sub_models[i]->size_history > size_max[i]) size_max[i] = model->sub_models[i]->size_history; + } + extra_svector = MAX(extra_svector, nsvector_total); if (model->nondefault_history_transfer) nondefault_history_transfer = 1; } + if (extra_svector != 0) { + single_extra = 12 + extra_svector; + delete[] svector; + svector = new double[single_extra]; + } + size_history = 0; if (use_history) { for (int i = 0; i < NSUBMODELS; i++) size_history += size_max[i]; @@ -770,7 +782,9 @@ double PairGranular::single(int i, int j, int itype, int jtype, model->omegaj = omega[j]; model->history = history; + model->calculate_svector = 1; model->calculate_forces(); + model->calculate_svector = 0; // apply forces & torques // Calculate normal component, normalized by r @@ -790,6 +804,14 @@ double PairGranular::single(int i, int j, int itype, int jtype, svector[10] = model->dx[1]; svector[11] = model->dx[2]; + // add submodel-specific quantities + for (int n = 0; n < model->nsvector; n++) + svector[12 + n] = model->svector[n]; + + // zero any values unused by this specific model + for (int n = 12 + model->nsvector; n < single_extra; n++) + svector[n] = 0.0; + return 0.0; } diff --git a/src/GRANULAR/pair_granular.h b/src/GRANULAR/pair_granular.h index c3f51a4a97..b3b8d350f0 100644 --- a/src/GRANULAR/pair_granular.h +++ b/src/GRANULAR/pair_granular.h @@ -82,6 +82,8 @@ class PairGranular : public Pair { // optional user-specified global cutoff, per-type user-specified cutoffs double **cutoff_type; double cutoff_global; + + int extra_svector; }; } // namespace LAMMPS_NS From de5a41de7b76c4d14382f8f51891e55e0f0b52bd Mon Sep 17 00:00:00 2001 From: jtclemm Date: Thu, 16 Jan 2025 15:37:16 -0700 Subject: [PATCH 69/74] simplifying svector handling for walls --- src/GRANULAR/fix_wall_gran.cpp | 4 ++-- src/GRANULAR/fix_wall_gran_region.cpp | 8 +++++--- 2 files changed, 7 insertions(+), 5 deletions(-) diff --git a/src/GRANULAR/fix_wall_gran.cpp b/src/GRANULAR/fix_wall_gran.cpp index f91857ba13..7b4f559635 100644 --- a/src/GRANULAR/fix_wall_gran.cpp +++ b/src/GRANULAR/fix_wall_gran.cpp @@ -435,7 +435,9 @@ void FixWallGran::post_force(int /*vflag*/) rwall = 0.0; + model->calculate_svector = 0; if (peratom_flag) { + model->calculate_svector = 1; clear_stored_contacts(); } @@ -523,9 +525,7 @@ void FixWallGran::post_force(int /*vflag*/) if (use_history) model->history = history_one[i]; if (heat_flag) model->Ti = temperature[i]; - if (peratom_flag) model->calculate_svector = 1; model->calculate_forces(); - if (peratom_flag) model->calculate_svector = 0; forces = model->forces; torquesi = model->torquesi; diff --git a/src/GRANULAR/fix_wall_gran_region.cpp b/src/GRANULAR/fix_wall_gran_region.cpp index 9d760b5659..2009b5974b 100644 --- a/src/GRANULAR/fix_wall_gran_region.cpp +++ b/src/GRANULAR/fix_wall_gran_region.cpp @@ -174,7 +174,11 @@ void FixWallGranRegion::post_force(int /*vflag*/) region->set_velocity(); } - if (peratom_flag) clear_stored_contacts(); + model->calculate_svector = 0; + if (peratom_flag) { + model->calculate_svector = 1; + clear_stored_contacts(); + } // Define constant wall properties (atom j) model->radj = 0.0; @@ -262,9 +266,7 @@ void FixWallGranRegion::post_force(int /*vflag*/) if (use_history) model->history = history_many[i][c2r[ic]]; if (heat_flag) model->Ti = temperature[i]; - if (peratom_flag) model->calculate_svector = 1; model->calculate_forces(); - if (peratom_flag) model->calculate_svector = 0; forces = model->forces; torquesi = model->torquesi; From 7900f24844be23b7210c04133b20af3adbf1da55 Mon Sep 17 00:00:00 2001 From: William Zunker Date: Fri, 17 Jan 2025 11:29:35 -0500 Subject: [PATCH 70/74] Adding contact area svector to mdr --- src/GRANULAR/gran_sub_mod_normal.cpp | 6 ++++++ 1 file changed, 6 insertions(+) diff --git a/src/GRANULAR/gran_sub_mod_normal.cpp b/src/GRANULAR/gran_sub_mod_normal.cpp index 9aef4eb6f4..a26d846f5c 100644 --- a/src/GRANULAR/gran_sub_mod_normal.cpp +++ b/src/GRANULAR/gran_sub_mod_normal.cpp @@ -443,6 +443,7 @@ GranSubModNormalMDR::GranSubModNormalMDR(GranularModel *gm, LAMMPS *lmp) : num_coeffs = 6; contact_radius_flag = 1; size_history = 26; + nsvector = 1; fix_mdr_flag = 0; id_fix = nullptr; @@ -578,6 +579,7 @@ double GranSubModNormalMDR::calculate_forces() double F0 = 0.0; // force on contact side 0 double F1 = 0.0; // force on contact side 1 double delta = gm->delta; // apparent overlap + double Ac_avg = 0.0; // average contact area across both sides double *history = & gm->history[history_index]; // load in all history variables int history_update = gm->history_update; @@ -890,6 +892,7 @@ double GranSubModNormalMDR::calculate_forces() Atot_sum[i] += wij * (Ac - MY_2PI * R * (deltamax_MDR + delta_BULK)); Acon1[i] += wij * Ac; } + Ac_avg += wij * Ac; // bulk force calculation double F_BULK; @@ -932,6 +935,9 @@ double GranSubModNormalMDR::calculate_forces() } } + // save contact area + if (gm->calculate_svector) gm->svector[index_svector] = Ac_avg * 0.5; + gm->i = i_true; gm->j = j_true; gm->radi = radi_true; From e6a84d5f2a6814c855b85492a1d4ab3a59a69170 Mon Sep 17 00:00:00 2001 From: William Zunker Date: Fri, 17 Jan 2025 13:37:15 -0500 Subject: [PATCH 71/74] Added mdr svector to doc and svector example in in.triaxial.compaction.12 --- doc/src/pair_granular.rst | 13 ++++++++----- examples/granular/in.triaxial.compaction.12 | 9 +++++++++ 2 files changed, 17 insertions(+), 5 deletions(-) diff --git a/doc/src/pair_granular.rst b/doc/src/pair_granular.rst index ed24507dda..8417cc6520 100644 --- a/doc/src/pair_granular.rst +++ b/doc/src/pair_granular.rst @@ -272,15 +272,17 @@ adhesive behaviors between particle-particle and particle-wall interactions. .. note:: - The *mdr* model has a number of custom *property/atom* definitions that + The *mdr* model has a number of custom *property/atom* and *pair/local* definitions that can be called in the input file. The useful properties for visualization and analysis are described below. In addition to contact forces the *mdr* model also tracks the following -quantities for each particle: elastic volume change, the average normal -stress components for each particle, and total surface area involved in -contact. In the input script, these quantities are initialized by calling -*run 0* and can then be accessed using subsequent *compute* commands. +quantities for each particle: elastic volume change, average normal +stress components, total surface area involved in +contact, and individual contact areas. In the input script, these quantities are +initialized by calling *run 0* and can then be accessed using subsequent *compute* +commands. The last *compute* command uses *pair/local p13* to calculate the pairwise +contact areas for each active contact in the *group-ID*. .. code-block:: LAMMPS @@ -290,6 +292,7 @@ contact. In the input script, these quantities are initialized by calling compute ID group-ID property/atom d_sigmayy compute ID group-ID property/atom d_sigmazz compute ID group-ID property/atom d_Acon1 + compute ID group-ID pair/local p13 .. note:: diff --git a/examples/granular/in.triaxial.compaction.12 b/examples/granular/in.triaxial.compaction.12 index c56fe521d0..6befe55241 100644 --- a/examples/granular/in.triaxial.compaction.12 +++ b/examples/granular/in.triaxial.compaction.12 @@ -15,6 +15,9 @@ boundary f f f read_data spheres12.data fix integr all nve/sphere +# create pair group for contact area outputs +group particles_1_12 id 1 12 + ########################### PARTICLE MATERIAL PROPERTIES AND FORCE MODEL ############################### variable atomRadius equal 0.5 @@ -94,6 +97,12 @@ dump dumpParticles all custom ${output_rate} triaxial_compaction_12.dump id type run 0 +# print out contact area evolution for particles 1 and 12 +compute Ac_1_12 particles_1_12 pair/local p13 +compute Ac_1_12_sum particles_1_12 reduce sum c_Ac_1_12 inputs local +variable Ac_1_12 equal c_Ac_1_12_sum +fix logArea all print 100 "${plane_disp} ${Ac_1_12}" file pair_1_12_contact_area_triaxial12.csv screen no + variable plane_disp equal ${ddisp}*elapsed variable plane_disp_neg equal -${ddisp}*elapsed From 769b0b9211a2878c42ac52c94165877f69a7d58d Mon Sep 17 00:00:00 2001 From: jtclemm Date: Fri, 17 Jan 2025 11:56:26 -0700 Subject: [PATCH 72/74] Clarifying doc on svector for many models, resetting svector values in granular model --- doc/src/pair_granular.rst | 6 +++++- src/GRANULAR/granular_model.cpp | 5 ++++- 2 files changed, 9 insertions(+), 2 deletions(-) diff --git a/doc/src/pair_granular.rst b/doc/src/pair_granular.rst index 8417cc6520..798556dbf7 100644 --- a/doc/src/pair_granular.rst +++ b/doc/src/pair_granular.rst @@ -941,7 +941,11 @@ calculate the amount of heat exchanged), these quantities are appended to the end of this list. First, any extra values from the normal submodel are appended followed by the damping, tangential, rolling, twisting, then heat models. See the descriptions of specific granular submodels above -for information on any extra quantities. +for information on any extra quantities. If two or more models are +defined by pair coefficients, the size of the array is set by the +maximum number of extra quantities in a model but the order of quantities +is determined by each model's specific set of submodels. Any unused +quantities are zeroed. These extra quantities can be accessed by the :doc:`compute pair/local ` command, as *p1*, *p2*, ..., *p12*\ . diff --git a/src/GRANULAR/granular_model.cpp b/src/GRANULAR/granular_model.cpp index f85774554c..cb89cc1bd1 100644 --- a/src/GRANULAR/granular_model.cpp +++ b/src/GRANULAR/granular_model.cpp @@ -305,6 +305,7 @@ void GranularModel::init() for (int i = 0; i < NSUBMODELS; i++) sub_models[i]->init(); + nsvector = 0; int index_svector = 0; for (int i = 0; i < NSUBMODELS; i++) { if (sub_models[i]->nsvector != 0) { @@ -314,8 +315,10 @@ void GranularModel::init() } } - if (nsvector != 0) + if (nsvector != 0) { + delete[] svector; svector = new double[nsvector]; + } } /* ---------------------------------------------------------------------- */ From f540e8b9ffd655fd51ae6d3a9fffd28342a1a23c Mon Sep 17 00:00:00 2001 From: jtclemm Date: Fri, 17 Jan 2025 12:48:18 -0700 Subject: [PATCH 73/74] whitespace --- doc/src/pair_granular.rst | 2 +- src/GRANULAR/fix_granular_mdr.cpp | 1 - 2 files changed, 1 insertion(+), 2 deletions(-) diff --git a/doc/src/pair_granular.rst b/doc/src/pair_granular.rst index 13390516c4..745d898d01 100644 --- a/doc/src/pair_granular.rst +++ b/doc/src/pair_granular.rst @@ -282,7 +282,7 @@ stress components, total surface area involved in contact, and individual contact areas. In the input script, these quantities are initialized by calling *run 0* and can then be accessed using subsequent *compute* commands. The last *compute* command uses *pair/local p13* to calculate the pairwise -contact areas for each active contact in the *group-ID*. +contact areas for each active contact in the *group-ID*. .. code-block:: LAMMPS diff --git a/src/GRANULAR/fix_granular_mdr.cpp b/src/GRANULAR/fix_granular_mdr.cpp index d6a84a7c6b..207d18d7aa 100644 --- a/src/GRANULAR/fix_granular_mdr.cpp +++ b/src/GRANULAR/fix_granular_mdr.cpp @@ -245,7 +245,6 @@ void FixGranularMDR::pre_force(int) comm_stage = COMM_1; comm->forward_comm(this, 5); - // rezero temporary variables for all atoms, no need to communicate for (int i = 0; i < ntotal; i++) { ddelta_bar[i] = 0.0; From 026da76a3bd9cf5dfac178e5d9e0acb0981e6f5c Mon Sep 17 00:00:00 2001 From: William Zunker Date: Mon, 27 Jan 2025 14:16:18 -0800 Subject: [PATCH 74/74] cutoff radius related items --- doc/src/pair_granular.rst | 6 ++++-- examples/granular/in.triaxial.compaction.12 | 2 +- src/GRANULAR/pair_granular.cpp | 4 ++++ 3 files changed, 9 insertions(+), 3 deletions(-) diff --git a/doc/src/pair_granular.rst b/doc/src/pair_granular.rst index 745d898d01..0a44ccb197 100644 --- a/doc/src/pair_granular.rst +++ b/doc/src/pair_granular.rst @@ -282,7 +282,9 @@ stress components, total surface area involved in contact, and individual contact areas. In the input script, these quantities are initialized by calling *run 0* and can then be accessed using subsequent *compute* commands. The last *compute* command uses *pair/local p13* to calculate the pairwise -contact areas for each active contact in the *group-ID*. +contact areas for each active contact in the *group-ID*. Due to the use of an apparent +radius in the *mdr* model, the keyword/arg pair *cutoff radius* must be specified for +*pair/local* to properly detect existing contacts. .. code-block:: LAMMPS @@ -292,7 +294,7 @@ contact areas for each active contact in the *group-ID*. compute ID group-ID property/atom d_sigmayy compute ID group-ID property/atom d_sigmazz compute ID group-ID property/atom d_Acon1 - compute ID group-ID pair/local p13 + compute ID group-ID pair/local p13 cutoff radius .. note:: diff --git a/examples/granular/in.triaxial.compaction.12 b/examples/granular/in.triaxial.compaction.12 index 6befe55241..eee9a2bfd8 100644 --- a/examples/granular/in.triaxial.compaction.12 +++ b/examples/granular/in.triaxial.compaction.12 @@ -98,7 +98,7 @@ dump dumpParticles all custom ${output_rate} triaxial_compaction_12.dump id type run 0 # print out contact area evolution for particles 1 and 12 -compute Ac_1_12 particles_1_12 pair/local p13 +compute Ac_1_12 particles_1_12 pair/local p13 cutoff radius compute Ac_1_12_sum particles_1_12 reduce sum c_Ac_1_12 inputs local variable Ac_1_12 equal c_Ac_1_12_sum fix logArea all print 100 "${plane_disp} ${Ac_1_12}" file pair_1_12_contact_area_triaxial12.csv screen no diff --git a/src/GRANULAR/pair_granular.cpp b/src/GRANULAR/pair_granular.cpp index 79b6c2406e..bae3371ebc 100644 --- a/src/GRANULAR/pair_granular.cpp +++ b/src/GRANULAR/pair_granular.cpp @@ -728,6 +728,10 @@ double PairGranular::single(int i, int j, int itype, int jtype, model->xj = x[j]; model->radi = radius[i]; model->radj = radius[j]; + model->i = i; + model->j = j; + model->itype = itype; + model->jtype = jtype; model->history_update = 0; // Don't update history // If history is needed